fBasics/0000755000176200001440000000000013203550545011626 5ustar liggesusersfBasics/inst/0000755000176200001440000000000013203500423012571 5ustar liggesusersfBasics/inst/unitTests/0000755000176200001440000000000013202116741014600 5ustar liggesusersfBasics/inst/unitTests/runit.plot.R0000644000176200001440000000440413202116741017043 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: INTERNAL USED PLOT FUNCTIONS: # .residualsPlot Returns a residual series plot # .acfPlot Returns a autocorrelation function plot # .pacfPlot Returns a partial ACF plot # .mrlPlot Returns a mean residual life plot # FUNCTION: INTERNAL USED BIVARIATE PLOT FUNCTIONS: # .responsesPlot Returns a response series plot # .firePlot Returns a fitted values vs.residuals plot # FUNCTION: INTERNAL THREE-DIMENSIONAL PLOT UTILITIES: # .circlesPlot Returns a circles plot indexing 3rd variable # .perspPlot Returns a perspective plot in 2 dimensions # .contourPlot Returns a contour plot in 2 dimensions # .histStack Returns a stacked histogram plot ################################################################################ test.plot <- function() { # Plot: NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/Makefile0000644000176200001440000000042013203500425016231 0ustar liggesusersPKG=fBasics TOP=../.. SUITE=doRUnit.R R=R all: inst test inst: # Install package -- but where ?? -- will that be in R_LIBS ? cd ${TOP}/..;\ ${R} CMD INSTALL ${PKG} test: # Run unit tests export RCMDCHECK=FALSE;\ cd ${TOP}/tests;\ ${R} --vanilla --slave < ${SUITE} fBasics/inst/unitTests/runit.HyperbolicDistribution.R0000644000176200001440000001257113202116741022571 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2006, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # dgh Returns density for generalized hyperbolic DF # pgh Returns probability for generalized hyperbolic DF # qgh Returns quantiles for generalized hyperbolic DF # rgh Returns random variates for generalized hyperbolic DF # FUNCTION: DESCRIPTION: # dhyp Returns density for hyperbolic DF # phyp Returns probability for hyperbolic DF # qhyp Returns quantiles for hyperbolic DF # rhyp Returns random variates for hyperbolic DF # hypMode Computes the hyperbolic mode # FUNCTION: DESCRIPTION: # dnig Returns density for inverse Gaussian DF # pnig Returns probability for for inverse Gaussian DF # qnig Returns quantiles for for inverse Gaussian DF # rnig Returns random variates for inverse Gaussian DF # FUNCTION: DESCRIPTION: # hypSlider Displays hyperbolic distribution function # nigSlider Displays normal inverse Gausssian distribution function ################################################################################ test.gh = function() { # gh() Distribution: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") test = fBasics:::.distCheck("gh", alpha = 1.3, beta = 0.3, delta = 1.7, mu = 0.2, lambda = 0.8, n = 2000, robust = FALSE) print(test) checkTrue(mean(test) == 1) # Return Value: return() } # ------------------------------------------------------------------------------ test.hyp = function() { # hyp() Distribution - Parameterization 1: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") test = fBasics:::.distCheck("hyp", alpha = 1.2, beta = 0.2, delta = 1.9, mu = 0.1, pm = "1", n = 1000, robust = FALSE) print(test) checkTrue(mean(test) == 1) # hyp() Distribution - Parameterization 2: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") test = fBasics:::.distCheck("hyp", alpha = 0.9, beta = -0.3, delta = 1.4, mu = -0.1, pm = "2", n = 1000, robust = FALSE) print(test) checkTrue(mean(test) == 1) # hyp() Distribution - Parameterization 3: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") fBasics:::.distCheck("hyp", alpha = 0.9, beta = -0.3, delta = 1.4, mu = -0.1, pm = "3", n = 1000, robust = FALSE) print(test) checkTrue(mean(test) == 1) # hyp() Distribution - Parameterization 4: if (FALSE) { RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") fBasics:::.distCheck("hyp", alpha = 1.6, beta = -0.3, delta = 1.4, mu = 0.1, pm = "4", n = 1000, robust = FALSE) # CHECK print(test) checkTrue(mean(test) == 1) } # Return Value: return() } # ------------------------------------------------------------------------------ test.nig = function() { # nig() Distribution: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") test = fBasics:::.distCheck("nig", alpha = 2.1, beta = 0.1, delta = 1.5, mu = -0.1, n = 1000, robust = FALSE) print(test) checkTrue(mean(test) == 1) # Return Value: return() } # ------------------------------------------------------------------------------ test.hypSlider = function() { # Arguments ? # hypSlider() # Try: # hypSlider() NA # Return Value: return() } # ------------------------------------------------------------------------------ test.nigSlider = function() { # Arguments ? # nigSlider # Try: # nigSlider() NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.NormalityTests.R0000644000176200001440000001155713202116741021075 0ustar liggesusers# This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2006, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: NORMALITY TESTS: # normalTest Test suite for normality tests # ksnormTest One sample Kolmogorov-Smirnov normality test # shapiroTest Shapiro-Wilk normality test # jarqueberaTest Jarque-Bera normality test # dagoTest D'Agostino normality test # FUNCTION: FROM NORTEST PACKAGE: # adTest Anderson-Darling normality test # cvmTest Cramer-von Mises normality test # lillieTest Lilliefors (Kolmogorov-Smirnov) normality test # pchiTest Pearson chi-square normality test # sfTest Shapiro-Francia normality test # FUNCTION: MORE TESTS ... # runsTest Runs test for detecting non-randomness [tseries] # gofnorm Reports on several tests of normality # FUNCTION ADDON: DESCRIPTION: # jbTable Table of finite sample p values for the JB test # pjb Computes probabilities for the Jarque Bera Test # qjb Computes quantiles for the Jarque Bera Test # jbTest Performs finite sample adjusted JB LM and ALM test ################################################################################ test.NormalityTests = function() { # Normal Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(50) TEST = ksnormTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = shapiroTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = jarqueberaTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") if(try(require(akima))) { TEST = jbTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") } TEST = dagoTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = adTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = cvmTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = lillieTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = pchiTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = sfTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } # ------------------------------------------------------------------------------ test.NormalityTests.MSFT = function() { X = returnSeries(MSFT)[, 1] TEST = ksnormTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = shapiroTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = jarqueberaTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") if(try(require(akima))) { TEST = jbTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST")} TEST = dagoTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = adTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = cvmTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = lillieTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = pchiTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") TEST = sfTest(X) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.StylizedFacts.R0000644000176200001440000001355013202116741020657 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2006, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # acfPlot Displays autocorrelations function plot # pacfPlot Displays partial autocorrelation function plot # teffectPlot Estimates and plots the Taylor effect # lmacfPlot Estimates and plots the long memory ACF # lacfPlot Plots lagged autocorrelations # .logpdfPlot Returns a pdf plot on logarithmic scale(s) # .qqgaussPlot Returns a Gaussian quantile-quantile plot # scalinglawPlot Evaluates and plots scaling law behavior ################################################################################ test.acfPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # acfPlot - acfPlot(x = msft.ret) # acfPlot - acfPlot(x = msft.ret, labels = FALSE) # Return Value: return() } # ------------------------------------------------------------------------------ test.pacfPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # pacfPlot - pacfPlot(x = msft.ret) # pacfPlot - pacfPlot(x = msft.ret, labels = FALSE) # Return Value: return() } # ------------------------------------------------------------------------------ test.teffectPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # teffectPlot - teffectPlot(x = msft.ret) # teffectPlot - teffectPlot(x = msft.ret, labels = FALSE) # Return Value: return() } # ------------------------------------------------------------------------------ test.lmacfPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # lmacfPlot - ## lmacfPlot(x = abs(msft.ret), type = "acf") ## lmacfPlot(x = abs(msft.ret), type = "hurst") # ... CHECK ACF OF RETURNS # lmacfPlot - ## lacfPlot(x = msft, n = 4, type = "values") ## CHECK !!! # lmacfPlot - ## lmacfPlot(x = abs(msft.ret), type = "acf", labels = FALSE) ## lmacfPlot(x = abs(msft.ret), type = "hurst", labels = FALSE) # ... CHECK ACF OF RETURNS # lmacfPlot - ## lacfPlot(x = msft, n = 4, labels = FALSE, type = "values") ## CHECK !!! # Return Value: return() } # ------------------------------------------------------------------------------ test.lacfPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # Return Value: return() } # ------------------------------------------------------------------------------ test.logpdfPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # logpdfPlot - fBasics:::.logpdfPlot(x = msft.ret, labels = FALSE) fBasics:::.logpdfPlot(x = msft.ret, type = "log-log") # ... CHECK WARNINGS # ... CHECK COLORS # logpdfPlot - fBasics:::.logpdfPlot(x = msft.ret, labels = FALSE) fBasics:::.logpdfPlot(x = msft.ret, type = "log-log", labels = FALSE) # ... CHECK WARNINGS # ... CHECK COLORS # Return Value: return() } # ------------------------------------------------------------------------------ test.qqgausPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # qqgaussPlot - fBasics:::.qqgaussPlot(x = msft.ret) # qqgaussPlot - fBasics:::.qqgaussPlot(x = msft.ret, labels = FALSE) # Return Value: return() } # ------------------------------------------------------------------------------ test.scalinglawPlot = function() { # MSFT Data: msft.dat = MSFT msft = msft.dat[, 1] msft.vol = msft.dat[ , 5]/10^6 msft.ret = returns(msft) # Graph Frame: par(mfrow = c(1, 1)) # scalinglawPlot - scalinglawPlot(x = msft.ret, span = 4) # ... CHECK COLORS # scalinglawPlot - scalinglawPlot(x = msft.ret, span = 4, labels = FALSE) # ... CHECK COLORS # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.Heaviside.R0000644000176200001440000000335113202116741017766 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: HEAVISIDE AND RELATED FUNCTIONS: # Heaviside Computes Heaviside unit step function # Sign Another signum function # Delta Computes delta function # Boxcar Computes boxcar function # Ramp Computes ramp function ################################################################################ test.Heaviside <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.subStars.R0000644000176200001440000000316613202116741017677 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # .emptyPlot Creates an empty plot page # .subPlot Creates a sub plot # .cnvrt.coords Converts coordinates ################################################################################ test.subplot <- function() { # Plot: NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.matrixAddon.R0000644000176200001440000002344113202116741020341 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # GENERATION: DESCRIPTION: # matrix R Creates a matrix from the given set of values # diag R Creates a diagonal matrix or extracts diagonals # triang M Extracs the lower tridiagonal part from a matrix # Triang M Extracs the upper tridiagonal part from a matrix # pascal M Creates a Pascal matrix # hilbert M Creates a Hilbert matrix # colVec M Creates a column vector from a data vector # rowVec M Creates a row vector from a data vector # as.matrix R Attempts to turn its argument into a matrix # is.matrix R Tests if its argument is a (strict) matrix # isPositiveDefinite M Checks if the matrix X is positive definite # makePositiveDefinite M Forces the matrix x to be positive definite # dimnames R Retrieves or sets the dimnames of an object # colnames|rownames R Retrieves or sets the row or column names # colIds|rowIds M ... use alternatively # colIds<-|rowIds<- M ... for assignments # SUBSETS: DESCRIPTION: # dim R Returns the dimension of a matrix object # ncol|nrow R Counts columns|rows of a matrix object # length R Counts elements of a matrix object # "["|"[[" R Subsets a matrix object # (Arith) R Elementwise Arithmetic: + - * / # (Lops) R Elementwise logical Ops: > < >= <= == != # cbind|rbind R Augments a matrix object by columns|rows # na.omit R Removes NA from a matrix object # BASIC STATISTICS: DESCRIPTION: # var R Returns the variance matrix # cov R Returns the covariance matrix # col|rowStats B calculates column|row statistics # col|rowMeans R calculates column|row means # col|rowAvgs B calculates column|row averages # col|rowVars B calculates column|row variances # col|rowStdevs B calculates column|row standard deviations # col|rowSkewness B calculates column|row skewness # col|rowKurtosis B calculates column|row kurtosis # col|rowCumsums B calculates column|row cumulated sums # LINEAR ALGEBRA: DESCRIPTION: # t R Returns the transposed matrix # det R Returns the determinant of a matrix # inv M returns the inverse of a matrix, synonyme # chol2inv R Returns the inverse of a matrix # norm M returns the norm of a matrix # rk M returns the rank of a matrix # tr M returns the trace of a matrix # %*% R Returns the product of two matrices # %x% R Returns the Kronecker product # kron S returns the Kronecker product # vec M is the operator that stacks a matrix # vech M is the operator that stacks the lower triangle # MORE LINEAR ALGEBRA: DESCRIPTION: # chol R Returns the Cholesky factor matrix # eigen R Returns eigenvalues and eigenvectors # svd R Returns the singular value decomposition # kappa R Returns the condition number of a matrix # qr R Returns the QR decomposition of a matrix # solve R Solves a system of linear equations # backsolve R ... use when the matrix is upper triangular # forwardsolve R ... use when the matrix is lower triangular # TIME SERIES DESCRIPTION: # tslag R Lagged/leading vector/matrix of selected orders # .tslag1 Internal Function used by tslag # pdl R Regressor matrix for polynomial distributed lags # NOTES: WHERE YOU FIND THE FUCTIONS? # R Basic R Package # B Rmetrics fBasics Package # M This Rmetrics fMultivar Package ################################################################################ test.creation = function() { # Create Pascal Matrix: P = pascal(3) P # Create lower triangle matrix L = triang(P) L # Extract diagonal part diag(P) # Return Value: return() } # ------------------------------------------------------------------------------ test.mathOps = function() { # Create Pascal Matrix: P = pascal(3) P # Add/Subtract/Multiply/Divide: X = P # Multiply matrix with a constant 3 * X # Multiply two matrices elementwise X * P # Multiplies rows/columns of a matrix by a vector X %*% diag(P) diag(P) %*% X # Return Value: return() } # ------------------------------------------------------------------------------ test.subsets = function() { # Create Pascal Matrix: P = pascal(3) P # Operate on Subsets of a Matrix: n = 3 i = 2 j = 3 D = diag(1:3) # Return the dimension of a matrix dim(P) # Get the last colum of a matrix P[, ncol(P)] # Delete a column of a matrix P[, -i] # Permute the columns of a matrix P[c(3, 1, 2), ] # Augments matrix horizontally cbind(P, D) # Return Value: return() } # ------------------------------------------------------------------------------ test.apply = function() { # Apply a function to all Elements of a Matrix: # Create Pascal Matrix: P = pascal(3) P # Return square root for each element sqrt(P) # Exponentiate the matrix elementwise exp(P) # Compute the median of each column apply(P, 2, "median") # Test on all elements of a matrix all( P > 2 ) # test on any element in a matrix any( P > 2 ) # Return Value: return() } # ------------------------------------------------------------------------------ test.moreOperations = function() { # More Matrix Operations: # Create Pascal Matrix: P = pascal(3) P # Create Diagonal Matrix: D = diag(1:3) # Return the product of two matrices P %*% D # Return the Kronecker Product P %x% D # Return the transposed matrix t(P) # Return the inverse of a matrix inv(P) # Return the norm of a matrix norm(P) # Return the determinante of a matrix det(P) # Return the rank of a matrix rk(P) # Return trace of a matrix tr(P) # Return the variance matrix var(P) # Return the covariance matrix cov(P) # Stack a matrix vec(P) # Stack the lower triangle vech(P) # Return Value: return() } # ------------------------------------------------------------------------------ test.linearAlgebra = function() { # More Linear Algebra: # Create Pascal Matrix: P = pascal(3) P # Example Matrix and Vector X = P b = c(1, 2, 3) # Return the Cholesky factor matrix chol(X) # Return eigenvalues and eigenvectors eigen(X) # Return the singular value decomposition svd(X) # Return the condition number of a matrix kappa(X) # Return the QR decomposition of a matrix qr(X) # Solve a system of linear equations # ... use backsolve when the matrix is upper triangular # ... use forwardsolve when the matrix is lower triangular solve(X, b) backsolve(Triang(X), b) solve(Triang(X), b) forwardsolve(triang(X), b) solve(triang(X), b) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.description.R0000644000176200001440000000302113202116741020402 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # description Sets default description string ################################################################################ test.description <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.linearInterp.R0000644000176200001440000000344013202116741020520 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: BIVARIATE GRIDDED INTERPOLATION: # linearInterp Interpolates linearly irregularly spaced data points # linearInterpp Interpolates linearly pointwise ################################################################################ test.linearInterp <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.linearInterp <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.decor.R0000644000176200001440000000277113202116741017166 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: # decor # hgrid # vgrid # boxL # box_ # xrug # yrug # copyright ################################################################################ test.decor <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.listDescription.R0000644000176200001440000000307513202116741021247 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # listDescription Extracts R package description ################################################################################ test.listDescription <- function() { # List Description: print(listDescription("stats")) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.subPlot.R0000644000176200001440000000316613202116741017521 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # .emptyPlot Creates an empty plot page # .subPlot Creates a sub plot # .cnvrt.coords Converts coordinates ################################################################################ test.subplot <- function() { # Plot: NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.print.R0000644000176200001440000000320513202116741017217 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: CONTROL ATTRIBUTES: # print.control Prints unlisted control attributes # FUNCTION: DESCRIPTION: # .print Used in regression package ################################################################################ test.print <- function() { # Print: NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.symbolTable.R0000644000176200001440000000316613202116741020346 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: CHARACTER, SYMBOL AND COLOR TABLES: # symbolTable Shows a table of plot symbols ################################################################################ test.symbolTable <- function() { # Symbol Table: args(symbolTable) par(mfrow = c(1, 1)) symbolTable() # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.fHTEST.R0000644000176200001440000000314013202116741017116 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: NORMALITY TESTS: # 'fHTEST' S4 Class Representation # show.fHTEST S4 Print Method ################################################################################ test.fHTEST = function() { # Class: getClass("fHTEST") # Slots: getSlots("fHTEST") # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.baseMethods.R0000644000176200001440000000724013202116741020324 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: BASIC EXTENSIONS: # align.default align default method # atoms.default atoms default method # attach.default attach default method # colnames<-.default colnames<- default method # cor.default cor default method # cov.default var default method # log.default log default method # outlier.default outlier default method # rownames<-.default rownames<- default method # rank.default rank default method # sample.default sample default method # sort.default sort default method # stdev.default stdev default method # termPlot.default termPlot default method # var.default var default method # volatility.default volatility default method ################################################################################ test.as.align.default <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.colnames.default = function() { # "colnames<-.default" colnames<- default method # Row and Column Names: m = matrix(1:8, ncol = 2) m # Set Names: colnames(m) <- c("A", "B") m # Get Names: colnames(m) # Return Value: return() } # ------------------------------------------------------------------------------ test.rownames.default = function() { # "rownames<-.default" rownames<- default methodd # Row and Column Names: m = matrix(1:8, ncol = 2) m # Set Names: rownames(m) = as.character(1:4) m # Get Names: rownames(m) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.Sys.putenv.R0000644000176200001440000000354713202116741020172 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # Sys.putenv depreciated after 2.4.1 # head.ts Adds head method ################################################################################ test.Sys.putenv <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.colorTable.R0000644000176200001440000000312713202116741020154 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # colorTable Shows a table of plot color codes ################################################################################ test.colorTable = function() { # Color Table: args(colorTable) par(mfrow = c(1, 1)) colorTable() # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.julian.R0000644000176200001440000000335513202116741017353 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DATE FUNCTIONS: # .fjulian Transforms formatted dates to julian day numbers # .julian Implements SPlus like 'julian' # .isPOSIX Checks for an object of class POSIX # .by2seconds Converts 'by' string into numeric value of seconds ################################################################################ test.fjulian <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.sliderMenu.R0000644000176200001440000000340413202116741020173 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: SLIDER MENU: # .sliderMenu Opens a teching demo slider menu # .tdSliderMenu Opens a teching demo slider and button menu ################################################################################ test.sliderMenu <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.sliderMenu <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.krigeInterp.R0000644000176200001440000000305613202116741020352 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: BIVARIATE GRIDDED INTERPOLATION: # krigeInterp Kriges irregularly distributed data points ################################################################################ test.krigeInterp <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.distCheck.R0000644000176200001440000000302313202116741017762 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # .distCheck Checks consistency of distributions ################################################################################ test.distCheck <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.akimaInterp.R0000644000176200001440000000263313202116741020333 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: BIVARIATE GRIDDED INTERPOLATION: # akimaInterp Interpolates and smoothes irregularly spaced points # akimaInterpp Interpolates and smoothes pointwise ################################################################################ test.akimaInterp <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.akimaInterpp <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.listFunctions.R0000644000176200001440000000355713202116741020741 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # listFunctionss Lists all functions in a package # countFunctions Counts all functions in a package ################################################################################ test.listFunctions <- function() { # List Functions: print(listFunctions("fUtilities")) # Return Value: return() } # ------------------------------------------------------------------------------ test.countFunctions <- function() { # Count Functions: print(countFunctions("fUtilities")) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.ReturnSeriesBasics.R0000644000176200001440000001160113202116741021641 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2007, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: TAILORED PLOT FUNCTIONS: # seriesPlot Returns a tailored return series plot # histPlot Returns a tailored histogram plot # densityPlot Returns a tailored kernel density estimate plot # qqnormPlot Returns a tailored normal quantile-quantile plot # FUNCTION: BASIC STATISTICS: # basicStats Returns a basic statistics summary # FUNCTION: DESCRIPTION: # .distCheck Checks consistency of distributions # FUNCTION: SPLUS FUNCTIONALITY: # stdev S-PLUS: Returns the standard deviation of a vector ################################################################################ test.seriesPlot = function() { # Description: # Returns a tailored return series plot # Time Series: tS = MSFT[, "Close"] # Series Plot: par(mfrow = c(2, 1)) seriesPlot(tS) seriesPlot(tS) points(tS, col = "red", pch = 19, cex = 0.7) # Return Value: return() } # ------------------------------------------------------------------------------ test.histPlot = function() { # Description: # Returns a tailored histogram plot # Time Series: tS = MSFT[, "Close"] # Histogram Plot: par(mfrow = c(1, 1)) histPlot(tS) histPlot(tS, add.fit = FALSE) # Return Value: return() } # ------------------------------------------------------------------------------ test.densityPlot = function() { # Description: # Returns a tailored kernel density estimate plot # Time Series: tS = MSFT[, "Close"] # Density Plot: par(mfrow = c(1, 1)) densityPlot(tS) # Return Value: return() } # ------------------------------------------------------------------------------ test.qqnormPlot = function() { # Description: # Returns a tailored normal quantile-quantile plot # Time Series: tS = MSFT[, "Close"] # Quantile Plot: par(mfrow = c(1, 1)) qqnormPlot(tS) # Return Value: return() } # ------------------------------------------------------------------------------ test.basicStats = function() { # Description: # Returns a basic statistics summary # Time Series: tS = MSFT Close = tS[, "Close"] # Univariate timeSeries - basicStats(x, ci = 0.95) basicStats(Close) # basicStats(as.numeric(Close)) basicStats(as.matrix(Close)) basicStats(as.data.frame(Close)) basicStats(as.ts(Close)) # Multivariate - timeSeries - basicStats(x, ci = 0.95) basicStats(tS) basicStats(as.matrix(tS)) basicStats(as.data.frame(tS)) basicStats(as.ts(tS)) # Return Value: return() } # ------------------------------------------------------------------------------ test.distCheck = function() { # Description: # Checks consistency of distributions # Arguments: # .distCheck(fun = "norm", n = 1000, seed = 4711, ...) # Normal Distribution Check: fBasics:::.distCheck() # Return Value: return() } # ------------------------------------------------------------------------------ test.stdev = function() { # Description: # S-PLUS: Returns the standard deviation of a vector # Time Series: tS = MSFT # stdev - Univariate: tU = tS[, 1] # S-Plus Compatible: stdev(tU) ## stdev(as.numeric(tU)) ## CHECK !!! stdev(as.vector(tU)) stdev(as.ts(tU)) # Base R: sd(tU) ## sd(as.numeric(tU)) ## CHECK !!! sd(as.vector(tU)) sd(as.ts(tU)) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.rgb.R0000644000176200001440000000452213202116741016640 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: UTILITIES: # .asRGB Converts any R color to RGB (red/green/blue) # .chcode Changes from one to another number system # .hex.to.dec Converts heximal numbers do decimal numbers # .dec.to.hex Converts decimal numbers do heximal numbers ################################################################################ test.hexCode <- function() { # .chcode Changes from one to another number system # .hex.to.dec Converts heximal numbers do decimal numbers # .dec.to.hex Converts decimal numbers do heximal numbers # Change from one to another number system # .chcode(b, base.in = 2, base.out = 10, digits="0123456789ABCDEF") # Convert heximal numbers do decimal numbers # .hex.to.dec(b) fBasics:::.hex.to.dec("AA") # Convert decimal numbers do heximal numbers # .dec.to.hex(b) fBasics:::.dec.to.hex(170) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.unitrootNA.R0000644000176200001440000000302313202116741020163 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # .unirootNA Computes zero without error exit ################################################################################ test.unitrootNA <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.interactivePlot.R0000644000176200001440000000475213202116741021247 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: PLOT UTILITIES: # interactivePlot Plots several graphs interactively ################################################################################ test.interactivePlot <- function() { # interactivePlot(x, choices = paste("Plot", 1:9), # plotFUN = paste("plot.", 1:9, sep = ""), which = "all", ...) # Test Plot Function: testPlot = function(x, which = "all", ...) { # Plot Function and Addons: plot.1 <<- function(x, ...) plot(x, ...) plot.2 <<- function(x, ...) acf(x, ...) plot.3 <<- function(x, ...) hist(x, ...) plot.4 <<- function(x, ...) qqnorm(x, ...) # Plot: interactivePlot(x, choices = c("Series Plot", "ACF", "Histogram", "QQ Plot"), plotFUN = c("plot.1", "plot.2", "plot.3", "plot.4"), which = which, ...) # Return Value: invisible() } # Plot: par(mfrow = c(2, 2), cex = 0.7) testPlot(rnorm(500)) # Reorder 2: par(mfrow = c(2, 1), cex = 0.7) testPlot(rnorm(500), which = c(1, 2)) # Try: # par(mfrow = c(1,1)); testPlot(rnorm(500), which = "ask") # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.getS4.R0000644000176200001440000000360213202116741017052 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: GENERAL EXTRACTORS FOR S4: # isS4 Checks if a function is a S4 object # getCall Extracts the call slot from a S4 object # getModel Extracts the model slot from a S4 object # getTitle Extracts the title slot from a S4 object # getDescription Extracts the description slot from a S4 object # getSlot Extracts a specified slot from a S4 object ################################################################################ test.isS4 <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.colStats.R0000644000176200001440000000405213202116741017660 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: COLUMN STATISTICS: # colStats Computes sample statistics by column # colSums Computes sums of all values in each column # colMeans Computes means of all values in each column # colSds Computes standardard deviation of each column # colVars Computes sample variance by column # colSkewness Computes sample skewness by column # colKurtosis Computes sample kurtosis by column # colMaxs Computes maximum values in each colum # colMins Computes minimum values in each colum # colProds Computes product of all values in each colum # FUNCTION: NO LONGER USED: # colAvgs Computes sample mean by column # colStdevs Computes sample standard deviation by column # mean.timeSeries Computes sample means by column # var.timeSeries Computes sample variance by column ################################################################################ test.colStats <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.DistributionFits.R0000644000176200001440000001721113202116741021372 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2006, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # 'fDISTFIT' S4 Class representation # print.fDISTFIT Prints Results from a Fitted Distribution # FUNCTION: NORMAL AND T DISTRIBUTION: # nFit Fits parameters of a Normal density # tFit Fits parameters of a Student-t density # FUNCTION: STABLE DISTRIBUTION: # stableFit Fits parameters of a stable density # FUNCTION: GENERALIZED DISTRIBUTION: # ghFit Fits parameters of a generalized hyperbolic density # hypFit Fits parameters of a hyperbolic density # nigFit Fits parameters of a normal inverse Gaussian density ################################################################################ test.nFit <- function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate normal random variates: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") s = rnorm(n = 2000, mean = 1, sd = 0.5) # Fit: cat("nFit():\n") print(ans <- nFit(x = s)) # Precision within 10% ? relErrorTest = c( ( (ans@fit$estimate[1] - 1.0)/1.0 < 0.10 ), ( (ans@fit$estimate[2] - 0.5)/0.5 < 0.10 )) print(relErrorTest) checkTrue(as.logical(mean(relErrorTest))) # Return Value: return() } # ------------------------------------------------------------------------------ test.tFit = function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate random variates t(4): RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") s = rt(n = 2000, df = 4) # Fit: ans = tFit(x = s, df = 2*var(s)/(var(s)-1), trace = FALSE) # Precision of df within 10% ? relErrorTest = c( ( (ans@fit$estimate[1] - 4.0)/4.0 < 0.10 )) print(ans) print(relErrorTest) checkTrue(as.logical(mean(relErrorTest))) # Return Value: return() } # ------------------------------------------------------------------------------ test.ghFit = function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate random variates: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") s = rgh(n = 2000, alpha = 0.8, beta = 0.2, delta = 2, mu = -0.4, lambda = 1) # Fit: ans = ghFit(x = s, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = 1, trace = FALSE) # Precision of parameters within 10% ? relErrorTest = c( ( (ans@fit$estimate[1] - 0.8)/( 0.8) < 0.10 ), ( (ans@fit$estimate[2] - 0.2)/( 0.2) < 0.10 ), ( (ans@fit$estimate[3] - 2.0)/( 2.0) < 0.10 ), ( (ans@fit$estimate[4] + 0.4)/(-0.4) < 0.10 ), ( (ans@fit$estimate[5] - 2.0)/( 2.0) < 0.10 )) print(ans) print(relErrorTest) checkTrue(as.logical(mean(relErrorTest))) # Return Value: return() } # ------------------------------------------------------------------------------ test.hypFit = function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate normal random variates: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") s = rhyp(n = 2000, alpha = 1.5, beta = 0.8, delta = 0.5, mu = -1) # Fit: ans = hypFit(s, alpha = 1, beta = 0, delta = 1, mu = mean(s), trace = FALSE) # Precision of parameters within 10% ? relErrorTest = c( ( (ans@fit$estimate[1] - 1.5)/( 1.5) < 0.10 ), ( (ans@fit$estimate[2] - 0.8)/( 0.8) < 0.10 ), ( (ans@fit$estimate[3] - 0.5)/( 0.5) < 0.10 ), ( (ans@fit$estimate[4] + 1.0)/(-1.0) < 0.10 )) print(ans) print(relErrorTest) checkTrue(as.logical(mean(relErrorTest))) # Return Value: return() } # ------------------------------------------------------------------------------ test.nigFit <- function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate normal random variates: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") th.0 <- c(alpha = 1.5, beta = -0.7, delta = 0.5, mu = -1.0) s <- do.call(rnig, c(list(n = 2000), th.0)) # Fit {includes plot !} print(ans <- nigFit(s, alpha = 1, beta = 0, delta = 1, mu = mean(s), trace = FALSE)) # Precision of parameters within 10% / 35% ? est <- ans@fit$estimate relErr <- (est - th.0) / th.0 checkTrue(all(abs(relErr) < 0.35))# 35% ## 10% / 35$ is silly, rather use SE scale: print(SE <- ans@fit$se.coef) print(cbind(th.0, est, SE))# NaN SE[is.na(SE)] <- .1 # arbitrary cat("t-ratios:\n"); print(t. <- (est - th.0)/ SE) checkTrue(all(abs(t.) < 6))## 6 is too large, but have -5.476 for beta # Return Value: return() } # ------------------------------------------------------------------------------ test.stableFit <- function() { # Graph Frame: par(mfrow = c(1, 1)) # Simulate stable random variates: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") th.0 <- c(alpha=1.8, beta=0.3, gamma = 1, delta = 0.1) s <- do.call(stabledist::rstable, c(list(n = 500), th.0)) # Fit {includes plot !} cat("stableFit():\n") print(ans <- stableFit(x = s, alpha = 1.5)) # Precision of parameters within 5% / 10% / ...? est <- ans@fit$estimate arelErr <- abs(relErr <- (est - th.0) / th.0) print(cbind(th.0, est, relErr)) checkTrue(all(arelErr[c("alpha","gamma")] < 0.05) && arelErr[["beta"]] < 0.15 && arelErr[["delta"]] < 1.50) # 150% ! # MLE Fit: if (FALSE) { # as this takes rather too long time ... print(system.time( ans <- stableFit(x = s, alpha = 1.5, type = "mle", trace = TRUE) ## .mleStableFit(s, 1.75, 0, 1, 0) )) ## user {lynne, 2012-09} ## 159.7 # The result would be: print(ans) ## Precision of parameters within 5% / 10% / ...? est <- ans@fit$estimate arelErr <- abs(relErr <- (est - th.0) / th.0) print(cbind(th.0, est, relErr)) checkTrue(all(arelErr[1:3] < 0.02) && arelErr[["delta"]] < 0.42) } # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.characterTable.R0000644000176200001440000000315413202116741020772 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # characterTable Shows a table of character codes ################################################################################ test.characterTable <- function() { # Character Table: args(characterTable) par(mfrow = c(1, 1)) characterTable() # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.lcg.R0000644000176200001440000000530713202116741016635 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: PORTABLE INNOVATIONS: # set.lcgseed Sets initial random seed # get.lcgseed Gets the current valus of the random seed # FUNCTION: DISTRIBUTIONS: # runif.lcg Generates portable uniform linear congruational rvs # rnorm.lcg Generates portable normal linear congruational rvs # rt.lcg Generates portable Student-t linear congruational rvs ################################################################################ test.portableInnovations <- function() { # set.lcgseed Sets initial random seed # get.lcgseed Gets the current valus of the random seed # Set initial random seed - set.lcgseed(seed = 4711) set.lcgseed() # Get the current valus of the random seed - get.lcgseed() get.lcgseed() # Return Value: return() } # ------------------------------------------------------------------------------ test.randomNumbers <- function() { # runif.lcg Generates portable uniform linear congruational rvs # rnorm.lcg Generates portable normal linear congruational rvs # rt.lcg Generates portable Student-t linear congruational rvs # Uniform: x = runif.lcg(n = 1000, min = 0, max = 1) hist(x) # Normal: x = rnorm.lcg(n = 1000, mean = 0, sd = 1) hist(x) # Student-t: x = rt.lcg(n = 1000, df = 4) hist(x) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.colorLocator.R0000644000176200001440000000313213202116741020524 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: COLOR NAMES: # colorLocator Plots R's 657 named colors for selection # colorMatrix Returns matrix of R's color names ################################################################################ test.colorLocator <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.listIndex.R0000644000176200001440000000306513202116741020032 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # listIndex Extracts R package index ################################################################################ test.listIndex <- function() { # List Functions: print(listIndex(package = "fBasics")) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/HeavisideSlider.R0000644000176200001440000000312013202116741017763 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: HEAVISIDE AND RELATED FUNCTIONS: # .heavisideSlider Displays Heaviside and related functions ################################################################################ test.heavisideSlider = function() { # Slider: # .heavisideSlider() NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.skewness.R0000644000176200001440000000432513202116741017731 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: SKEWNESS: # skewness.default Default method # skewness.data.frame Method for objects of class data.frame # skewness.POSIXct Method for objects of class POSIXct # skewness.POSIXlt Method for objects of class POSIXlt ################################################################################ test.skewness.default <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.skewness.data.frame <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.skewness.POSIXct <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.skewness.POSIXlt <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runTests.R0000644000176200001440000000452713202116741016562 0ustar liggesuserspkg <- "fBasics" if(require("RUnit", quietly = TRUE)) { library(package=pkg, character.only = TRUE) if(!(exists("path") && file.exists(path))) path <- system.file("unitTests", package = pkg) ## --- Testing --- ## Define tests testSuite <- defineTestSuite(name = paste(pkg, "unit testing"), dirs = path) if(interactive()) { cat("Now have RUnit Test Suite 'testSuite' for package '", pkg, "' :\n", sep='') str(testSuite) cat('', "Consider doing", "\t tests <- runTestSuite(testSuite)", "\nand later", "\t printTextProtocol(tests)", '', sep = "\n") } else { ## run from shell / Rscript / R CMD Batch / ... ## Run tests <- runTestSuite(testSuite) if(file.access(path, 02) != 0) { ## cannot write to path -> use writable one tdir <- tempfile(paste(pkg, "unitTests", sep="_")) dir.create(tdir) pathReport <- file.path(tdir, "report") cat("RUnit reports are written into ", tdir, "/report.(txt|html)", sep = "") } else { pathReport <- file.path(path, "report") } ## Print Results: printTextProtocol(tests, showDetails = FALSE) printTextProtocol(tests, showDetails = FALSE, fileName = paste(pathReport, "Summary.txt", sep = "")) printTextProtocol(tests, showDetails = TRUE, fileName = paste(pathReport, ".txt", sep = "")) ## Print HTML Version to a File: ## printHTMLProtocol has problems on Mac OS X if (Sys.info()["sysname"] != "Darwin") printHTMLProtocol(tests, fileName = paste(pathReport, ".html", sep = "")) ## stop() if there are any failures i.e. FALSE to unit test. ## This will cause R CMD check to return error and stop tmp <- getErrors(tests) if(tmp$nFail > 0 | tmp$nErr > 0) { stop(paste("\n\nunit testing failed (#test failures: ", tmp$nFail, ", R errors: ", tmp$nErr, ")\n\n", sep="")) } } } else { cat("R package 'RUnit' cannot be loaded -- no unit tests run\n", "for package", pkg,"\n") } ################################################################################ fBasics/inst/unitTests/runit.asPOSIXlt.R0000644000176200001440000000376713202116741017666 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # as.POSIXlt.default Default Method ################################################################################ # IMPORTANT NOTE: # as.POSIXlt was introduced as generic function in R 2.7.0 # Preliminarily, keep the function here to ne downward # compatible with previous R Versions. DW as.POSIXlt.default <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.TwoSampleTests.R0000644000176200001440000001327713202116741021033 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2006, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DISTRIBUTIONAL TESTS: # ks2Test Performs a two sample Kolmogorov-Smirnov test # FUNCTION: LOCATION TESTS: # locationTest Performs locations tests on two samples # .tTest Unpaired t test for differences in mean # .kw2Test Kruskal-Wallis test for differences in locations # FUNCTION: VARIANCE TESTS: # varianceTest Performs variance tests on two samples # .varfTest F test for differences in variances # .bartlett2Test Bartlett's test for differences in variances # .fligner2Test Fligner-Killeen test for differences in variances # FUNCTION: SCALE TESTS: # scaleTest Performs scale tests on two samples # .ansariTest Ansari-Bradley test for differences in scale # .moodTest Mood test for differences in scale # dansariw Returns density of the Ansari W statistic # pansariw Returns probabilities of the Ansari W statistic # qansariw Returns quantiles of the Ansari W statistic # FUNCTION: CORRELATION TESTS: # correlationTest Performs correlation tests on two samples # pearsonTest Pearson product moment correlation coefficient # kendallTest Kendall's tau correlation test # spearmanTest Spearman's rho correlation test ################################################################################ test.distributionTest = function() { # Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(100) Y = rt(50, df = 3) # Two Sample Kolmogorov-Smirnov Test: TEST = ks2Test(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } # ------------------------------------------------------------------------------ test.locationTests = function() { # Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(100) Y = rt(50, df = 3) # Location t-Test: TEST = fBasics:::.tTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Location kw2-Test: TEST = fBasics:::.kw2Test(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } # ------------------------------------------------------------------------------ test.varianceTests = function() { # Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(100) Y = rt(50, df = 3) # Variance F-Test: TEST = fBasics:::.varfTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Variance Bartlett-Test: TEST = fBasics:::.bartlett2Test(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Variance Fligner-Test: TEST = fBasics:::.fligner2Test(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } # ------------------------------------------------------------------------------ test.scaleTests = function() { # Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(100) Y = rt(50, df = 3) # Scale Ansari-Test: TEST = fBasics:::.ansariTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Scale Mood-Test: TEST = fBasics:::.moodTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } # ------------------------------------------------------------------------------ test.correlationTests = function() { # Data: RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") X = rnorm(100) Y = rt(100, df = 3) # Correlation Pearson-Test: TEST = pearsonTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Correlation Kendall-Test: TEST = kendallTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Correlation Spearman-Test: TEST = spearmanTest(X, Y) print(TEST) checkIdentical(as.character(class(TEST)), "fHTEST") # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.kurtosis.R0000644000176200001440000000435013202116741017750 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # kurtosis.default Default method # kurtosis.data.frame Method for objects of class data.frame # kurtosis.POSIXct Method for objects of class POSIXct # kurtosis.POSIXlt Method for objects of class POSIXlt ################################################################################ test.kurtosis.default <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.kurtosis.data.frame <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.kurtosis.POSIXct <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ test.kurtosis.POSIXlt <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.rowStats.R0000644000176200001440000000446113202116741017716 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: ROW AND COLUMN STATISTICS: # rowStats Computes sample statistics by row # rowAvgs Computes sample mean by row # rowVars Computes sample variance by row # rowStdevs Computes sample variance by row # rowSkewness Computes sample skewness by row # rowKurtosis Computes sample kurtosis by row # rowCumsums Computes sample cumulated sums by row ################################################################################ test.colStats = function() { # colStats Computes sample statistics by column # colAvgs Computes sample mean by column # colVars Computes sample variance by column # colStdevs Computes sample variance by column # colSkewness Computes sample skewness by column # colKurtosis Computes sample kurtosis by column # colCumsums Computes sample cumulated sums by column # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.as.matrix.ts.R0000644000176200001440000000407513202116741020424 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # as.matrix.ts Converts univariate ts to 1-column matrix # as.matrix.mts Converts multivariate ts to matrix ################################################################################ test.as.matrix.ts <- function() { NA # Return Value: return() } # ------------------------------------------------------------------------------ as.matrix.mts <- function() { NA # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.JarqueBeraPValues.R0000644000176200001440000000501713202116741021407 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2007, Diethelm Wuertz, GPL # Diethelm Wuertz # info@rmetrics.org # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: JARQUE-BERA DATA TABLES: # .jbTable Finite sample p values for the Jarque Bera test # .jbPlot Plots probability # .pjb Returns probabilities for the JB Test given quantiles # .qjb Returns quantiles for the ADF Test given probabilities # DATA: Description: # .jbLM Jarque-Bera Lagrange Multiplier Test Data # .jbALM Jarque Bera Augmented Lagrange Multiplier Test Data ################################################################################ test.jbTable = function() { if (FALSE) { require(akima) # Jarque-Bera Table: # .jbTable(type = c("LM", "ALM"), size = c("mini", "small", "all")) table = .jbTable() table # Perspective Plot: # .jbPlot(type = c("LM", "ALM")) .jbPlot() } # Return Value: return() } # ------------------------------------------------------------------------------ test.jbData = function() { # Jarque-Bera LM Data: class(fBasics:::.jbLM) class(fBasics:::.jbLM()) head(fBasics:::.jbLM()) # Jarque-Bera ALM Data: class(fBasics:::.jbALM) class(fBasics:::.jbALM()) head(fBasics:::.jbALM()) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.gridVector.R0000644000176200001440000000325213202116741020175 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # gridVector Creates from two vectors rectangular grid coordinates ################################################################################ test.gridVector = function() { # Grid Vector - gridVector(x, y) gridVector(1:3, 1:3) as.data.frame(gridVector(1:3, 1:3)) as.matrix(as.data.frame(gridVector(1:3, 1:3))) # Return Value: return() } ################################################################################ fBasics/inst/unitTests/runit.colorPalette.R0000644000176200001440000000452013202116741020521 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: COLOR PALETTES: # rainbowPalette Creates a rainbow color palette # heatPalette Creates a heat color palette # terrainPalette Creates a terrain color palette # topoPalette Creates a topo color palette # cmPalette Creates a cm color palette # greyPalette Creates a grey palette # timPalette Creates a cyan, yellow, to orange palette # FUNCTION: COLOR RAMPS: # rampPalette Creates a color ramp palette # seqPalette Creates a sequential color palette # divPalette Creates a diverging color palette # qualiPalette Creates a qualitative color palette # focusPalette Creates a focus color palette # monoPalette Creates a mono color palette ################################################################################ test.greyPalette <- function() { # Grey Palette: args(greyPalette) greyPalette() # Return Value: return() } ################################################################################ fBasics/tests/0000755000176200001440000000000013203500424012757 5ustar liggesusersfBasics/tests/doRUnit.R0000644000176200001440000000151113202116742014471 0ustar liggesusers#### doRUnit.R --- Run RUnit tests ####------------------------------------------------------------------------ ### Origianlly follows Gregor Gojanc's example in CRAN package 'gdata' ### and the corresponding section in the R Wiki: ### http://wiki.r-project.org/rwiki/doku.php?id=developers:runit ### MM: Vastly changed: This should also be "runnable" for *installed* ## package which has no ./tests/ ## ----> put the bulk of the code e.g. in ../inst/unitTests/runTests.R : if(require("RUnit", quietly=TRUE)) { ## --- Setup --- wd <- getwd() pkg <- sub("\\.Rcheck$", '', basename(dirname(wd))) library(package=pkg, character.only=TRUE) path <- system.file("unitTests", package = pkg) stopifnot(file.exists(path), file.info(path.expand(path))$isdir) source(file.path(path, "runTests.R"), echo = TRUE) }fBasics/src/0000755000176200001440000000000013203500424012404 5ustar liggesusersfBasics/src/Makevars0000644000176200001440000000003713203500425014101 0ustar liggesusersPKG_LIBS=$(BLAS_LIBS) $(FLIBS) fBasics/src/gld.c0000644000176200001440000003451013203500425013322 0ustar liggesusers/* gld.fm5.fx.c - Part of Robert King's gld package for the R statistical * language. * * Copyright (C) Robert King 1993,2000,2001,2005,2006 * robert.king@newcastle.edu.au * http://tolstoy.newcastle.edu.au/~rking/publ/software.html * * This program is free software; you can redistribute it and/or modify it * under the terms of the GNU General Public License as published by the Free * Software Foundation; either version 2 of the License, or (at your option) * any later version. * * This program is distributed in the hope that it will be useful, but WITHOUT * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or * FITNESS FOR A PARTICULAR PURPOSE. * * See the GNU General Public License for more details. * You should have received a copy of the GNU General Public License along * with this program; if not, write to the * Free Software Foundation, Inc., 59 Temple Place, Suite 330, * Boston, MA 02111-1307 USA * * These functions calculate F(x) for the five parameter version of the * FMKL paramterisation of the gld. * This parameterisation is a variation of the 5 parameter version of the * RSparameterisation. * * This is not very good C. It is based on gld.rs.fx.c, which is based on * code written in 1993, as my first real program. I still haven't tidied * it up very much for release with the R package. * However, it has been used for some time and works fine. * * This is code is loaded into R. * The two include lines are handled by R, but need to be here to keep * the compile step happy * * $Id$ */ #include #include /* proto */ void fm5_funcd( double , double , double *, double *, double *, double *, double *, double *, double *); /* This needs a comment for explaining the arguments */ void gl_fm5_distfunc( double *pa,double *pb,double *pc,double *pd, double *pe, double *pu1,double *pu2,double *pxacc, int *max_it, double *ecks, double *u, int *lengthofdata) { /* pa to pe: pointers to the values of the parameters of the gld (fm5 param) * pu1: minimum value of u, should be zero * pu2: maximum value of u, should be 1 * pxacc: desired accuracy of the calculation * max_it: maximum iterations for N-R root finder * ecks: the quantiles of the gld given * u: array to put the calculated depths * pl: length of the data */ double u1, u2, xacc; int i,j; double df,dx,dxold,f,fh,fl; double x; double temp,xh,xl,rts; /* trying initialising things */ i=0; j=0; df=0.0;dx=0.0;dxold=0.0;f=0.0;fh=0.0;fl=0.0; x=0.0; temp=0.0;xh=0.0;xl=0.0;rts=0.0; u1 = *pu1; u2 = *pu2; xacc = *pxacc; /* If we are trying to do things outside the range, lets set them at almost 0 or almost 1 */ if (*pc < 0) { if (u1 == 0) { u1 = xacc; } if (u2 == 1) { u2 = 1-xacc; } } if (*pd < 0) { if (u1 == 0) { u1 = xacc; } if (u2 == 1) { u2 = 1-xacc; } } for (i=0;i<*lengthofdata;i++) { x = ecks[i]; u[i] = 0.0; fm5_funcd(u1,x,&fl,&df,pa,pb,pc,pd,pe); fm5_funcd(u2,x,&fh,&df,pa,pb,pc,pd,pe); if (fl*fh >= 0.0) { REprintf("Program aborted at parameter values %f, %f, %f, %f %f\n", *pa, *pb, *pc, *pd, *pe); REprintf("The data value being investigated was index %d",i); REprintf(" value: %f\n",x); error("C code failure - see error message printed above"); } if (fl < 0.0) { xl = u1; xh = u2; } else { xh = u1; xl = u2; } rts = 0.5*(u1+u2); dxold = fabs(u2-u1); dx = dxold; fm5_funcd(rts,x,&f,&df,pa,pb,pc,pd,pe); for (j=1;j<=*max_it;j++) { if ((((rts - xh)*df - f)* ( (rts-xl)*df - f) >= 0.0 ) || ( fabs(2.0*f) > fabs (dxold*df))) { dxold = dx; dx = .5* (xh - xl); rts = xl +dx; if (xl == rts ) { u[i] = rts; break; } } else { dxold = dx; dx = f/df; temp = rts; rts -= dx; if (temp == rts) { u[i] = rts; break; } } if (fabs(dx) < xacc) { u[i] = rts; break; } fm5_funcd(rts,x,&f,&df,pa,pb,pc,pd,pe); if (f < 0.0) xl =rts; else xh =rts; } } } void fm5_funcd( double u, double x, double *F, double *dFdu, double *pa, double *pb, double *pc, double *pd, double *pe) { /* *F is the gld F-1(u) */ /* *dFdu is dF-1(u)/du */ /* NOTE: *dFdu is 1/f(x) a.k.a. 1/f(F-1(u)) - the opposite of what's required for the pdf */ if ( *pc == 0 ) { if ( *pd == 0 ) { /* Both l3 and l4 zero */ *F = *pa + ( (1 - *pe) * log(u) - (1 + *pe) * (log(1.0-u)) )/ *pb - x; /* need the derivatives for each case */ *dFdu = ( (1 - *pe)/u + (1 + *pe)/(1-u)) / *pb ; } else { /* l3 zero, l4 non-zero */ *F = *pa + ((1 - *pe) * log(u) - ((1 + *pe)*( pow((1-u),*pd)-1)/ *pd ) ) / *pb - x; *dFdu = ((1 - *pe)/u + (1 + *pe)*pow((1-u), *pd-1) )/ *pb ; } } else { if ( *pd == 0 ) { /* l4 zero, l3 non-zero */ *F = *pa + ( (1 - *pe)*(( pow(u,*pc)- 1)/ *pc) - (1 + *pe)* log(1-u) ) / *pb - x; *dFdu = ( (1 - *pe) * pow(u, *pc-1) + (1 + *pe)/(1-u) ) / *pb; } else { /* l3 non-zero, l4 non-zero */ *F = ((1 - *pe)* ( pow((u),*pc) -1 )/ *pc - (1 + *pe)* (pow((1.0-u),*pd) -1 )/ *pd )/ *pb + *pa - x; *dFdu = ((1 - *pe)* ( pow((u),(*pc-1.0)) ) + (1 + *pe)* ( pow( (1.0-u),(*pd-1.0)) ) )/ *pb ; } } } /* gld.fmkl.fx.c - Part of Robert King's gld package for the R statistical * language. * * Copyright (C) Robert King 1993,2000,2001,2006 * robert.king@newcastle.edu.au * http://tolstoy.newcastle.edu.au/~rking/publ/software.html * * This program is free software; you can redistribute it and/or modify it * under the terms of the GNU General Public License as published by the Free * Software Foundation; either version 2 of the License, or (at your option) * any later version. * * This program is distributed in the hope that it will be useful, but WITHOUT * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or * FITNESS FOR A PARTICULAR PURPOSE. * * See the GNU General Public License for more details. * You should have received a copy of the GNU General Public License along * with this program; if not, write to the * Free Software Foundation, Inc., 59 Temple Place, Suite 330, * Boston, MA 02111-1307 USA * * These functions calculate F(x) for the Freimer, Mudholkar, Kollia and Lin parameterisation * of the gld. It is adapted from gld.rs.fx.c (also in this R distribution). * Because of that, this is not very good C. The original code was my first * real program in C and I haven't tidied it up very much for release with the R package. * However, it has been used for some time and works fine. * * This is code is loaded into R. * The two include lines are handled by R, but need to be here to keep the compile step happy * $Id$ */ #include #include #include /* proto */ void fmkl_funcd( double , double , double *, double *, double *, double *, double *, double *); /* the function that finds the root */ void gl_fmkl_distfunc( double *pa,double *pb,double *pc,double *pd, double *pu1,double *pu2,double *pxacc, int *max_it, double *ecks, double *u, int *lengthofdata) { /* pa to pd: pointers to the values of the parameters of the gld (rs param) * pu1: minimum value of u, should be zero * pu2: maximum value of u, should be 1 * pxacc: desired accuracy of the calculation * max_it: maximum iterations for N-R root finder * ecks: the quantiles of the gld given * u: array to put the calculated depths * pl: length of the data */ double u1, u2, xacc; int i,j; double df,dx,dxold,f,fh,fl; double x; double temp,xh,xl,rts; /* trying initialising things */ i=0; j=0; df=0.0;dx=0.0;dxold=0.0;f=0.0;fh=0.0;fl=0.0; x=0.0; temp=0.0;xh=0.0;xl=0.0;rts=0.0; u1 = *pu1; u2 = *pu2; xacc = *pxacc; if (*pc < 0) { if (u1 == 0) { u1 = xacc; } if (u2 == 1) { u2 = 1-xacc; } } if (*pd < 0) { if (u1 == 0) { u1 = xacc; } if (u2 == 1) { u2 = 1-xacc; } } for (i=0;i<*lengthofdata;i++) { x = ecks[i]; u[i] = 0.0; fmkl_funcd(u1,x,&fl,&df,pa,pb,pc,pd); fmkl_funcd(u2,x,&fh,&df,pa,pb,pc,pd); if (fl*fh >= 0.0) { /* This is suggested in writing R extensions, but still gives the warning */ /* error("Program aborted at parameter values %f, %f, %f, %f\n The data value being investigated was index %d, value: %f\n", *pa, *pb, *pc, *pd, i, x); */ REprintf("C code aborted at parameter values %f, %f, %f, %f\n", *pa, *pb, *pc, *pd); REprintf("The data value being investigated was index %d",i); REprintf(" value: %f\n",x); error("C code numerical failure"); } if (fl < 0.0) { xl = u1; xh = u2; } else { xh = u1; xl = u2; } rts = 0.5*(u1+u2); dxold = fabs(u2-u1); dx = dxold; fmkl_funcd(rts,x,&f,&df,pa,pb,pc,pd); for (j=1;j<=*max_it;j++) { if ((((rts - xh)*df - f)* ( (rts-xl)*df - f) >= 0.0 ) || ( fabs(2.0*f) > fabs (dxold*df))) { dxold = dx; dx = .5* (xh - xl); rts = xl +dx; if (xl == rts ) { u[i] = rts; break; } } else { dxold = dx; dx = f/df; temp = rts; rts -= dx; if (temp == rts) { u[i] = rts; break; } } if (fabs(dx) < xacc) { u[i] = rts; break; } fmkl_funcd(rts,x,&f,&df,pa,pb,pc,pd); if (f < 0.0) xl =rts; else xh =rts; } } } void fmkl_funcd( double u, double x, double *F, double *dFdu, double *pa, double *pb, double *pc, double *pd) { /* *F is the gld F-1(u) */ /* *dFdu is dF-1(u)/du */ /* NOTE: *dFdu is 1/f(x) a.k.a. 1/f(F-1(u)) - the opposite of what's required for the pdf */ if ( *pc == 0 ) { if ( *pd == 0 ) { /* Both l3 and l4 zero */ *F = *pa + (log(u) - log(1.0-u))/ *pb - x; *dFdu = ( 1 /(u * (1-u))) / *pb ; /* correct but confusing, should be 1/u + 1/(1-u) */ } else { /* l3 zero, l4 non-zero */ *F = *pa + ( log(u) - (( pow((1-u),*pd)-1)/ *pd ) ) / *pb - x; *dFdu = (1/u + pow((1-u), *pd-1) )/ *pb ; } } else { if ( *pd == 0 ) { /* l4 zero, l3 non-zero */ *F = *pa + ( (( pow(u,*pc)- 1)/ *pc) - log(1-u) ) / *pb - x; *dFdu = (pow(u, *pc-1) + 1/(1-u) ) / *pb; } else { /* l3 non-zero, l4 non-zero */ *F = ( ( pow((u),*pc) -1 )/ *pc - (pow((1.0-u),*pd) -1 )/ *pd )/ *pb + *pa - x; *dFdu = ( ( pow((u),(*pc-1.0)) ) + ( pow( (1.0-u),(*pd-1.0)) ) )/ *pb ; } } } /* gld.rs.fx.c - Part of Robert King's gld package for the R statistical * language. * * Copyright (C) Robert King 1993,2000,2001 * robert.king@newcastle.edu.au * http://maths.newcastle.edu.au/~rking/publ/software.html * * This program is free software; you can redistribute it and/or modify it * under the terms of the GNU General Public License as published by the Free * Software Foundation; either version 2 of the License, or (at your option) * any later version. * * This program is distributed in the hope that it will be useful, but WITHOUT * ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or * FITNESS FOR A PARTICULAR PURPOSE. * * See the GNU General Public License for more details. * You should have received a copy of the GNU General Public License along * with this program; if not, write to the * Free Software Foundation, Inc., 59 Temple Place, Suite 330, * Boston, MA 02111-1307 USA * * These functions calculate F(x) for the rs paramterisation for the gld * This is not very good C. I wrote this in 1993, as my first real program * and I haven't tidied it up very much for release with the R package. * However, it has been used for some time and works fine. * * This is code is loaded into R. It doesn't need stdio.h * It needs math.h, which is loaded automagically by R. */ #include #include #include static double la, lb, lc, ld, x; /* the function that finds the root */ void gl_rs_distfunc( double *pa,double *pb,double *pc,double *pd, double *px1,double *px2,double *pxacc, int *max_it, double *ecks, double *u, int *pl) { /* pa to pd: pointers to the values of the parameters of the gld (rs param) * px1: minimum value of u, should be zero * px2: maximum value of u, should be 1 * pxacc: desired accuracy of the calculation * max_it: maximum iterations for N-R root finder * ecks: the quantiles of the gld given * u: array to put the calculated depths * pl: length of the data */ double x1, x2, xacc; double a, b, c, d; int l; int i,j; double df,dx,dxold,f,fh,fl; double temp,xh,xl,rts; void funcd(); x1 = *px1; x2 = *px2; xacc = *pxacc; a = *pa; b = *pb; c = *pc; d = *pd; l = *pl; la = a; lb = b; lc = c; ld = d; /* The C version has something here to force the limits to be xacc and 1-xacc rather than 0 and 1 if lambda3 and lambda4 are negative. I can't see why, so I'm leaving it out.*/ for (i=0;i= 0.0) { REprintf("Program aborted during calculation of F(x)"); REprintf("at parameter values %f, %f, %f, %f\n", *pa, *pb, *pc, *pd); REprintf("The x value being investigated was index: %d",i); REprintf(" value: %f\n",x); error("C code numerical failure"); } if (fl < 0.0) { xl = x1; xh = x2; } else { xh = x1; xl = x2; } rts = 0.5*(x1+x2); dxold = fabs(x2-x1); dx = dxold; funcd(rts,&f,&df); for (j=1;j<= *max_it;j++) { if ((((rts - xh)*df - f)* ( (rts-xl)*df - f) >= 0.0 ) || ( fabs(2.0*f) > fabs (dxold*df))) { dxold = dx; dx = .5* (xh - xl); rts = xl +dx; if (xl == rts ) { u[i] = rts; break; } } else { dxold = dx; dx = f/df; temp = rts; rts -= dx; if (temp == rts) { u[i] = rts; break; } } if (fabs(dx) < xacc) { u[i] = rts; break; } funcd(rts,&f,&df); if (f < 0.0) xl =rts; else xh =rts; } } } void funcd(u,a,b) double u,*a,*b; { /* function is the gld F-1(u) */ /* df_du is dF-1(u)/du */ double function, df_du; if ( lc == 0 ) { if ( ld == 0 ) { /* Both l3 and l4 zero */ function = la - x; df_du = 0; } else { /* l3 zero, l4 non-zero */ function = la + ( 1 - pow((1-u),ld) )/ lb - x; df_du = (ld) * ( pow((1.0-u),(ld - 1.0)) / lb); } } else { if ( ld == 0 ) { /* l4 zero, l3 non-zero */ function = la + ( pow(u,lc) - 1 ) / lb - x; df_du = lc * ( pow(u,(lc- 1.0)) ) / lb; } else { /* l3 non-zero, l4 non-zero */ function = ( pow((u),lc) - pow((1.0-u),ld) )/ lb + la - x; df_du = (lc * (pow((u),(lc-1.0))) + ld * ( pow((1.0-u),(ld-1.0)) ))/ lb; } } *a = function; *b = df_du; } fBasics/src/nig.c0000644000176200001440000003410413203500425013330 0ustar liggesusers //////////////////////////////////////////////////////////////////////////////// // // pnigC and qnigC Code // // Author: Kjersti Aas, 2000 // Diethelm Wuertz, added to fBasics // Nikolai Eurich, bug fixed which appeared in R 2.7 // Yohan Chalabi, changed XMAX for 64 bit compatibility // and removed unused headers // //////////////////////////////////////////////////////////////////////////////// #include #include // #include #include // #include // #include // #include // #include // #include #include #include #define SIGN(a,b) ((b) >= 0.0 ? fabs(a) : -fabs(a)) #define MIN(a, b) ((a) < (b) ? (a) : (b)) #define MAX(a, b) ((a) > (b) ? (a) : (b)) #define pi 3.141593 #define EPS 1e-12 #define XLEAST 2.23e-308 #define XSMALL 1.11e-16 #define XINF 1.79e308 #define XMAX 704.78 // log(XINF) - 5 #define MAX_ITER 5000 #define ITMAX 100 //////////////////////////////////////////////////////////////////////////////// // // Print error text and return to R // //////////////////////////////////////////////////////////////////////////////// void printError(char *text, char filename[200]) { error("%s: %s !!!\n", text, filename); } //////////////////////////////////////////////////////////////////////////////// // // FUNCTIONNAME: heap_sort // AUTHOR : Kjersti Aas, NR // DATE : March 2000 // ARGUMENTS : n Number of elements in the vector to be sorted // x Vector to be sorted (n x 1) // order Order of sorted values (n x 1) // DESCRIPTION: Returns order of sorted values in index array. // //////////////////////////////////////////////////////////////////////////////// void heapSort(int n, double *x, int *order) { int i,j,l; int ir, ordert; double q; for(j = 0; j < n; j++) order[j] = j; if(n <= 1) return; l = (n >> 1) + 1; /* shift n one bit to the right, i.e divide it by two.*/ ir = n; for(;;) /* Indefinite loop */ { if(l > 1) { /* Decrement l before evaluating the expression */ q = x[(ordert = order[--l-1])]; } else { q = x[(ordert = order[ir-1])]; order[ir-1] = order[0]; /* Decrement ir before its value is used */ if(--ir == 1) { order[0] = ordert; return; } } i = l; j = l << 1; while(j <= ir) { if((j < ir) && (x[order[j-1]] > x[order[j]])) j++; if(q > x[order[j-1]]) { order[i-1] = order[j-1]; j += (i=j); } else j = ir + 1; } order[i-1] = ordert; } } //////////////////////////////////////////////////////////////////////////////// // // Evaluates the Bessel function of the third order, index nu=1 // //////////////////////////////////////////////////////////////////////////////// double bessk1(double x) { int i; double y, k1; double sump, sumq, sumf, sumg; static double p[5] = { 4.8127070456878442310e-1, 9.9991373567429309922e+1, 7.1885382604084798576e+3, 1.7733324035147015630e+5, 7.1938920065420586101e+5 }; static double q[3] = { -2.8143915754538725829e+2, 3.7264298672067697862e+4, -2.2149374878243304548e+6 }; static double f[5] = { -2.2795590826955002390e-1,-5.3103913335180275253e+1, -4.5051623763436087023e+3,-1.4758069205414222471e+5, -1.3531161492785421328e+6 }; static double g[3] = { -3.0507151578787595807e+2, 4.3117653211351080007e+4, -2.7062322985570842656e+6 }; static double pp[11] = { 6.4257745859173138767e-2, 7.5584584631176030810e+0, 1.3182609918569941308e+2, 8.1094256146537402173e+2, 2.3123742209168871550e+3, 3.4540675585544584407e+3, 2.8590657697910288226e+3, 1.3319486433183221990e+3, 3.4122953486801312910e+2, 4.4137176114230414036e+1, 2.2196792496874548962e+0 }; static double qq[9] = { 3.6001069306861518855e+1, 3.3031020088765390854e+2, 1.2082692316002348638e+3, 2.1181000487171943810e+3, 1.9448440788918006154e+3, 9.6929165726802648634e+2, 2.5951223655579051357e+2, 3.4552228452758912848e+1, 1.7710478032601086579e+0 }; if(x < XLEAST) // Case: x < XLEAST { k1 = XINF; } else if(x <= 1.0) // Case: XLEAST <= x < XSMALL { if(x < XSMALL) { k1 = 1.0/x; } else // Case: XSMALL <= x < 1.0 { y = x*x; sump = ((((p[0]*y + p[1])*y + p[2])*y + p[3])*y + p[4])*y + q[2]; sumq = ((y + q[0])*y + q[1])*y + q[2]; sumf = (((f[0]*y + f[1])*y + f[2])*y + f[3])*y + f[4]; sumg = ((y + g[0])*y + g[1])*y + g[2]; k1 = (y*log(x)*sumf/sumg + sump/sumq)/x; } } else if(x > XMAX) // Case: x > XMAX { k1 = 0.0; } else // Case: 1.0 < x <= XMAX { y = 1.0/x; sump = pp[0]; for(i = 1; i < 11; i++) { sump = sump*y + pp[i]; } sumq = y; for(i = 0; i < 8; i++) { sumq = (sumq + qq[i]) * y; } sumq = sumq + qq[8]; k1 = sump/sumq/sqrt(x)*exp(-x); } return(k1); } //////////////////////////////////////////////////////////////////////////////// // // Return density of NIG distribution evaluated at given points // //////////////////////////////////////////////////////////////////////////////// // "FIXME": is only used from fdNIG() below ... could simplify // *or* call from R's dnig void dNIG(double* x, double* mu, double* delta, double* alpha, double* beta, int* n, double* d) { for(int i = 0; i < *n; i++) { double sdx = sqrt(pow(*delta,2.0)+pow((x[i]-*mu),2.0)), xarg = *alpha * sdx, exparg = *delta*sqrt(pow(*alpha,2.0)-pow(*beta,2.0))+*beta*(x[i]-*mu); if(exparg < -XMAX) exparg = -XMAX; if(exparg > XMAX) exparg = XMAX; d[i] = (*alpha*(*delta)/pi)*exp(exparg)*bessk1(xarg)/ sdx; } } //////////////////////////////////////////////////////////////////////////////// // // Return density of NIG distribution evaluated at a given point // (made for integration) // //////////////////////////////////////////////////////////////////////////////// double fdNIG(double x, double mu, double delta, double alpha, double beta) { int i = 1; double f; dNIG(&x, &mu, &delta, &alpha, &beta, &i, &f); return(f); } ///////////////////////////////////////////////////////////////////////// // // DE-Quadrature // Numerical Automatic Integrator for Improper Integral // method : Double Exponential (DE) Transformation // dimension : one // table : not use functions // intde : integrator of f(x) over (a,b). // intdei : integrator of f(x) over (a,infinity), f(x) is non oscillatory function. // intdeo : integrator of f(x) over (a,infinity), f(x) is oscillatory function. // /////////////////////////////////////////////////////////////////////////// void intdei(double a, double mu, double delta, double alpha, double beta, double *i, double *err) { /* ---- adjustable parameters ---- */ int mmax = 512; double efs = 0.1, hoff = 11.0; /* ------------------------------ */ int m; double pi4, epsln, epsh, h0, ehp, ehm, epst, ir, h; double iback, irback, t, ep, em, xp, xm, fp, fm, errt, errh, errd; pi4 = atan(1.0); epsln = 1 - log(efs * EPS); epsh = sqrt(efs * EPS); h0 = hoff / epsln; ehp = exp(h0); ehm = 1 / ehp; epst = exp(-ehm * epsln); ir = fdNIG(a + 1, mu, delta, alpha, beta); *i = ir * (2 * pi4); *err = fabs(*i) * epst; h = 2 * h0; m = 1; errh = 0; do { iback = *i; irback = ir; t = h * 0.5; do { em = exp(t); ep = pi4 * em; em = pi4 / em; do { xp = exp(ep - em); xm = 1 / xp; fp = fdNIG(a + xp, mu, delta, alpha, beta) * xp; fm = fdNIG(a + xm, mu, delta, alpha, beta) * xm; ir += fp + fm; *i += (fp + fm) * (ep + em); errt = (fabs(fp) + fabs(fm)) * (ep + em); if (m == 1) *err += errt * epst; ep *= ehp; em *= ehm; } while (errt > *err || xm > epsh); t += h; } while (t < h0); if (m == 1) { errh = (*err / epst) * epsh * h0; errd = 1 + 2 * errh; } else { errd = h * (fabs(*i - 2 * iback) + 4 * fabs(ir - 2 * irback)); } h *= 0.5; m *= 2; } while (errd > errh && m < mmax); *i *= h; if (errd > errh) { *err = -errd * m; } else { *err = errh * epsh * m / (2 * efs); } } //////////////////////////////////////////////////////////////////////////////// // // Return cumulative NIG distribution function evaluated at given points // //////////////////////////////////////////////////////////////////////////////// void pNIG(double *x, double *mu, double *delta, double *alpha, double *beta, int *n, double *p) { int i; double err, v; for(i = 0; i < *n; i++) { // Special cases (-Inf, Inf) if(x[i] <= -XINF) { p[i] = 0.0; } else if(x[i] >= XINF) { p[i] = 1.0; } // Integrates density from x to Inf else { // printf("intdei\n"); intdei(x[i], *mu, *delta, *alpha, *beta, &v, &err); // Check that 0 <= v <= 1 if(v < 0.0) v = 0.0; if(v > 1.0) v = 1.0; // Computes integral from -Inf to x p[i] = 1.0-v; } } } //////////////////////////////////////////////////////////////////////////////// // // Return cdf of NIG distribution evaluated at a given point, with the // probability p substracted (made for root finding) // //////////////////////////////////////////////////////////////////////////////// double fpNIG(double x, double mu, double delta, double alpha, double beta, double sp) { double f; int i = 1; pNIG(&x, &mu, &delta, &alpha, &beta, &i, &f); f -= sp; return(f); } //////////////////////////////////////////////////////////////////////////////// // // Computes the root of fpNIG // //////////////////////////////////////////////////////////////////////////////// double zbrent(double x1, double x2, double mu, double delta, double alpha, double beta, double sp) { int iter; double a, b, c, d, e, min1, min2; double fa, fb, fc, p, q, r, s, tol1, xm; d = 0; e = 0; a = x1; b = x2; c = x2; fa = fpNIG(a,mu,delta,alpha,beta,sp); fb = fpNIG(b,mu,delta,alpha,beta,sp); // if((fa > 0.0 && fb > 0.0)||(fa < 0.0 && fb < 0.0)) // printError("Root must be bracketed in zbrent", ""); fc = fb; for(iter = 1; iter <= ITMAX; iter++) { if((fb > 0.0 && fc > 0.0)||(fb < 0.0 && fc < 0.0)) { c = a; fc = fa; e = d = b-a; } if(fabs(fc) < fabs(fb)) { a = b; b = c; c = a; fa = fb; fb = fc; fc = fa; } tol1 = 2.0*EPS*fabs(b)+0.5*EPS; xm = 0.5*(c-b); if(fabs(xm) <= tol1 || fb == 0.0) return b; if(fabs(e) >= tol1 && fabs(fa) > fabs(fb)) { s = fb/fa; if(a == c) { p = 2.0*xm*s; q = 1.0-s; } else { q = fa/fc; r = fb/fc; p = s*(2.0*xm*q*(q-r)-(b-a)*(r-1.0)); q = (q-1.0)*(r-1.0)*(s-1.0); } if(p > 0.0) q = -q; p = fabs(p); min1 = 3.0*xm*q-fabs(tol1*q); min2 = fabs(e*q); if(2.0*p < (min1 < min2 ? min1 : min2)) { e = d; d = p/q; } else { d = xm; e = d; } } else { d = xm; e = d; } a = b; fa = fb; if(fabs(d) > tol1) b += d; else b += SIGN(tol1, xm); fb = fpNIG(b, mu, delta, alpha, beta, sp); } // printError("Maximum number of iterations exceeded in zbrent", ""); return 0.0; } //////////////////////////////////////////////////////////////////////////////// // // Function that computes inverse cumulative NIG distribution function, // evaluated at given points. // INPUT: // p Probabilities at which to evaluate cdf^-1 (nx1) // i_mu First parameter of NIG distribution // i_delta Second parameter of NIG distribution // i_alpha Third parameter of NIG distribution // i_beta Fourth parameter of NIG distribution // i_n Number of quantiles // q Computed quantiles // //////////////////////////////////////////////////////////////////////////////// void qNIG(double* p, double* i_mu, double* i_delta, double* i_alpha, double* i_beta, int* i_n, double* q) { int i, n, counter, *pOrder; double mu, delta, alpha, beta, qTmp, sp, lpiv, rpiv, mpiv, div, lpivVal, rpivVal; n=*i_n; mu=*i_mu; delta=*i_delta; alpha=*i_alpha; beta=*i_beta; // Expectation and standard deviation of NIG distribution, // used for setting lpiv and rpiv mpiv = mu+delta*beta/sqrt(alpha*alpha-beta*beta); div = sqrt(delta*alpha*alpha/pow(alpha*alpha-beta*beta,1.5)); //Allocagte space: pOrder = malloc(n*sizeof(int)); //Find descending order of probabilities:0.5, heapSort(n, p, pOrder); for(i=0;i 0) { lpiv = MAX(lpiv, q[pOrder[n-i]]); // Make sure that upper boundary is > than lower if(rpiv <= lpiv) { while(rpiv <= lpiv) { rpiv += 2*div; } } } lpivVal = fpNIG(lpiv,mu,delta,alpha,beta,sp); rpivVal = fpNIG(rpiv,mu,delta,alpha,beta,sp); // Search for a quantile q that fulfills |fpNIG(q)-p| < eps if(lpivVal*rpivVal >= 0.0) { while(lpivVal*rpivVal >= 0.0) { counter++; lpiv = lpiv-pow(2.0, (double)counter)*div; rpiv = rpiv+pow(2.0, (double)counter)*div; lpivVal = fpNIG(lpiv,mu,delta,alpha,beta,sp); rpivVal = fpNIG(rpiv,mu,delta,alpha,beta,sp); } } qTmp = zbrent(lpiv, rpiv, mu, delta, alpha, beta, sp); q[pOrder[n-i-1]] = qTmp; } } // Free space: free(pOrder); } //////////////////////////////////////////////////////////////////////////////// fBasics/NAMESPACE0000644000176200001440000000470213203025541013041 0ustar liggesusers################################################################################ ## Libraries ################################################################################ useDynLib("fBasics") ################################################################################ ## Imports ################################################################################ importFrom("grDevices", as.graphicsAnnot, cm.colors, col2rgb, colors, contourLines, gray.colors, heat.colors, rainbow, rgb, terrain.colors, topo.colors, xy.coords) importFrom("graphics", axis, barplot, box, boxplot, contour, grid, hist, layout, locator, matplot, mtext, panel.smooth, par, persp, pie, plot.new, plot.window, polygon, rect, rug, symbols, text, title) importFrom("stats", acf, ansari.test, approx, ar, arima, complete.cases, constrOptim, cor, cor.test, density, dnorm, dt, integrate, ks.test, lsfit, median, model.matrix, model.response, nlm, nlminb, numericDeriv, optim, optimize, pacf, pchisq, pf, pnorm, ppoints, qchisq, qf, qnorm, qqline, qqnorm, qt, residuals, rexp, rnorm, runif, sd, shapiro.test, spline, t.test, uniroot, var) importFrom("utils", menu) importFrom("methods", getMethod, is, new, slot) importFrom("spatial", prmat, surf.gls) ## 'akima' is *not* here because of its non-GPL Licence ## importFrom("akima", interp, interpp) ## (MM:) FIXME: Only import what you need! import("timeDate") import("timeSeries") ################################################################################ ## Exports ################################################################################ exportPattern(".") S3method("getModel", "default") S3method("print", "control") S3method("stdev", "default") S3method("termPlot", "default") S3method("volatility", "default") S3method(".plot", "histogram") S3method(".print", "ssd") S3method(".summary", "gel") S3method(".summary", "gmm") # In the future this should be used: #exportPattern("^[^\\.]") # To do before implementation: #The porfolio book needs: #export(.blue2redPalette) #export(.green2redPalette) #export(.blue2greenPalette) #export(.purple2greenPalette) #export(.blue2yellowPalette) #export(.cyan2magentaPalette) #fCouplae, fExtremes, fGarch, fMultivar and fRegression need a lot of exported #functions that start with a dot. This has to be fixed first... fBasics/data/0000755000176200001440000000000013203500423012525 5ustar liggesusersfBasics/data/DowJones30.csv0000644000176200001440000161421413202116740015152 0ustar liggesusers%Y-%m-%d;AA;AXP;T;BA;CAT;C;KO;DD;EK;XOM;GE;GM;HWP;HD;HON;INTC;IBM;IP;JPM;JNJ;MCD;MRK;MSFT;MMM;MO;PG;SBC;UTX;WMT;DIS 1990-12-31;5.92;4.7;14.67;21.77;9.3;1.87;9.88;13.15;23.02;12.09;4.63;19.72;3.91;2.8;5.7;1.2;27.86;20.45;2.67;7.31;7.08;11.83;2.08;31.41;10.55;20.91;9.75;9.31;7.05;7.86 1991-01-02;5.92;4.7;14.67;21.77;9.3;1.87;9.88;13.15;23.02;12.09;4.63;19.72;3.91;2.8;5.7;1.2;27.86;20.45;2.67;7.31;7.08;11.83;2.08;31.41;10.55;20.91;9.75;9.31;7.05;7.86 1991-01-03;5.88;4.73;14.73;21.71;9.15;1.87;9.6;12.83;22.95;12.15;4.53;19.57;3.91;2.74;5.67;1.2;27.95;20.21;2.67;7.23;6.99;11.45;2.09;30.9;10.27;20.7;9.64;9.19;7.05;7.82 1991-01-04;5.76;4.73;14.79;22.5;9;1.92;9.85;13.06;22.74;12.27;4.47;19;3.85;2.75;5.65;1.2;27.86;20.5;2.69;7.18;7.02;11.27;2.11;30.8;10.24;20.48;9.56;9.24;6.97;7.79 1991-01-07;5.72;4.58;14.67;21.65;8.87;1.89;9.69;12.83;22.11;12.12;4.4;18.35;3.88;2.65;5.5;1.19;27.39;20.45;2.58;6.96;6.8;10.97;2.08;30.43;10.08;20.05;9.4;8.95;6.82;7.58 1991-01-08;5.63;4.53;14.73;21.34;9.05;1.85;9.6;12.6;22.18;12.09;4.44;18.28;3.9;2.59;5.47;1.18;27.08;20.26;2.58;7.02;6.83;11.01;2.04;29.65;10.11;20.02;9.32;8.78;6.85;7.41 1991-01-09;5.53;4.5;14.42;21.22;8.92;1.77;9.38;12.06;22.04;11.88;4.43;18.13;3.79;2.59;5.39;1.19;26.55;19.87;2.49;6.85;6.83;10.87;2.06;29.05;10.08;19.53;9.25;8.43;6.7;7.35 1991-01-10;5.67;4.73;14.49;21.83;9.07;1.8;9.55;12.1;22.11;12;4.43;18.35;3.74;2.68;5.45;1.2;26.93;20.45;2.55;7.03;6.89;11.02;2.17;29.46;10.19;19.78;9.32;8.58;6.82;7.45 1991-01-11;5.68;4.67;14.67;21.89;9.17;1.84;9.66;12.19;22.18;11.88;4.42;18.28;3.79;2.7;5.42;1.24;26.86;20.6;2.61;7.09;6.74;11.06;2.17;30.2;10.16;19.63;9.29;8.65;7;7.43 1991-01-14;5.68;4.56;14.42;21.53;9.15;1.86;9.69;12.15;21.62;11.91;4.43;17.85;3.79;2.71;5.27;1.23;26.52;20.5;2.52;7.1;6.64;10.96;2.13;30.25;10.14;19.44;9.16;8.48;6.85;7.39 1991-01-15;5.7;4.53;14.42;21.41;9.21;1.85;9.69;12.06;21.13;11.88;4.45;18.13;3.85;2.77;5.32;1.26;26.71;20.41;2.58;7.11;6.74;11.04;2.18;30.06;10.24;19.56;9.21;8.51;6.85;7.33 1991-01-16;5.7;4.61;14.61;22.01;8.76;1.85;9.79;12.06;21.27;11.85;4.47;18.49;4.13;2.83;5.39;1.31;27.11;20.6;2.61;7.24;6.71;11.2;2.28;30.02;10.32;19.66;9.07;8.68;7.03;7.49 1991-01-17;5.97;4.85;15.47;23.41;9.16;1.94;10.42;12.74;22.25;12.12;4.75;19.5;4.37;2.95;5.78;1.31;28.76;21.86;2.61;7.46;7.14;11.62;2.33;31.54;10.81;20.3;9.45;9.29;7.5;7.93 1991-01-18;6.1;4.82;15.47;23.89;8.93;1.98;10.61;12.92;22.39;12.3;4.74;19.57;4.68;2.99;5.88;1.36;29.22;21.81;2.64;7.5;7.26;11.7;2.37;31.82;10.91;20.05;9.69;9.29;7.58;8.04 1991-01-21;6.14;4.82;15.35;23.53;8.93;2.01;10.48;12.83;22.32;12.21;4.7;19.36;4.51;3.02;5.75;1.4;29.72;21.57;2.78;7.53;7.14;11.58;2.49;31.59;10.89;19.87;9.78;9.12;7.41;7.95 1991-01-22;5.97;4.76;15.16;22.86;8.61;2;10.48;12.79;22.18;12.12;4.64;19;4.3;2.99;5.55;1.36;29.32;21.32;2.96;7.49;7.14;11.58;2.47;31.45;10.99;19.63;9.32;8.51;7.32;7.76 1991-01-23;6.1;4.58;15.04;22.86;8.81;1.99;10.5;12.83;22.39;12.39;4.69;19.57;4.4;3.05;5.78;1.36;29.63;21.52;2.99;7.62;7.08;11.78;2.47;29.88;11.09;19.38;8.9;8.6;7.23;7.88 1991-01-24;6.02;4.64;15.23;23.65;9.28;2.02;10.67;12.97;22.46;12.39;4.79;19.5;4.5;3.21;5.9;1.36;30.06;22.39;2.96;7.8;7.05;11.88;2.51;30.02;11.3;19.14;9.03;8.78;7.44;7.76 1991-01-25;6.05;4.73;15.41;23.83;9.38;2;10.42;13.01;23.37;12.54;4.9;19.07;4.54;3.19;5.93;1.37;30.47;22.24;3.14;7.79;7.05;11.82;2.49;30.34;11.38;19.56;9.05;8.87;7.41;7.93 1991-01-28;6.12;4.7;15.6;22.74;9.63;1.94;10.39;13.01;23.16;12.51;4.97;19.07;4.65;3.13;6.08;1.37;30.87;22.39;3.14;7.8;6.89;11.8;2.56;30.43;11.41;18.95;9.12;8.87;7.47;7.96 1991-01-29;6.31;4.79;15.6;22.92;9.84;2.02;10.34;12.83;22.95;12.39;4.97;19.5;4.7;3.1;6.16;1.38;30.93;22.63;3.17;7.86;6.64;11.85;2.57;30.48;11.38;18.77;9.14;9.12;7.53;8.01 1991-01-30;6.7;5.08;15.78;23.22;9.99;2.08;10.64;13.01;23.58;12.33;5.08;20.29;4.8;3.25;6.06;1.39;31.55;23.16;3.08;7.97;6.89;12.11;2.67;31.13;11.56;18.77;9.14;9.24;7.67;8.43 1991-01-31;6.64;5.28;16.09;23.95;9.99;2.13;10.64;13.2;23.86;12.3;5.24;20.87;4.79;3.17;5.9;1.42;31.49;22.77;3.11;7.99;7.08;12.1;2.73;31.41;11.54;19.38;9.25;9.26;7.76;8.44 1991-02-01;6.73;5.25;15.53;24.13;9.91;2.18;10.31;12.88;24.21;12.03;5.24;20.8;4.67;3.14;5.85;1.46;31.52;22.63;3.23;7.84;7.11;12.18;2.77;30.8;11.79;19.47;9.25;9.34;7.88;8.65 1991-02-04;6.87;5.37;15.9;25.04;10.06;2.22;10.53;12.7;25.26;12.21;5.33;20.29;4.65;3.17;6.11;1.46;31.65;22.82;3.67;7.97;7.26;12.49;2.75;31.13;12.05;19.63;9.29;9.38;7.97;9.07 1991-02-05;6.8;5.77;16.21;24.8;10.21;2.27;10.89;12.83;25.89;12.06;5.44;20.15;4.62;3.25;6.13;1.49;31.93;23.07;3.64;7.96;7.23;12.69;2.81;31.78;11.98;19.6;9.4;9.63;8.05;9.31 1991-02-06;6.75;5.69;16.46;25.23;10.01;2.32;11.24;13.47;24.63;12.6;5.46;20.36;4.7;3.36;6.18;1.55;32.27;23.89;3.64;8.07;7.23;12.89;2.94;32.47;12.24;20.21;9.67;9.7;8.32;9.24 1991-02-07;6.66;5.6;16.83;24.74;9.73;2.28;10.8;13.33;24.56;12.81;5.31;20.65;4.71;3.43;6.46;1.53;31.93;23.6;3.67;7.97;7.11;12.63;2.86;32.28;12.11;19.93;9.8;9.56;8.47;9.13 1991-02-08;6.73;5.69;16.77;25.35;9.61;2.28;11.02;13.47;25.61;12.66;5.35;21.69;4.76;3.37;6.23;1.5;32.17;23.65;3.76;8.07;7.14;12.89;2.89;32.33;12.29;20.12;9.89;9.51;8.38;9.01 1991-02-11;7.05;6.01;16.89;24.92;9.81;2.36;11.32;13.95;26.38;12.99;5.47;21.47;5.05;3.53;6.2;1.54;32.89;24.13;4.12;8.34;7.45;13.27;2.9;33.53;12.78;20.73;10.11;9.75;8.67;9.2 1991-02-12;6.88;5.98;16.64;23.41;10.01;2.39;11.1;14.08;25.68;12.72;5.47;20.96;4.94;3.48;6.22;1.5;32.98;23.69;4.06;8.23;7.76;13.02;2.87;33.58;12.52;20.63;9.89;9.51;8.44;9.33 1991-02-13;7.19;6.09;16.89;22.86;10.11;2.41;11.32;14.45;26.1;13.05;5.56;21.47;5.05;3.52;6.43;1.49;33.45;23.94;4.21;8.3;8.04;13.04;2.93;34.5;12.62;20.54;10.02;9.17;8.7;9.48 1991-02-14;6.97;6.09;16.71;23.29;10.19;2.43;11.24;13.85;25.4;12.81;5.52;21.1;4.96;3.45;6.2;1.47;33.54;24.18;4.03;8.18;7.85;12.91;2.8;33.76;12.49;20.21;9.91;9.14;8.49;9.2 1991-02-15;7.01;6.24;16.95;23.77;10.26;2.47;11.46;14.22;25.89;12.72;5.7;21.69;4.94;3.59;6.38;1.52;34.13;25.22;4.12;8.49;7.82;13.48;2.87;33.96;12.86;20.79;10;9.36;8.73;9.19 1991-02-19;6.97;5.92;16.89;23.95;10.39;2.51;11.43;14.27;26.03;12.75;5.7;21.9;5.62;3.65;6.2;1.55;34.66;25.31;4.03;8.48;7.98;13.53;2.85;33.4;13.48;20.54;9.94;9.35;8.64;9.25 1991-02-20;6.84;5.66;16.71;23.29;10.16;2.51;11.29;14.18;25.61;12.78;5.6;20.96;5.73;3.52;6.12;1.55;34.25;25.27;3.85;8.39;7.92;13.32;2.85;32.94;13.3;20.27;9.69;9.25;8.44;9.14 1991-02-21;6.74;5.8;16.4;23.04;9.99;2.49;11.49;14.27;25.61;12.84;5.58;21.18;5.82;3.39;6.15;1.54;33.66;24.83;3.79;8.43;7.98;13.35;2.78;32.7;13.74;19.93;9.69;9.28;8.47;9.26 1991-02-22;6.68;5.77;16.4;23.22;9.96;2.5;11.62;13.95;25.68;12.81;5.67;21.18;5.84;3.64;6.2;1.55;33.11;24.29;3.91;8.44;7.73;13.45;2.84;32.66;14.05;20.18;9.63;9.42;8.76;9.47 1991-02-25;6.55;5.8;16.64;22.74;10.16;2.5;11.68;13.67;25.26;12.84;5.73;20.81;5.85;3.59;6.2;1.55;33.2;23.66;3.91;8.62;7.7;13.65;2.86;32.84;14.23;20.48;9.56;9.45;8.91;9.63 1991-02-26;6.69;5.63;16.46;22.38;10.09;2.46;11.59;13.67;24.9;12.81;5.61;20.96;5.73;3.56;6.09;1.54;32.24;23.51;3.91;8.48;7.61;13.45;2.83;32.7;13.84;20.48;9.47;9.42;8.7;9.46 1991-02-27;6.6;5.63;16.52;22.92;10.74;2.51;11.68;14.22;24.76;13.28;5.68;22.05;5.73;3.63;6.17;1.53;32.52;23.71;3.94;8.64;7.64;13.63;2.92;33.12;13.79;19.96;9.56;9.47;8.61;9.67 1991-02-28;6.61;5.57;16.46;23.41;10.96;2.48;11.43;13.85;24.76;13.13;5.57;23;5.74;3.58;6.15;1.48;31.99;23.9;3.91;8.61;7.85;13.5;2.88;33.03;13.69;19.87;9.52;9.79;8.32;9.62 1991-03-01;6.78;5.89;16.52;23.89;11.04;2.52;11.51;14.04;24.9;13.28;5.64;23;5.88;3.58;6.2;1.48;32.55;24.1;4.09;8.6;7.95;13.52;2.94;33.31;13.69;20.05;9.58;9.65;8.49;9.66 1991-03-04;6.89;5.98;16.46;24.01;11.14;2.61;11.29;14.18;24.97;13.02;5.59;22.92;5.85;3.64;6.22;1.49;32.45;24.34;4.06;8.51;8.07;13.69;2.97;33.31;13.56;20.33;9.52;9.74;8.44;9.51 1991-03-05;6.98;6.21;16.64;24.38;11.37;2.7;11.62;14.45;25.68;13.08;5.65;23.58;6.05;3.8;6.28;1.6;33.17;24.88;4.21;8.74;8.23;13.82;3.1;33.78;14.02;20.73;9.65;9.94;8.7;9.74 1991-03-06;7.1;6.3;16.77;24.38;11.01;2.63;11.43;14.64;25.96;13.08;5.61;23.58;6.19;3.82;6.33;1.6;33.01;24.29;4.26;9.19;8.2;13.74;2.98;33.82;13.97;20.79;9.65;10.04;8.58;9.87 1991-03-07;6.98;6.09;16.46;24.38;10.99;2.59;11.4;14.31;25.75;13.16;5.58;23.14;6.13;3.81;6.2;1.61;32.92;24.34;4.26;9.48;8.48;13.86;2.89;33.87;14.05;20.85;9.58;9.99;8.61;9.9 1991-03-08;6.96;6.15;16.27;24.01;10.99;2.57;11.4;13.99;25.82;13.19;5.47;23.07;6.02;3.73;6.2;1.6;32.61;24.19;4.21;9.41;8.44;14.04;2.85;34.06;14.01;21.28;9.54;9.92;8.52;9.93 1991-03-11;6.92;6.15;16.77;23.47;11.14;2.52;11.4;14.04;25.75;13.22;5.6;22.92;6.07;3.69;6.09;1.42;32.08;23.95;4.3;9.25;8.16;14.19;2.76;33.59;14.06;20.79;9.54;9.89;8.58;9.82 1991-03-12;6.93;5.95;16.58;23.16;10.94;2.5;11.32;13.9;25.82;13.4;5.56;22.7;5.93;3.61;6.15;1.41;31.55;23.76;4.14;9.17;8.41;14.02;2.66;33.96;13.85;20.67;9.45;9.79;8.52;9.65 1991-03-13;7.11;6.18;16.77;23.47;11.01;2.5;11.65;14.18;25.61;13.64;5.68;23;6.08;3.73;6.17;1.48;32.08;23.85;4.21;9.33;8.72;14.09;2.79;33.82;14.11;20.76;9.52;9.77;8.67;9.75 1991-03-14;7.1;6.33;16.71;23.47;10.99;2.46;11.76;13.95;25.54;13.58;5.61;23.21;5.97;3.69;6.17;1.48;31.83;24.19;4.18;9.62;8.69;14.34;2.72;34.06;13.98;21;9.52;9.7;8.55;9.65 1991-03-15;7;6.44;16.64;23.29;10.71;2.46;11.76;13.9;25.26;13.61;5.62;23.29;5.82;3.65;6.17;1.47;31.46;24.34;4.14;9.82;8.57;14.36;2.68;33.92;13.85;20.97;9.63;9.72;8.7;9.61 1991-03-18;6.97;6.38;16.71;23.29;10.46;2.46;11.84;13.58;25.26;13.43;5.63;22.92;5.84;3.66;6.12;1.46;31.77;24.1;4.18;9.72;8.69;14.07;2.76;33.82;13.98;21.03;9.85;9.62;8.77;9.61 1991-03-19;6.83;6.24;16.95;22.86;10.11;2.38;11.68;13.39;24.62;13.43;5.53;22.49;5.62;3.62;6.04;1.41;28.6;23.42;4.14;9.5;8.66;13.49;2.75;33.45;13.88;20.3;9.67;9.5;8.65;9.44 1991-03-20;6.82;6.18;16.77;22.92;10.06;2.37;11.98;13.58;23.7;13.61;5.47;21.76;5.62;3.58;6.12;1.43;28.35;23.81;3.99;9.44;8.57;13.79;2.75;32.66;14.3;20.45;9.63;9.47;8.74;9.5 1991-03-21;6.71;6.33;16.64;22.86;9.91;2.36;11.84;13.44;23.98;13.64;5.43;21.69;5.59;3.63;5.99;1.38;27.79;23.37;3.84;9.45;8.26;13.69;2.63;32.56;14.4;20.36;9.6;9.47;8.77;9.21 1991-03-22;6.77;6.44;16.21;23.16;9.68;2.35;11.84;13.44;24.41;13.79;5.43;21.83;5.82;3.74;5.89;1.36;27.73;23.32;3.69;9.58;8.35;13.79;2.6;32.56;14.51;20.12;9.58;9.25;8.74;9.28 1991-03-25;6.79;6.56;16.27;23.1;9.84;2.4;11.65;13.3;23.63;14.09;5.48;21.98;5.87;3.82;5.84;1.37;28.2;23.08;3.84;9.96;8.35;13.87;2.73;32.56;13.96;20.24;9.69;9.25;8.89;9 1991-03-26;6.88;6.96;16.71;23.35;9.81;2.46;11.84;13.44;23.91;14.18;5.74;23;6.07;3.94;5.76;1.46;28.29;23.51;4.08;10.24;8.41;14.37;2.92;33.03;14.11;20.79;9.94;9.4;9.36;9.29 1991-03-27;6.86;6.96;17.14;23.1;9.76;2.47;11.89;13.49;24.12;13.91;5.69;22.27;6.25;3.97;5.89;1.48;28.04;24.15;4.12;10.14;8.63;14.17;2.99;32.84;14.24;20.7;9.83;9.47;9.21;9.29 1991-03-28;6.75;6.7;16.89;22.8;9.61;2.46;11.89;13.67;24.69;13.94;5.7;21.98;6.16;3.96;5.99;1.45;28.29;23.76;4.18;10.05;8.63;14.02;2.95;33.03;14.19;20.82;9.94;9.55;9.12;9.28 1991-04-01;6.65;6.61;16.64;22.74;9.53;2.4;12;13.39;24.76;13.7;5.71;21.47;6.02;3.92;6.02;1.48;27.89;23.42;3.96;9.9;8.41;14.02;2.97;32.89;13.91;20.7;9.71;9.4;9.12;9.15 1991-04-02;6.79;6.93;16.95;22.92;9.63;2.5;12.39;14.08;24.9;14.03;5.91;22.41;6.19;4.07;6.09;1.51;28.14;23.71;4.24;10.12;8.66;14.46;3.12;33.59;14.51;20.85;9.85;9.47;9.42;9.36 1991-04-03;6.75;6.93;17.01;23.1;9.73;2.53;12.22;14.13;23.91;13.79;5.85;22.34;6.22;4.12;6.12;1.52;28.11;23.76;4.48;10.1;8.6;14.42;3.16;33.45;14.24;20.79;9.89;9.6;9.59;9.37 1991-04-04;6.71;6.76;17.01;23.83;9.78;2.58;12.17;14.08;24.12;13.7;5.89;22.05;6.41;4.12;6.02;1.53;28.2;23.27;4.6;9.95;8.82;14.41;3.16;33.36;14.32;20.82;9.82;9.7;9.68;9.41 1991-04-05;6.69;6.64;16.77;23.71;9.53;2.56;11.87;13.62;23.98;13.67;5.81;21.69;6.16;4;5.97;1.5;27.98;23.37;4.6;9.79;8.88;14.19;3.06;33.08;14.14;20.73;9.57;9.84;9.56;9.32 1991-04-08;6.68;6.61;17.08;23.71;9.66;2.56;11.79;14.18;24.26;13.73;5.87;21.76;6.33;4.05;5.97;1.51;28.07;23.56;4.63;10.16;8.82;14.36;3.09;33.17;14.3;20.79;9.5;9.67;9.92;9.27 1991-04-09;6.62;6.41;16.89;23.16;9.53;2.48;11.59;13.81;23.56;13.58;5.84;21.54;6.16;4.01;5.81;1.45;27.64;23.42;4.45;10.03;8.54;14.17;3.06;32.8;14.24;20.63;9.44;9.4;9.77;9.15 1991-04-10;6.53;6.49;16.83;22.98;9.41;2.5;11.59;13.99;23.35;13.61;5.93;21.39;6.25;4.02;5.78;1.48;27.64;23.61;4.39;9.97;8.51;14.17;2.99;32.61;14.24;20.42;9.39;9.33;9.71;9.05 1991-04-11;6.5;6.46;17.08;22.8;9.48;2.57;11.57;13.99;23.7;13.88;5.96;21.83;6.25;4.12;5.84;1.62;27.48;24.19;4.54;10.21;8.79;14.39;3.08;33.12;14.3;20.91;9.46;9.42;10.03;8.98 1991-04-12;6.42;6.41;17.32;22.74;9.41;2.52;11.76;14.22;23.49;14.24;5.98;21.47;6.36;4.26;6.04;1.69;26.96;24.34;4.51;10.25;8.72;14.42;2.98;33.03;14.24;21.4;9.5;9.38;10.27;9.02 1991-04-15;6.74;6.38;17.69;22.62;9.41;2.62;11.87;14.31;23.2;14.18;6.04;21.61;6.31;4.24;5.97;1.68;26.55;24.44;4.72;10.17;8.63;14.57;3.16;32.47;14.58;21.4;9.57;9.38;10.42;9.08 1991-04-16;6.74;6.87;18.37;22.56;10.02;2.68;12.17;14.64;23.84;14.33;6.13;22.05;6.54;4.26;6.09;1.69;27.14;24.68;4.9;10.51;8.79;15.02;3.12;33.22;14.95;21.86;9.57;9.15;10.33;9.42 1991-04-17;7.01;6.99;18.68;22.8;10;2.62;12.28;14.77;24.26;14.33;6.16;22.63;6.56;4.32;6.2;1.7;27.3;25.27;5.29;10.43;8.79;15.25;3.1;33.31;14.74;21.89;9.68;8.98;10.3;9.45 1991-04-18;6.98;6.84;18.55;22.92;10.2;2.57;12.06;15.05;23.84;14.27;6.14;23.21;6.57;4.24;6.15;1.66;27.27;25.51;5.17;10.31;8.69;15.1;3.06;33.12;14.61;21.83;9.71;8.81;10.09;9.35 1991-04-19;6.95;6.55;18.43;22.68;10;2.45;11.89;15.05;24.48;14.33;6.09;22.78;6.53;4.16;6.15;1.64;27.2;24.73;5.08;10.2;8.57;14.76;2.98;32.75;14.3;21.34;9.68;8.71;9.89;9.15 1991-04-22;6.91;6.35;17.82;22.62;9.9;2.37;11.89;14.68;24.12;14.33;6.01;21.9;6.48;4.2;6.09;1.66;26.96;24.49;4.9;10.12;8.69;14.61;2.84;32.7;14.11;21.06;9.62;8.78;9.95;9.13 1991-04-23;7.02;6.2;17.75;23.04;9.85;2.4;11.84;14.91;24.48;14.5;5.97;21.83;6.54;4.26;6.04;1.67;26.93;24.44;5.08;10.04;8.66;14.61;2.82;32.75;14.09;20.76;9.59;8.88;9.86;9.29 1991-04-24;7.22;6.38;18.31;23.16;9.75;2.48;11.79;15.14;24.76;14.5;5.94;22.27;6.77;4.36;5.89;1.71;26.89;24.58;5.05;9.84;8.75;14.52;2.86;32.84;14.14;20.54;9.53;9.06;10.03;9.21 1991-04-25;7.02;6.17;18.49;23.1;9.65;2.44;11.68;15.1;24.34;14.09;5.86;21.54;6.61;4.29;5.94;1.65;26.83;24.34;5.05;9.96;8.63;14.57;2.8;32.8;14.17;20.3;9.5;8.98;9.83;8.99 1991-04-26;6.91;6.11;18.74;22.38;9.6;2.43;11.62;15;24.19;14.18;5.88;21.18;6.56;4.31;6.02;1.62;26.68;24.49;4.99;9.95;8.54;14.49;2.8;32.61;14.11;20.48;9.55;9.03;9.74;8.98 1991-04-29;6.97;6.03;18.31;22.25;9.57;2.39;11.26;15.1;23.56;14.09;5.73;19.79;6.33;4.25;5.94;1.57;26.06;24.49;5.02;9.93;8.38;14.32;2.72;32.66;14.01;20.36;9.44;9.01;9.53;8.97 1991-04-30;7.01;5.85;18.43;22.19;9.62;2.37;11.57;15.33;23.56;14.18;5.8;20.81;6.3;4.22;6.12;1.53;25.59;24.49;4.93;9.91;8.32;14.32;2.75;33.26;13.93;20.51;9.57;9.06;9.53;8.99 1991-05-01;7.26;6.14;18.62;22.07;9.85;2.43;11.89;15.69;23.06;14.39;5.94;21.9;6.08;4.35;5.99;1.51;25.84;24.73;4.9;10.09;8.44;14.82;2.8;33.12;14.35;20.45;9.59;9.1;9.68;9.18 1991-05-02;7.37;6.23;18.43;22.25;9.97;2.44;11.92;15.51;23.27;14.21;5.94;21.61;5.9;4.37;6.09;1.5;26.3;24.73;4.84;9.88;8.48;15;2.79;33.03;14.3;20.45;9.48;9.01;9.74;9.2 1991-05-03;7.32;6;18.31;22.62;10.15;2.43;12.09;15.74;23.27;14.12;5.95;22.12;5.7;4.33;6.17;1.51;25.75;24.63;4.78;9.88;8.32;15.34;2.81;32.84;14.43;20.39;9.53;8.93;9.74;9.42 1991-05-06;7.42;5.91;18.12;22.8;10.05;2.43;12.11;15.83;23.63;14.03;5.97;21.83;5.7;4.34;6.15;1.54;25.68;24.49;4.69;9.86;8.26;15.47;2.85;32.75;14.35;20.24;9.5;8.88;9.68;9.54 1991-05-07;7.34;5.88;17.69;22.8;10.25;2.37;12;15.33;23.27;13.73;5.99;21.39;5.56;4.27;6.04;1.56;25.31;24.63;4.72;9.87;8.35;15.62;2.81;32.56;14.19;20.08;9.44;8.81;9.59;9.36 1991-05-08;7.32;5.67;17.75;22.86;10.4;2.36;12;15.74;23.63;13.88;5.97;21.54;5.73;4.29;6.17;1.6;25.78;24.49;4.75;9.82;8.44;15.55;2.86;32.75;14.14;20.24;9.28;8.91;9.42;9.35 1991-05-09;7.36;5.79;18.06;23.35;10.55;2.38;12.28;16.18;23.49;14.21;6.03;22.34;6.04;4.4;6.12;1.69;26.3;25.17;4.81;9.99;8.51;15.8;2.94;33.54;14.32;20.36;9.12;8.96;9.89;9.62 1991-05-10;7.41;5.59;17.69;22.8;10.48;2.33;12;15.62;23.42;13.79;5.84;21.91;5.94;4.3;6.15;1.65;25.68;25.07;4.66;9.78;8.41;15.74;2.85;32.98;14.09;20.15;8.94;8.93;9.42;9.44 1991-05-13;7.19;5.35;18;22.8;10.38;2.33;11.92;15.99;23.27;13.7;5.86;21.84;6;4.28;6.19;1.64;26.3;25.46;4.69;9.75;8.38;15.75;2.86;33.36;14.11;20.21;9.01;8.96;9.62;9.48 1991-05-14;7.04;5.5;17.75;22.68;10.23;2.31;11.81;15.99;22.99;13.4;5.81;21.47;5.88;4.24;6.03;1.66;26.34;24.88;4.48;9.69;8.32;15.59;2.81;32.98;13.88;20.02;8.94;8.78;9.53;9.4 1991-05-15;6.9;5.56;17.63;22.38;10.05;2.27;11.79;15.8;23.13;13.43;5.81;21.55;5.67;4.14;5.9;1.53;25.53;24.78;4.45;9.62;8.13;15.52;2.72;32.75;13.59;20.08;8.88;8.74;9.53;9.24 1991-05-16;6.95;5.5;17.82;22.62;10.1;2.3;12.06;15.94;23.27;13.73;5.83;21.77;5.91;4.24;5.85;1.51;25.87;24.54;4.51;9.69;8.2;15.74;2.76;33.17;13.72;20.08;8.88;8.69;9.62;9.35 1991-05-17;6.84;5.44;17.75;22.31;10.1;2.28;12.03;15.66;23.27;13.82;5.86;21.4;5.93;4.29;5.87;1.51;25.78;24.49;4.48;9.48;8.35;15.82;2.76;32.84;13.54;20.05;8.99;8.64;9.56;9.36 1991-05-20;6.9;5.38;17.75;22.31;10;2.33;12.09;15.8;23.49;13.88;5.92;21.33;5.91;4.32;5.87;1.51;25.65;24.5;4.51;9.61;8.48;15.9;2.75;33.23;13.49;20.08;8.94;8.68;9.51;9.42 1991-05-21;7.02;5.44;17.82;22.44;9.72;2.35;12.25;16.08;23.2;14.06;5.95;21.69;5.91;4.46;5.9;1.46;25.22;24.65;4.54;9.86;8.63;16.2;2.83;33.56;13.75;20.08;9.06;8.75;9.74;9.42 1991-05-22;7.04;5.47;17.63;22.68;9.47;2.39;12.28;15.99;23.63;14.06;5.85;22.21;6.1;4.59;5.87;1.51;25.99;24.5;4.66;9.92;8.54;16.17;2.97;33.37;13.96;20.21;9.01;8.73;9.8;9.39 1991-05-23;6.94;5.44;17.45;22.31;9.37;2.36;12.06;15.99;22.99;14;5.92;22.72;6.27;4.75;5.85;1.57;25.99;24.26;4.81;9.86;8.41;16.1;3.04;32.95;14.09;20.18;8.97;8.75;9.59;9.41 1991-05-24;7.03;5.56;17.75;22.5;9.34;2.35;12.25;16.04;23.2;13.97;5.98;23.38;6.27;4.8;5.8;1.59;26.09;24.99;4.96;9.75;8.38;16.07;3.06;33.09;14.19;20.18;8.97;8.63;9.74;9.42 1991-05-28;7.34;5.85;17.94;22.62;9.62;2.37;12.39;16.73;23.35;13.97;6.07;23.9;6.51;4.75;5.87;1.66;26.12;25.63;5.05;9.94;8.57;16.22;3.08;33.61;14.43;20.36;8.94;8.75;9.92;9.44 1991-05-29;7.47;5.97;18.12;22.74;9.62;2.42;12.39;16.87;23.35;14;6.11;25.08;6.57;4.68;6.03;1.62;25.87;26.37;4.99;9.86;8.6;16.15;3.06;34.17;14.3;20.45;8.97;8.78;9.77;9.27 1991-05-30;7.41;5.91;18.43;23.47;9.92;2.54;12.58;17.38;24.28;13.94;6.27;25;6.59;4.79;6.29;1.66;25.93;26.91;5.05;9.69;8.75;16.02;3.06;34.88;14.27;20.91;9.21;8.83;9.95;9.11 1991-05-31;7.38;6;18.31;23.77;10.45;2.56;12.55;17.57;24.28;13.88;6.33;25.37;6.68;4.83;6.27;1.73;26.37;27.69;5.14;9.54;8.69;15.8;3.05;35.87;14.27;20.82;9.28;9.32;10.09;9.05 1991-06-03;7.43;5.97;18.18;23.47;10.81;2.58;12.39;17.62;24.71;14.03;6.35;25.3;6.67;4.84;6.27;1.82;26.43;28.33;5.05;9.31;8.66;15.51;3.11;35.77;13.96;20.51;9.06;9.32;9.95;9.21 1991-06-04;7.47;6.03;18.06;23.41;10.68;2.56;12.33;17.38;24.42;13.94;6.3;25;6.64;4.81;6.24;1.8;26.09;28.28;5.29;9.35;8.69;15.58;3.14;35.77;14.04;20.48;9.03;9.42;9.89;9.17 1991-06-05;7.42;5.82;18;23.35;10.48;2.47;12.11;17.43;24.42;13.79;6.2;24.49;6.65;4.86;6.21;1.67;25.65;28.13;5.53;9.32;8.6;15.53;3.11;35.35;13.98;20.3;8.97;9.35;9.74;9.19 1991-06-06;7.25;5.82;18.06;23.16;10.43;2.47;12.03;17.48;24.71;13.88;6.16;24.56;6.51;4.82;6.16;1.66;25.59;28.33;5.59;9.31;8.48;15.34;3.09;35.11;13.85;20.15;8.94;9;9.86;8.98 1991-06-07;7.14;5.7;17.94;23.29;10.48;2.49;12.03;17.34;24.49;13.7;6.07;24.34;6.33;4.79;5.95;1.62;25.34;27.89;5.83;9.14;8.48;15.31;3.06;35.02;13.85;20.24;8.92;9.1;9.8;9.03 1991-06-10;7.07;5.62;17.88;23.16;10.53;2.47;12.14;17.29;24.56;13.82;6.1;24.63;6.41;4.72;6;1.57;25.43;27.94;5.58;9.14;8.41;15.26;3.07;34.78;13.83;20.21;8.92;9;9.92;9.1 1991-06-11;6.97;5.56;18.12;23.35;10.61;2.45;12.22;17.52;24.35;13.94;6.16;24.93;6.44;4.79;5.98;1.59;25.4;27.94;5.83;9.15;8.54;15.43;3.07;35.11;13.84;20.39;9.1;9.1;10.16;9.09 1991-06-12;6.94;5.47;17.94;23.22;10.45;2.35;12.03;17.2;23.78;13.73;6.08;24.86;6.54;4.78;6.03;1.53;25.22;27.59;5.64;8.98;8.44;15.54;3.09;35.11;13.76;20.3;9.01;9.07;10.02;9.04 1991-06-13;6.94;5.67;18.06;23.47;10.38;2.4;12.19;17.43;23.78;13.79;6.13;24.78;6.41;4.84;6;1.52;25;27.25;5.68;8.94;8.48;15.46;3.08;35.21;13.71;20.51;9.1;9.12;10.04;9.04 1991-06-14;7.01;5.76;18.31;23.95;10.48;2.4;12.36;17.85;23.85;13.88;6.2;26.03;6.34;5.01;6.06;1.5;24.94;27.94;5.64;9;8.26;15.79;3.15;36.15;14.02;20.67;9.35;9.22;10.22;9.1 1991-06-17;7.15;5.62;18.43;23.77;10.43;2.37;12.33;17.85;23.7;13.7;6.11;25.74;6.3;5.08;6.08;1.54;24.72;28.57;5.49;8.98;8.13;15.78;3.15;36.1;13.89;20.73;9.21;9.12;10.07;9.04 1991-06-18;7.21;5.62;18.62;24.01;10.28;2.33;12.14;17.71;23.35;13.58;6.11;25.59;6.27;4.97;6.08;1.51;25.06;28.87;5.4;8.92;8.01;15.56;3.1;36.15;13.86;20.39;9.17;9.12;10.02;9 1991-06-19;7.21;5.56;18.62;23.53;10;2.32;12.11;17.48;22.99;13.58;6.07;25.3;6.27;4.94;6.06;1.48;25.09;28.33;5.4;8.81;7.95;15.44;2.87;36.15;13.73;19.81;9.06;9.1;9.99;8.86 1991-06-20;7.21;5.5;18.55;23.65;9.95;2.31;12.22;17.57;23.2;13.85;6.07;25.66;6.24;4.93;6.11;1.46;24.63;27.94;5.34;8.94;7.92;15.48;2.8;35.77;13.73;19.66;9.14;9.05;10.13;8.84 1991-06-21;7.17;5.56;18.74;22.74;10.1;2.32;12.22;17.94;23.35;13.94;6.14;25.96;6.34;4.93;6.21;1.46;24.75;28.23;5.37;9;7.98;15.53;2.84;36.1;13.68;19.6;9.17;9.02;10.22;8.84 1991-06-24;6.99;5.44;18.37;22.13;9.82;2.21;12.14;17.15;22.85;13.85;6.04;24.27;6.19;4.78;6.27;1.36;24.44;27.84;5.31;8.85;7.85;15.28;2.73;35.35;13.5;19.26;9.14;8.93;9.96;8.76 1991-06-25;6.91;5.53;18.68;22.19;9.87;2.23;12.03;17.01;22.56;13.94;6.03;24.34;6.28;4.82;6.27;1.37;24.69;27.69;5.13;8.82;7.85;15.58;2.74;35.3;13.29;18.98;9.21;8.9;9.96;8.81 1991-06-26;6.9;5.41;18.86;22.01;10.1;2.21;12.11;17.06;22.85;14.12;6.02;23.97;6.34;4.83;6.16;1.43;24.5;27.98;5.4;8.73;7.89;15.71;2.8;35.11;13.44;18.92;9.26;8.88;10.22;8.73 1991-06-27;7.04;5.38;19.11;22.07;10.2;2.22;12.06;17.2;22.77;14.06;6.11;24.27;6.36;5.02;6.98;1.42;24.25;28.18;5.34;8.86;8.29;15.83;2.83;35.54;13.47;18.89;9.48;8.93;10.22;8.64 1991-06-28;7.01;5.32;18.86;22.19;9.97;2.24;12;17.06;22.2;13.85;6.06;23.97;6.25;4.96;6.92;1.45;24.13;27.64;5.19;8.79;8.16;15.51;2.84;35.25;13.34;18.92;9.59;8.85;10.07;8.7 1991-07-01;6.93;5.41;19.05;22.31;10.05;2.3;12.33;17.43;22.77;14.27;6.13;24.86;6.48;5.17;7.16;1.41;24.44;27.94;5.22;8.9;8.32;15.93;2.97;35.4;13.68;19.44;9.82;8.83;10.28;8.88 1991-07-02;7.12;5.35;19.36;22.19;10.05;2.22;12.31;17.62;22.7;14;6.14;25.08;6.45;5.2;7.26;1.33;24.63;28.18;5.16;8.74;8.32;15.94;2.84;35.11;13.79;19.47;9.71;9;10.28;9.28 1991-07-03;7.04;5.23;19.36;21.83;9.85;2.21;12.25;17.52;22.34;13.67;6.06;24.93;6.27;5.18;7.13;1.33;24.38;28.18;5.01;8.63;8.2;15.66;2.67;34.27;13.73;19.29;9.63;9.05;10.22;9.24 1991-07-05;6.99;5.2;19.17;21.65;9.8;2.24;12.31;17.52;22.34;13.7;6.04;25;6.25;5.17;7.11;1.33;24.5;28.33;5.07;8.9;8.2;15.71;2.57;34.17;13.79;19.32;9.63;8.95;10.31;9.25 1991-07-08;7.08;5.17;19.29;21.47;9.65;2.25;12.44;17.52;23.28;13.94;6.13;25.44;6.54;5.21;7.13;1.37;24.97;28.43;5.25;8.96;8.2;15.96;2.79;34.45;14.02;19.53;9.68;8.88;10.66;9.33 1991-07-09;7.04;5.2;19.23;21.53;9.52;2.28;12.28;17.38;23.35;13.73;6.12;25.44;6.65;5.25;7.32;1.41;24.72;28.23;5.58;9.02;8.2;15.74;2.83;34.45;13.79;19.38;9.65;8.68;10.52;9.35 1991-07-10;7.06;5.29;19.11;21.89;9.54;2.41;12.19;17.29;23.42;13.67;6.08;24.93;6.74;5.28;7.5;1.45;24.53;27.69;5.55;9.11;8.2;15.69;2.72;33.98;13.92;19.35;9.77;8.78;10.52;9.37 1991-07-11;7.2;5.41;19.23;22.07;9.54;2.41;12.31;17.43;23.28;13.79;6.14;25.08;6.59;5.27;7.58;1.41;24.41;27.74;5.55;9.17;8.23;15.81;2.76;33.89;13.97;19.41;9.81;9.02;10.78;9.48 1991-07-12;7.3;5.41;18.99;22.13;9.7;2.34;12.72;17.66;23.13;14;6.16;25.15;6.62;5.32;7.63;1.45;24.69;27.84;5.77;9.19;8.2;16.01;2.83;33.7;14.23;19.56;9.83;9.1;10.96;9.56 1991-07-15;7.42;5.41;18.86;22.13;9.82;2.39;12.69;17.34;23.56;14.09;6.17;24.86;6.93;5.4;7.6;1.45;24.66;27.89;6.46;9.15;8.23;16.24;2.91;33.94;14.44;19.66;9.9;9.02;11.11;9.55 1991-07-16;7.41;5.41;18.62;22.13;9.68;2.49;12.72;17.15;23.42;14.06;6.05;24.71;6.87;5.31;7.89;1.42;24.01;27.64;6.25;9.23;8.23;16.16;2.81;34.22;14.34;19.66;9.81;9.25;11.02;9.49 1991-07-17;7.26;5.5;18.74;21.95;9.71;2.52;12.83;16.97;23.56;14.27;5.88;24.93;6.88;5.24;7.95;1.38;23.91;27.4;6.1;9.11;8.44;16.13;2.82;33.94;14;19.57;9.74;9.3;10.93;9.39 1991-07-18;7.42;5.64;19.54;21.77;9.83;2.54;13.19;17.43;23.49;14.27;5.99;25.08;6.88;5.25;7.97;1.42;24.41;27.69;6.25;9.25;8.41;16.23;2.79;34.31;14.05;19.63;9.86;9.72;11.02;9.52 1991-07-19;7.5;5.64;19.66;21.22;10.01;2.46;13.1;17.43;23.28;14.21;6.03;25;6.9;5.17;7.92;1.47;24.97;27.98;6.25;9.23;8.51;16.18;2.82;34.17;13.84;19.66;9.77;9.62;11.02;9.52 1991-07-22;7.42;5.47;19.54;20.98;10.16;2.49;12.97;17.48;23.13;14.18;6;24.86;6.76;5.07;7.63;1.43;25.34;27.94;6.25;9.24;8.51;16.13;2.81;35.02;13.76;19.57;9.58;9.6;10.93;9.54 1991-07-23;7.51;5.85;19.48;21.22;10.06;2.51;12.86;17.2;22.92;13.94;5.92;24.19;6.59;4.95;7.63;1.38;25;27.25;6.13;9.17;8.26;16.06;2.77;33.75;13.79;19.17;9.45;9.55;10.84;9.49 1991-07-24;7.33;5.88;19.54;21.28;9.88;2.42;12.83;17.38;22.42;14.03;5.85;23.83;6.51;4.98;7.58;1.39;25.03;26.66;6.16;9.14;8.23;16.19;2.73;32.81;13.84;19.41;9.52;9.5;10.69;9.33 1991-07-25;7.36;5.82;19.6;21.34;10.06;2.49;12.83;17.9;23.06;14.09;5.94;24.12;6.59;5.02;7.79;1.42;24.97;26.81;6.22;9.21;8.2;16.44;2.75;32.9;14;19.41;9.56;9.55;10.9;9.21 1991-07-26;7.37;5.85;19.66;21.16;9.91;2.45;12.75;17.99;22.63;14;5.96;23.9;6.64;5.16;7.92;1.41;24.97;27;6.22;9.25;8.13;16.46;2.96;32.95;13.94;19.29;9.56;9.55;10.9;9.17 1991-07-29;7.29;6.15;19.66;21.53;10.01;2.46;12.88;18.22;23.13;14.12;5.96;23.75;6.71;5.2;8;1.41;25.19;26.81;6.22;9.45;8.1;16.66;2.93;33.14;14;19.44;9.63;9.45;11.02;9.19 1991-07-30;7.35;6.03;19.66;22.56;10.09;2.48;13.08;18.31;23.28;14.18;5.99;23.46;6.74;5.32;8.21;1.43;25.25;27.1;6.25;9.57;8.2;17.01;3.03;33.37;14.05;19.84;9.72;9.37;11.13;9.37 1991-07-31;7.37;6;19.66;22.5;9.99;2.56;13.24;18.17;23.49;14.15;6;23.38;6.62;5.34;8.16;1.46;25.16;27.25;6.22;9.65;8.13;17.2;3.06;33.04;14.23;19.75;9.81;9.27;11.22;9.44 1991-08-01;7.29;6.23;19.54;21.95;10.04;2.5;13.41;17.94;23.42;14.15;5.98;23.38;6.76;5.28;8.13;1.54;25.16;26.91;6.19;9.58;8.01;17.13;3.05;32.48;14.42;19.72;9.77;9.35;11.16;9.47 1991-08-02;7.25;6.09;19.66;22.07;10.09;2.53;13.63;18.03;23.35;14;5.96;23.46;6.96;5.29;8.21;1.53;24.94;26.56;6.19;9.64;7.89;17.05;3.05;32.52;14.47;19.81;9.86;9.22;11.25;9.44 1991-08-05;7.07;6.15;19.54;22.07;9.91;2.54;13.68;17.76;23.06;13.91;5.9;23.53;6.77;5.28;7.95;1.52;25.09;26.56;6.16;9.6;7.82;16.88;3.01;32.62;14.47;19.96;9.88;9;11.16;9.36 1991-08-06;7.12;6.32;19.66;22.44;9.96;2.63;13.98;18.22;23.28;14.24;5.96;23.9;6.82;5.49;8.08;1.58;24.94;26.76;6.28;9.74;7.92;17.11;3.1;33.04;15.02;20.33;9.99;9.07;11.4;9.47 1991-08-07;7.25;6.26;19.6;22.56;9.96;2.67;13.96;18.27;23.78;14.03;6.04;23.97;6.7;5.43;7.97;1.56;24.6;26.66;6.34;9.77;8.1;17.15;3.17;32.71;15.05;20.12;9.88;9.12;11.34;9.35 1991-08-08;7.06;6.06;19.6;22.68;10.04;2.74;13.87;18.5;23.56;13.85;6.05;23.53;6.54;5.49;8;1.52;24.66;26.95;6.59;9.7;8.2;17.03;3.29;32.71;14.94;19.87;9.88;9.12;11.52;9.37 1991-08-09;7.14;6.15;19.48;22.5;9.93;2.7;13.85;18.09;23.28;13.7;6.03;22.65;6.59;5.49;7.92;1.5;24.57;26.81;6.53;9.71;8.1;16.9;3.36;32.81;14.97;19.84;9.99;9.1;11.46;9.35 1991-08-12;7.14;6.23;19.36;22.31;9.88;2.66;13.93;18.24;24.35;13.73;6.01;22.51;6.53;5.6;7.96;1.52;24.5;26.56;6.62;9.64;7.98;16.96;3.46;32.71;14.94;20.08;9.93;9.12;11.58;9.42 1991-08-13;7.16;6.35;19.17;22.44;9.73;2.69;13.98;17.95;24.71;13.79;6;22.95;6.54;5.71;7.99;1.55;24.6;26.66;6.86;9.71;8.1;16.96;3.44;32.76;14.97;20.21;9.79;9.17;11.75;9.45 1991-08-14;7.05;6.41;19.29;22.68;9.71;2.74;14.04;18;24.64;13.64;5.98;22.65;6.77;5.82;8.01;1.56;24.47;26.56;7.04;9.61;7.98;16.88;3.44;32.57;15.23;20.24;9.81;9.12;12.14;9.56 1991-08-15;7.03;6.38;19.48;23.04;9.63;2.71;14.07;18.14;25.07;13.7;5.95;22.8;6.71;5.64;8.01;1.53;24.44;26.37;6.8;9.64;7.98;16.8;3.4;32.57;15.15;20.27;9.81;9.22;11.72;9.36 1991-08-16;7.05;6.18;19.29;22.44;9.53;2.66;13.82;17.81;24.64;13.7;5.9;22.28;6.28;5.51;8.07;1.48;23.98;25.88;6.68;9.44;7.95;16.68;3.41;32.57;15.05;20.08;9.7;9.12;11.4;9.14 1991-08-19;6.9;5.91;18.8;22.01;9.22;2.52;13.63;17.2;23.7;13.73;5.76;21.17;6.16;5.39;7.83;1.46;23.6;25.35;6.4;9.2;7.7;16.39;3.34;32.25;14.65;19.57;9.43;8.81;11.19;8.87 1991-08-20;6.75;6.03;18.86;22.25;9.27;2.61;13.93;17.58;24.06;13.7;5.78;20.95;6.14;5.46;7.93;1.48;23.79;25.45;6.49;9.23;7.7;16.39;3.35;32.11;14.76;19.66;9.52;8.96;11.46;8.82 1991-08-21;6.84;6.2;19.29;23.41;9.53;2.75;14.34;18.28;25.07;13.88;5.97;22.28;6.36;5.75;8.01;1.57;23.76;26.34;6.68;9.56;7.95;16.88;3.5;32.77;15.47;19.99;9.81;9.64;11.75;9.15 1991-08-22;6.93;6.15;19.29;23.59;9.58;2.75;14.29;18.28;24.99;13.94;5.98;21.91;6.42;5.78;8.12;1.55;23.45;26.98;6.53;9.64;8.01;16.86;3.5;33.06;15.39;19.93;9.79;9.72;11.61;9.09 1991-08-23;7.25;6.12;19.29;23.59;9.81;2.74;14.31;18.28;25.21;14.06;6.12;22.51;6.59;5.73;8.33;1.56;23.57;27.77;6.53;9.74;8.13;16.81;3.55;33.11;15.36;20.36;9.93;9.82;11.61;9.21 1991-08-26;7.31;6.26;19.29;23.65;9.71;2.74;14.29;18.38;25.14;13.94;6.11;22.36;6.62;5.67;8.28;1.57;23.63;27.82;6.46;9.77;8.1;16.78;3.55;33.2;15.39;20.24;10.04;9.74;11.68;9.3 1991-08-27;7.24;6.23;19.11;23.77;9.65;2.78;14.23;18.19;25.28;13.97;6.07;22.21;6.54;5.8;8.15;1.63;23.66;27.62;6.37;9.72;8.07;16.71;3.53;33.06;15.39;20.33;9.97;9.67;11.82;9.25 1991-08-28;7.27;6.44;19.05;24.32;9.76;2.8;14.62;18.28;25.64;14.18;6.13;22.88;6.53;5.93;8.28;1.61;23.48;27.57;6.34;9.82;8.16;17.08;3.57;33.25;15.57;20.3;9.99;9.69;11.82;9.31 1991-08-29;7.21;6.32;19.05;24.26;9.68;2.73;14.53;18.24;25.14;14.03;6.12;22.73;6.62;5.89;8.23;1.59;23.73;27.42;6.43;9.84;8.26;17.18;3.57;33.11;15.68;20.42;9.95;9.59;11.73;9.25 1991-08-30;7.23;6.26;19.23;24.13;9.65;2.72;14.48;18.09;24.99;13.88;6.13;22.58;6.51;5.93;8.15;1.54;24.07;27.47;6.43;9.82;8.1;17.03;3.55;33.01;15.57;20.42;9.99;9.62;11.94;9.28 1991-09-03;7.15;6.12;19.36;24.07;9.58;2.69;14.31;17.72;24.05;13.82;6.07;22.13;6.41;5.9;8.12;1.51;24.35;26.93;6.43;9.73;8.07;16.98;3.46;32.92;15.44;20.21;10.08;9.57;11.73;9.13 1991-09-04;7.08;6.18;19.42;24.5;9.45;2.67;14.15;17.67;24.12;13.79;6.03;21.76;6.27;5.83;8.17;1.5;24.5;26.59;6.43;9.64;7.89;16.88;3.44;32.82;15.41;20.33;10.06;9.49;11.79;8.99 1991-09-05;7.08;6.26;19.36;25.29;9.48;2.64;14.15;17.77;24.2;14;5.92;21.47;6.13;5.73;8.17;1.48;24.41;26.09;6.43;9.56;7.82;16.94;3.35;32.96;15.28;20.24;10.08;9.49;11.91;9.02 1991-09-06;7.05;6.18;19.29;25.41;9.5;2.6;14.34;17.53;24.7;14.06;5.81;21.61;6.24;5.69;8.15;1.48;24.69;26.14;6.43;9.51;7.79;17.06;3.36;32.82;15.31;20.21;10.15;9.39;11.85;9 1991-09-09;6.97;6.12;18.8;25.1;9.45;2.64;14.26;17.44;24.99;14.03;5.78;21.39;6.25;5.75;8.2;1.46;25.09;26.09;6.5;9.45;7.95;17.38;3.36;32.63;15.47;20.12;10.15;9.26;11.7;9.03 1991-09-10;6.91;6.06;18.49;24.8;9.4;2.62;14.06;17.11;24.85;13.97;5.75;21.17;6.07;5.6;8.25;1.48;24.75;25.65;6.43;9.36;7.98;17.3;3.33;32.54;15.34;20.12;10.06;9.14;11.65;8.9 1991-09-11;6.98;6.06;18.43;24.26;9.38;2.54;14.17;17.06;24.7;14.03;5.76;21.24;5.91;5.61;8.09;1.52;25.19;25.8;6.34;9.33;8.07;17.48;3.42;32.68;15.42;20.12;10.22;9.06;11.65;8.84 1991-09-12;6.93;6.06;18.86;24.19;9.35;2.68;14.31;17.2;24.63;14.03;5.7;21.69;6.08;5.71;8.15;1.55;25.84;26.09;6.37;9.51;8.23;17.55;3.57;33.39;15.66;20.3;10.36;9.14;11.7;8.83 1991-09-13;6.9;6.03;18.68;23.59;9.2;2.67;14.26;16.97;25.14;13.91;5.56;21.69;5.84;5.6;8.04;1.34;25.56;26.49;6.22;9.43;8.1;17.28;3.46;33.39;15.34;20.24;10.15;9.26;11.62;8.78 1991-09-16;7.03;6.03;18.56;23.77;9.35;2.73;14.45;17.39;25.35;14.21;5.71;21.69;5.7;5.6;7.93;1.29;25.75;26.44;6.07;9.55;8.2;17.4;3.46;33.58;15.39;20.54;10.24;9.39;11.73;8.88 1991-09-17;6.99;6;18.62;23.95;9.3;2.67;14.4;17.16;24.77;14.15;5.66;21.76;5.74;5.58;7.78;1.27;26.06;26.83;6.22;9.49;8.1;17.68;3.52;33.53;15.42;20.51;10.27;9.44;11.73;8.91 1991-09-18;6.99;6;18.62;23.77;9.32;2.75;14.48;17.16;24.7;14.12;5.67;21.84;5.82;5.73;7.8;1.3;26.18;26.49;6.19;9.45;8.16;17.65;3.53;33.91;15.58;20.73;10.4;9.44;11.7;8.79 1991-09-19;6.95;6.18;18.8;24.26;9.3;2.69;14.37;17.11;25.06;14.15;5.69;21.91;5.9;5.73;7.83;1.29;26.06;26.73;6.19;9.48;8.16;17.68;3.59;34.06;15.42;20.82;10.45;9.24;11.7;8.67 1991-09-20;6.89;6.06;18.62;24.13;9.3;2.71;14.31;16.97;24.77;14.06;5.69;21.76;5.96;5.84;7.86;1.31;25.9;26.78;6.22;9.37;8.26;17.78;3.6;33.82;15.42;20.64;10.29;9.16;11.7;8.66 1991-09-23;6.77;6.12;18.86;24.13;9.2;2.68;14.17;16.83;24.85;13.97;5.65;21.84;5.99;5.93;7.86;1.27;25.99;26.78;6.22;9.41;8.35;17.5;3.54;33.63;15.26;20.51;10.24;9.09;11.62;8.78 1991-09-24;6.65;6.18;18.86;24.38;9.27;2.69;14.23;16.88;24.77;14.18;5.72;21.99;6.16;6.01;7.93;1.3;26.3;27.32;6.13;9.58;8.29;17.62;3.67;34.06;15.29;20.73;10.18;9.16;11.68;8.93 1991-09-25;6.63;6.09;18.68;24.68;9.3;2.77;14.23;17.02;24.63;14.15;5.64;21.99;6.1;6.04;7.99;1.3;26.09;27.13;6.16;9.49;8.6;17.43;3.66;33.96;15.21;20.6;9.97;9.11;11.29;8.87 1991-09-26;6.71;6.12;18.74;24.56;9.05;2.79;14.2;16.83;24.49;14;5.65;22.51;6.19;5.95;7.93;1.32;26.06;27.37;6.25;9.47;8.75;17.45;3.72;33.96;15.18;20.42;9.99;8.96;11.2;8.94 1991-09-27;6.65;6.18;18.49;24.44;9.12;2.88;14.2;16.88;24.49;14;5.64;22.36;6.04;5.9;7.72;1.31;25.4;27.08;6.22;9.36;8.72;17.28;3.68;34.25;15.26;20.51;9.99;8.91;11.26;8.91 1991-09-30;6.67;6.12;18.49;24.62;9.07;2.87;14.26;16.92;24.7;14.18;5.68;22.21;6.1;6;7.7;1.31;25.75;26.88;6.22;9.35;8.69;17.46;3.71;34.25;15.26;20.76;10.15;9.04;11.26;8.91 1991-10-01;6.58;6.23;18.56;24.56;8.99;2.87;14.37;17.02;24.92;14.36;5.72;22.06;5.99;6.05;7.78;1.28;25.5;26.34;6.01;9.39;8.66;17.6;3.7;34.58;15.58;20.76;10.29;8.86;11.29;8.79 1991-10-02;6.34;6.06;18.49;24.32;9.05;2.9;14.34;16.73;24.85;14.36;5.78;21.99;5.88;6.09;7.7;1.24;25.12;26.98;6.04;9.25;8.79;17.5;3.62;34.72;15.37;20.7;10.15;8.81;11.26;8.8 1991-10-03;6.2;5.49;18.31;23.77;9.05;2.83;14.15;16.69;24.85;14.18;5.66;22.28;5.77;6.04;7.48;1.23;24.6;27.32;5.88;9.21;8.69;17.41;3.65;34.58;15.23;20.51;10.27;8.71;11.14;8.79 1991-10-04;6.11;5.16;17.94;23.35;9.05;2.73;14.12;16.36;24.41;14.09;5.6;22.8;5.77;5.86;7.43;1.24;24.41;27.28;5.82;9.17;8.72;17.38;3.67;33.91;15.1;20.39;10.17;8.69;10.94;8.84 1991-10-07;6.08;4.95;17.88;23.47;9.2;2.84;14.06;16.41;23.76;14.12;5.51;22.88;5.85;5.75;7.43;1.24;24.57;27.03;5.76;9.16;8.66;17.18;3.69;33.53;15.07;20.48;10.01;8.56;10.97;8.82 1991-10-08;6.24;4.98;18.25;23.71;9.38;2.75;14.2;16.22;24.49;14.33;5.49;22.88;5.84;5.97;7.67;1.2;24.35;27.67;5.79;9.19;8.66;17.2;3.72;34.06;15.15;19.99;10.21;8.64;11.09;8.9 1991-10-09;6.34;4.95;18.12;23.41;9.15;2.69;14.12;16.22;24.12;14.15;5.36;22.21;5.71;5.8;8.57;1.2;24.16;27.47;5.64;9.12;8.54;17.11;3.73;33.77;14.84;20.02;9.91;8.56;10.85;8.8 1991-10-10;6.41;4.89;18.19;23.77;9.17;2.77;14.09;16.17;24.49;14.36;5.51;22.73;5.82;5.86;8.2;1.31;24.78;27.62;5.76;9.14;8.66;17.11;3.74;34.44;15.02;20.36;10.12;8.56;11.03;8.9 1991-10-11;6.38;4.98;18.19;23.29;9.12;2.79;13.93;16.22;24.85;14.33;5.45;22.43;5.77;5.8;8.44;1.3;24.81;27.72;5.88;9.14;8.75;17.3;3.73;34.48;15.26;20.27;10.17;8.64;11.09;9.02 1991-10-14;6.33;4.95;18.56;23.59;9.22;2.82;14.15;16.88;25.57;14.5;5.54;22.73;5.84;5.95;8.41;1.33;25.16;28.16;5.97;9.2;8.85;17.5;3.84;34.67;15.45;20.42;10.24;8.79;11.26;9.04 1991-10-15;6.35;5.07;18.99;23.83;9.23;2.83;13.98;17.02;25.86;14.5;5.73;22.43;6.04;5.94;8.44;1.38;25.9;28.46;6.4;9.29;8.88;17.55;3.81;34.96;15.66;20.48;10.37;8.79;11.41;9 1991-10-16;6.67;5.13;19.29;24.26;9.44;2.86;13.9;17.25;26.44;14.42;5.84;22.13;6.24;6.08;8.6;1.41;25.25;29.84;6.34;9.37;8.97;17.55;3.78;35.1;15.55;20.27;10.3;8.64;11.44;9.2 1991-10-17;6.71;5.07;19.23;24.26;9.72;2.88;13.9;17.16;26.3;14.53;5.86;22.28;6.1;6.12;8.52;1.36;24.81;29.15;6.1;9.51;9.07;17.45;3.72;35.24;15.42;20.3;10.37;8.71;11.44;9.14 1991-10-18;6.68;4.95;19.23;24.26;9.95;2.86;14.01;17.39;26.44;14.65;5.85;22.51;6.17;6.13;8.65;1.37;24.94;29.74;6.16;9.62;9.25;17.72;3.75;35.48;15.42;20.27;10.56;9.47;11.56;9.33 1991-10-21;6.67;4.77;18.93;24.19;10;2.77;13.95;17.49;26.01;14.59;5.82;22.13;6.16;6.12;8.62;1.34;24.91;29.59;6.13;9.4;8.94;17.65;3.79;35.43;15.18;20.15;10.6;9.59;11.56;9.26 1991-10-22;6.67;4.92;18.93;23.95;10.03;2.79;13.87;17.25;26.08;14.56;5.83;21.91;6.21;6.2;8.65;1.34;24.47;30.04;6.16;9.86;8.69;17.52;3.81;35.15;14.68;19.72;10.56;9.67;11.09;9.34 1991-10-23;6.58;5.04;18.93;24.01;9.97;2.76;13.93;17.2;26.3;14.5;5.9;21.02;6.24;6.06;8.65;1.33;24.47;30.04;6.01;9.97;8.69;17.77;3.76;34.72;14.57;19.72;10.4;9.62;10.94;9.39 1991-10-24;6.51;4.92;18.62;23.89;9.82;2.79;13.87;17.34;26.44;14.42;5.83;21.24;6.28;5.95;8.49;1.32;24.41;29.25;5.85;9.82;8.63;17.78;3.76;34.1;14.7;19.57;10.3;9.59;10.91;9.28 1991-10-25;6.46;4.59;18.74;23.59;9.72;2.76;14.01;17.25;26.59;14.45;5.66;21.24;6.19;6.01;8.52;1.32;24.35;29.4;5.88;9.82;8.51;17.55;3.73;34.1;14.81;19.96;10.37;9.49;10.91;9.21 1991-10-28;6.49;4.56;19.05;23.95;9.82;2.87;14.34;17.67;26.22;14.71;5.75;21.17;6.19;6.11;8.49;1.33;24.41;29.59;6.01;9.99;8.63;18.02;3.76;34.82;14.73;20.33;10.6;9.49;11.2;9.29 1991-10-29;6.54;4.5;19.11;24.07;9.74;2.88;14.51;17.53;25.79;14.68;5.81;21.17;6.3;6.06;8.76;1.36;24.57;29.74;6.07;10.06;8.85;17.9;3.78;34.82;14.68;20.6;10.81;9.69;11.2;9.45 1991-10-30;6.67;4.65;18.99;23.77;9.77;2.91;14.78;17.67;26.08;14.56;5.74;21.17;6.33;6.2;8.76;1.36;24.91;30.28;6.1;10.07;8.75;17.87;3.94;34.67;14.7;20.45;10.93;9.77;11.11;9.38 1991-10-31;6.66;4.53;19.17;23.89;9.82;2.94;14.73;17.86;26.15;14.53;5.65;20.87;6.21;6.27;8.81;1.26;24.41;29.99;6.07;10.06;8.63;18.42;3.91;34.58;14.84;20.45;11.06;9.77;10.91;9.3 1991-11-01;6.62;4.56;19.05;24.07;9.67;2.92;14.62;17.49;25.93;14.42;5.6;20.5;6.16;6.22;8.7;1.3;24.44;29.84;6.07;10.09;8.6;18.29;3.86;34.72;14.65;20.39;11.11;9.79;10.85;9.42 1991-11-04;6.58;4.45;18.99;23.95;9.92;2.92;14.56;17.39;26.15;14.68;5.61;20.35;6.16;6.24;8.65;1.27;24.1;29.4;5.94;10.22;8.63;18.39;3.79;34.29;14.52;20.3;10.95;9.77;10.91;9.27 1991-11-05;6.63;4.42;18.86;23.95;9.87;2.94;14.45;17.44;25.86;14.47;5.57;20.13;5.99;6.27;8.73;1.31;24.01;29.84;6.04;10.18;8.66;18.52;3.91;34.1;14.52;20.36;10.9;9.59;10.94;8.91 1991-11-06;6.58;4.39;18.93;23.95;9.85;2.93;14.51;17.81;25.86;14.56;5.61;20.5;6.04;6.34;8.92;1.3;24.01;29.59;6.13;10.14;8.72;18.44;3.97;34.2;14.57;20.42;11.04;9.84;11.06;8.85 1991-11-07;6.66;4.39;18.99;23.95;9.92;2.97;14.51;17.95;26.37;14.45;5.61;20.65;5.97;6.57;8.92;1.34;24.81;29.4;6.22;10.17;8.75;18.44;3.95;34.34;14.7;20.33;11.18;9.79;11.53;8.97 1991-11-08;6.61;4.42;18.8;23.65;9.9;2.98;14.51;18.02;26.08;14.33;5.63;20.2;5.93;6.53;8.89;1.34;24.91;29;6.13;10.15;8.85;18.27;3.97;34.67;14.73;20.21;11.18;10.04;11.56;8.99 1991-11-11;6.58;4.56;18.86;24.01;9.82;2.97;14.67;17.97;26.51;14.36;5.61;19.39;6;6.59;8.81;1.34;24.88;29.15;6.01;10.36;8.82;18.19;4.06;34.77;14.78;20.3;11.06;10.02;11.68;8.97 1991-11-12;6.49;4.68;18.86;23.77;9.82;2.99;14.81;17.97;28.11;14.36;5.66;19.54;6.19;6.74;8.92;1.34;24.69;28.9;6.13;10.52;8.82;18.76;4.16;35.15;14.94;20.6;11.16;9.97;12;8.84 1991-11-13;6.5;4.59;18.86;23.89;9.82;2.94;15;17.92;28.69;14.36;5.7;20.5;6.14;6.68;9.02;1.34;24.57;29.4;6.1;10.42;8.82;19.13;4.21;35.24;14.94;20.57;11.11;10.07;11.91;8.64 1991-11-14;6.5;4.74;18.99;23.71;9.18;2.83;15.11;17.73;28.54;14.24;5.76;20.06;6.19;6.68;9.18;1.34;24.85;29.2;6.1;10.5;8.85;19.41;4.14;34.86;14.89;20.67;11.11;10.02;11.94;8.76 1991-11-15;6.26;4.45;18.31;21.89;9.03;2.8;14.31;16.93;26.8;13.64;5.52;18.72;5.88;6.35;8.68;1.27;23.91;28.02;5.85;10.01;8.48;18.39;3.96;33.44;14.49;19.93;10.76;9.94;11.17;8.53 1991-11-18;6.3;4.53;18.25;22.19;8.85;2.9;14.84;17.12;27.75;13.88;5.62;19.02;5.68;6.6;8.73;1.3;24.16;28.43;5.79;10.27;8.69;18.94;4.05;33.98;14.6;20.15;10.83;9.83;11.35;8.53 1991-11-19;5.99;4.5;17.63;22.13;8.72;2.8;14.67;16.98;27.46;14.06;5.58;18.79;5.87;6.39;8.6;1.3;23.98;27.64;5.58;10.11;8.54;18.64;4.01;33.98;14.47;19.87;10.65;9.65;11.2;8.35 1991-11-20;6.12;4.47;18;21.77;8.57;2.81;14.7;17.12;26.95;13.91;5.49;18.2;5.88;6.45;8.36;1.28;23.73;27.49;5.64;10.01;8.35;19.46;4.02;33.59;14.36;19.75;10.79;9.78;11.14;8.41 1991-11-21;6.21;4.5;18.25;21.41;8.47;2.86;15.2;16.88;27.02;14;5.47;18.5;5.94;6.53;8.33;1.28;23.7;27.64;5.55;10.11;8.48;19.39;4.05;33.26;14.52;19.69;10.93;9.5;11.14;8.37 1991-11-22;6.11;4.45;17.88;21.16;8.34;2.8;15.36;16.79;26.95;13.76;5.44;18.35;5.88;6.55;8.22;1.27;23.54;27.29;5.48;10.07;8.38;19.34;4;32.92;14.47;19.35;10.58;9.45;11.11;8.29 1991-11-25;6.05;4.53;18;21.59;8.13;2.73;15.19;16.93;26.8;13.85;5.39;18.05;5.97;6.45;8.3;1.25;23.63;26.79;5.45;10.01;8.38;19.49;3.98;32.92;14.47;19.81;10.56;9.58;11.26;8.27 1991-11-26;6.07;4.62;17.88;21.47;7.98;2.75;15.64;16.88;27.46;13.88;5.39;18.64;6.11;6.55;8.33;1.27;24.32;26.64;5.42;9.98;8.48;19.23;3.94;33.35;14.76;19.9;10.6;9.68;11.47;8.22 1991-11-27;5.96;4.53;17.82;21.41;8.16;2.67;15.5;17.02;27.24;13.91;5.37;18.35;6;6.56;8.33;1.28;23.42;26.74;5.3;10.17;8.41;19.31;3.97;33.45;14.41;19.96;10.56;9.73;11.47;8.2 1991-11-29;6.15;4.53;17.94;21.47;8.44;2.64;15.39;16.79;27.31;13.97;5.3;18.27;5.93;6.63;8.3;1.27;22.98;26.5;5.18;10.23;8.35;19.65;4.05;33.26;14.33;19.81;10.63;9.65;11.53;8.2 1991-12-02;6.08;4.59;17.88;21.77;8.88;2.67;15.94;17.17;27.46;14.15;5.39;18.42;6.04;6.78;8.38;1.3;22.92;27.39;5.36;10.49;8.51;19.97;4.22;33.45;14.57;20.15;10.67;9.43;11.73;8.39 1991-12-03;6.24;4.53;18;21.59;8.59;2.69;15.86;17.02;27.53;13.94;5.29;17.9;5.97;6.82;8.33;1.29;22.67;26.84;5.3;10.58;8.41;20.25;4.22;33.64;14.57;20.27;10.56;9.53;11.79;8.38 1991-12-04;6.15;4.45;18.06;20.07;8.57;2.66;15.89;17.26;27.97;13.79;5.2;17.75;5.93;6.83;8.41;1.29;22.36;26.4;5.21;10.75;8.41;20.3;4.25;33.64;14.44;20.33;10.63;9.5;11.88;8.33 1991-12-05;6.08;4.47;18.25;20.43;8.41;2.63;16.05;16.93;27.39;13.61;5.11;17.31;6.07;6.82;8.41;1.28;22.42;26.15;4.96;10.62;8.35;20.14;4.24;33.59;14.39;20.24;10.47;9.38;12.01;8.28 1991-12-06;6.18;4.5;18.37;20.86;8.13;2.65;15.86;17.02;26.95;13.61;5.23;17.23;6.07;7.03;8.28;1.3;22.11;25.4;4.93;10.9;8.54;20.35;4.34;33.45;14.36;20.36;10.51;9.4;12.25;8.26 1991-12-09;6.03;4.45;18.31;20.86;8.11;2.65;16.05;17.02;27.09;13.37;5.31;16.42;6.07;7;8.33;1.31;21.15;25.11;4.87;10.73;8.6;20.4;4.25;33.45;14.52;20.15;10.65;9.38;12.16;8.23 1991-12-10;5.83;4.47;18.43;20.56;8.06;2.63;15.89;16.98;26.8;13.43;5.32;16.94;6.11;7.14;8.12;1.34;21.43;25.45;4.75;11.08;8.63;20.32;4.24;33.26;14.68;20.18;10.81;9.35;12.22;8.19 1991-12-11;5.96;4.42;18.49;20.43;7.98;2.64;16;17.02;27.17;13.52;5.39;16.56;6.11;7.1;8.12;1.32;21.8;25.16;4.65;10.9;8.51;20.15;4.2;32.87;14.66;20.21;10.86;9.48;12.16;8.17 1991-12-12;6.03;4.45;18.68;20.74;8.26;2.64;15.92;17.07;26.51;13.73;5.46;16.71;6.1;7.1;8.12;1.35;22.02;25.3;4.93;11.02;8.6;20.12;4.25;33.5;14.84;20.3;11.09;9.6;12.22;8.33 1991-12-13;6.03;4.47;18.8;20.86;8.29;2.67;15.97;16.88;26.8;13.82;5.56;16.94;6.14;7.18;8.14;1.38;21.86;25.75;5.06;11.1;8.69;20.08;4.25;33.4;15.06;20.51;11.25;9.78;12.42;8.48 1991-12-16;6.07;4.42;18.62;20.98;8.29;2.71;16.28;16.74;26.58;13.79;5.55;16.94;6.11;7.14;8.09;1.4;21.58;25.75;5.06;11.28;8.91;20.22;4.26;33.45;15.22;20.73;11.13;9.58;12.54;8.54 1991-12-17;5.88;4.39;18.74;20.56;8.18;2.71;16.58;16.55;26.44;13.82;5.6;16.56;6.04;7.04;7.96;1.38;21.24;25.3;4.84;11.32;8.97;20.4;4.24;33.35;15.24;20.79;10.99;9.43;12.57;8.46 1991-12-18;5.94;4.33;18.86;20.37;8.08;2.7;16.61;16.88;26.58;13.88;5.59;16.49;6.13;7.07;7.8;1.4;21.43;25.06;4.81;11.28;9.03;20.51;4.29;33.5;15.4;20.79;11.02;9.53;12.54;8.57 1991-12-19;6.09;4.36;18.99;20.62;7.98;2.69;16.64;17.17;26.29;14;5.58;15.97;5.91;6.94;7.88;1.32;21.09;24.91;4.84;11.32;9.1;20.69;4.28;34.12;15.48;20.97;11.2;9.5;12.42;8.5 1991-12-20;6.24;4.39;19.17;21.1;8.01;2.74;16.83;17.02;26;14.09;5.71;16.34;6.04;7.01;8.06;1.32;21.3;25.06;5.03;11.52;9.25;20.86;4.3;34.26;15.48;21.12;11.62;9.83;12.6;8.3 1991-12-23;6.51;4.53;19.17;22.38;8.49;2.91;17.47;17.17;26.51;13.94;5.9;17.31;6.34;7.11;8.12;1.37;21.93;26.79;5.22;11.76;9.41;21.57;4.45;34.55;15.7;21.43;12.1;10.46;13.04;8.59 1991-12-24;6.75;4.71;19.05;22.01;8.59;2.97;17.69;17.36;26.8;13.7;6.05;17.53;6.37;7.15;8.76;1.41;21.93;27.39;5.32;11.73;9.75;21.42;4.43;35.08;15.8;21.43;11.82;10.64;12.84;8.7 1991-12-26;6.72;4.95;19.05;22.74;8.88;3.07;17.88;17.17;27.24;13.67;6.15;17.01;6.76;7.21;8.78;1.48;21.93;27.09;5.47;11.95;9.81;22.12;4.49;35.17;16.26;21.83;11.78;10.64;13.13;8.65 1991-12-27;6.87;5.07;19.23;22.38;8.7;3.18;17.8;17.4;27.17;13.88;6.06;16.49;6.64;7.37;8.81;1.48;22.21;27.39;5.63;12.08;9.65;22.29;4.6;34.93;16.47;22.1;11.66;10.59;13.34;8.87 1991-12-30;6.75;5.07;19.42;22.56;8.75;3.17;18.02;17.5;27.97;13.94;6.3;16.94;6.94;7.62;9.42;1.52;22.45;28.13;5.82;12.26;9.75;22.41;4.61;36.04;17.19;22.93;11.85;10.95;13.87;8.99 1991-12-31;6.76;4.95;19.3;23.16;8.98;3.18;17.8;17.64;28.27;14.5;6.27;17.16;7.02;7.41;9.37;1.52;22.11;28.08;5.29;12.16;9.44;22.44;4.64;36.52;17.11;22.96;11.89;11;13.9;8.96 1992-01-02;6.72;5.01;19.36;22.92;8.93;3.18;17.8;17.59;28.85;14.3;6.28;18.42;6.88;7.54;8.97;1.56;22.42;27.79;5.82;11.92;9.75;22.43;4.75;36.52;16.98;22.74;11.98;10.77;13.96;9.07 1992-01-03;6.79;4.98;19.54;22.86;8.9;3.18;18.47;17.5;28.41;14.33;6.25;19.31;6.94;7.66;9.08;1.55;22.45;28.13;5.94;11.87;9.78;22.76;4.71;36.42;16.95;22.62;12.05;10.9;13.63;9.32 1992-01-06;6.74;5.19;19.79;22.98;8.93;3.17;18.41;17.21;28.63;14.21;6.22;19.91;6.93;7.65;9.21;1.53;22.92;28.38;6.16;11.97;10;22.54;4.85;36.71;16.92;22.47;12.02;10.52;13.4;9.4 1992-01-07;6.74;5.16;20.22;23.35;8.98;3.15;18.24;17.45;28.93;14.12;6.18;19.61;6.9;7.6;9.29;1.6;23.51;28.58;6.25;12.13;10.21;22.48;5;37.19;16.92;22.47;11.95;10.34;13.34;9.41 1992-01-08;6.75;5.25;20.16;23.71;8.93;3.13;17.91;17.55;28.78;13.94;6.17;19.09;7.14;7.54;9.53;1.62;22.95;28.38;6.53;12.36;10.21;22.48;5.18;36.61;17.08;22.5;11.91;10.29;13.46;9.61 1992-01-09;6.62;5.37;20.28;23.83;8.93;3.16;17.75;17.59;28.27;13.85;6.09;19.09;7.39;7.43;9.77;1.66;22.67;28.08;6.84;12.33;10.65;22.44;5.3;36.04;17.24;22.62;11.91;10.69;13.46;10.04 1992-01-10;6.59;5.31;20.22;23.47;8.82;3.13;17.58;17.5;28.19;14;6.1;18.87;7.21;7.47;9.58;1.64;22.58;27.69;6.72;12.21;10.43;21.97;5.22;36.37;17.03;22.93;11.74;10.9;13.37;10 1992-01-13;6.49;5.28;20.22;23.71;8.54;3.12;17.5;17.5;28.12;14.12;6.16;18.42;7.25;7.63;9.56;1.66;22.42;27.39;6.72;12.21;10.43;21.58;5.3;36.47;16.9;23.02;11.72;10.82;13.66;9.94 1992-01-14;6.57;5.59;20.16;24.62;8.75;3.29;17.69;17.83;28.71;14.36;6.25;19.02;7.48;7.8;9.72;1.69;22.95;27.64;7.06;12.07;10.68;21.58;5.34;37.38;17.03;23.69;11.65;10.77;13.93;10.25 1992-01-15;7.05;5.37;20.16;25.16;9.27;3.25;17.08;18.11;28.85;14.18;6.32;19.09;7.79;7.77;9.96;1.74;23.7;28.63;7.49;11.51;10.49;21.05;5.48;37.19;16.74;23.29;11.37;11.05;13.84;10.45 1992-01-16;7.14;5.34;19.79;25.16;9.68;3.24;16.41;18.54;28.56;14.09;6.39;20.43;7.73;7.52;9.96;1.9;23.73;28.88;7.4;11.11;10.15;20.78;5.32;37.04;16.34;22.65;11.32;11.15;13.69;10.34 1992-01-17;7.25;5.41;20.1;25.1;9.75;3.31;16.44;19.11;28.63;14.27;6.51;20.13;7.64;7.33;9.88;1.94;23.94;28.98;7.12;11.39;10.18;20.72;5.27;37.62;16.36;22.07;11.49;11.48;13.48;10.38 1992-01-20;7.26;5.28;19.85;24.68;9.91;3.34;16.11;18.82;29.07;14.3;6.59;20.13;7.56;7.14;9.9;1.91;23.67;28.88;6.97;11.15;10.31;20.69;5.1;37.38;16.47;22.35;11.35;11.2;13.16;10.31 1992-01-21;6.96;5.16;19.73;24.01;9.6;3.34;16.28;18.82;28.71;14.5;6.39;19.46;7.24;6.79;9.96;1.85;23.08;28.68;6.94;11.06;10.52;20.42;4.97;37.24;16.58;22.62;11.51;10.95;12.87;10.12 1992-01-22;7.06;5.37;19.91;25.16;9.63;3.4;16.61;18.63;28.93;14.18;6.51;19.61;7.36;7.22;9.9;1.9;23.76;28.58;6.87;11.42;10.71;20.88;5.23;36.8;16.63;23.45;11.6;10.9;13.34;10.33 1992-01-23;6.96;5.34;19.48;25.29;9.63;3.41;16.53;18.21;28.78;14.06;6.47;19.39;7.48;7.08;9.77;1.92;23.23;28.48;6.9;11.32;10.59;20.89;5.21;35.8;16.36;23.97;11.46;10.29;13.1;10.24 1992-01-24;6.97;5.37;18.93;25.53;9.6;3.38;16.61;18.25;28.56;14.36;6.42;19.46;7.3;7.08;9.85;1.94;23.14;28.88;7.03;11.39;10.65;20.69;5.19;35.75;16.31;24.03;11.46;10.34;13.37;10.44 1992-01-27;7.04;5.47;18.74;26.38;9.75;3.33;16.39;18.25;28.78;14.42;6.41;20.28;7.45;7;9.88;1.91;23.29;29.52;7.12;11.28;10.56;20.49;5.03;35.94;16.34;23.75;11.53;10.29;13.19;10.39 1992-01-28;7.08;5.44;18.68;26.01;9.6;3.4;16.28;18.44;28.41;14.39;6.4;20.43;7.39;6.94;10.14;1.95;23.17;30.22;7.15;11.2;10.8;20.62;5.03;36.09;16.26;25.1;11.53;10.31;13.07;11.1 1992-01-29;7.01;5.19;18.62;24.56;9.52;3.26;15.86;18.25;28.27;14.15;6.34;19.46;7.39;6.86;10.36;1.88;22.83;29.57;6.87;10.96;10.49;20.54;5.19;36.09;16.15;25.47;11.37;9.93;12.95;10.88 1992-01-30;6.97;5.25;18.49;25.59;9.6;3.33;17.11;18.02;28.93;14.06;6.27;19.46;7.42;6.82;10.39;1.88;22.8;29.47;7.03;11.26;10.99;20.93;5.15;35.65;16.39;25.25;11.44;10.19;12.84;10.88 1992-01-31;6.78;4.98;18.37;24.68;9.6;3.35;17.19;17.59;29.58;13.88;6.16;19.24;7.3;6.78;10.57;1.86;22.36;28.68;6.97;11.42;10.8;21.18;5.01;34.89;16.28;25.37;11.23;10.29;12.72;10.7 1992-02-03;6.82;5.37;18.25;24.68;9.6;3.26;17.5;17.4;29.22;14.09;6.23;20.2;7.41;7;10.52;1.86;22.7;28.73;7.03;11.26;10.9;20.81;5.21;34.98;16.36;24.67;11.18;10.26;12.92;10.97 1992-02-04;6.85;5.31;18.56;24.5;9.81;3.28;17.52;18.16;29.73;14.18;6.3;20.8;7.7;7.07;10.52;1.95;22.92;29.17;7.21;11.42;10.8;21.42;5.19;35.51;16.42;24.92;11.3;10.29;13.1;11.11 1992-02-05;6.77;5.22;18.56;24.38;9.88;3.31;17.33;17.83;27.24;13.82;6.35;20.72;7.67;7.14;10.57;1.95;22.67;29.03;7.37;11.47;10.83;21.31;5.3;35.56;16.52;25.43;11.37;10.03;13.07;11.16 1992-02-06;6.72;5.19;18.43;24.19;10.06;3.31;17.44;18.25;27.39;13.97;6.35;21.17;7.61;7.18;10.65;1.94;22.33;29.27;7.59;11.47;10.8;21.03;5.26;35.46;16.63;24.79;11.23;10.31;12.92;11.02 1992-02-07;6.77;5.19;18.19;24.07;9.75;3.27;17.33;18.21;27.46;13.94;6.33;20.43;7.7;7.08;10.52;2;22.17;28.88;7.65;11.27;10.87;20.69;5.24;34.93;16.15;24.61;10.93;10.34;12.87;10.95 1992-02-10;6.89;5.19;18.43;23.29;10.24;3.34;17.47;18.08;27.39;13.91;6.34;20.96;7.74;7.12;10.63;2.03;22.3;29.08;7.99;11.31;10.77;20.72;5.19;35.27;15.99;24.61;11.16;10.24;12.89;11.27 1992-02-11;6.97;5.25;18.62;22.8;10.11;3.29;17.25;17.84;27.9;13.85;6.31;21.26;7.64;7.11;10.68;2.04;22.42;29.17;7.87;11.13;10.68;20.74;5.1;35.51;15.86;24.52;11.35;10.41;12.84;11.4 1992-02-12;7.05;5.34;18.74;22.62;10.42;3.31;17.41;18.03;27.75;14;6.38;21.56;7.9;7.14;10.76;2.11;22.89;29.22;8.12;11.29;10.9;20.71;5.24;35.56;16.12;24.7;11.39;10.69;12.78;11.32 1992-02-13;6.94;5.22;18.74;22.62;10.29;3.28;17.19;18.13;27.61;13.88;6.34;22.01;7.96;7.01;10.84;2.13;22.55;29.37;8.09;10.97;10.83;20.35;5.1;35.27;15.88;24.55;11.21;10.49;12.78;11.1 1992-02-14;7.17;5.19;19.05;22.38;10.4;3.23;17.08;18.22;27.39;13.88;6.32;22.91;7.84;6.88;10.92;2.09;22.3;29.54;8.05;10.77;10.65;19.98;4.94;35.68;15.99;24.46;11.18;10.36;12.6;11.21 1992-02-18;7.46;5.19;18.56;22.5;10.52;3.2;16.83;17.75;27.02;13.61;6.32;22.61;7.93;6.67;10.89;2;22.27;29.54;8.02;10.41;10.28;19.68;4.93;35.77;15.64;24.03;10.91;10.29;12.13;11.49 1992-02-19;7.58;5.1;18.8;22.38;10.81;3.22;17.08;17.84;26.95;13.64;6.42;23.06;9.05;6.72;10.7;1.98;22.27;30.14;7.87;10.51;10.18;19.43;4.8;35.53;15.78;24.18;10.95;10.14;12.3;11.42 1992-02-20;7.51;5.19;18.68;22.44;10.73;3.25;17.55;18.03;27.17;13.82;6.58;23.44;9.44;6.89;10.81;2.05;22.3;31.04;8.09;10.63;10.46;19.85;4.9;36.21;15.91;24.61;10.95;10.54;12.57;11.9 1992-02-21;7.38;5.16;18.56;22.74;10.42;3.26;17.55;18.42;27.31;13.79;6.58;23.06;9.3;6.78;10.68;2.11;22.33;31.04;8.33;10.61;10.65;19.71;4.77;36.26;15.99;25.01;10.7;10.49;12.3;11.99 1992-02-24;7.42;5.16;18.43;22.8;10.58;3.15;17.63;17.99;27.02;13.73;6.57;22.69;9.18;6.79;10.62;2.03;22.21;30.54;8.43;10.74;10.74;20.15;4.79;35.92;16.04;24.92;10.77;10.28;12.22;12.1 1992-02-25;7.22;5.1;18.31;22.44;10.27;3.19;17.66;17.94;27.17;13.64;6.5;21.94;8.99;6.85;10.33;1.98;21.93;30.04;8.21;10.77;10.56;20.56;4.82;35.87;16.12;24.61;10.74;10.3;12.16;12.01 1992-02-26;7.31;5.01;18.31;22.25;10.34;3.33;18.19;17.65;26.87;13.73;6.5;22.09;9.12;7.08;10.38;2.04;21.93;29.64;8.24;11.03;10.18;21.38;5.08;36.01;16.39;24.7;11.02;10.38;12.72;12.21 1992-02-27;7.34;5.04;18.25;22.13;10.09;3.35;18.11;17.75;26.8;13.64;6.46;21.71;9.21;7.14;10.41;2;21.8;29.84;8.4;10.97;10.15;21.35;5.2;35.48;16.31;24.92;11.12;10.38;12.92;12.09 1992-02-28;7.34;5.07;18.31;22.31;10.04;3.35;18.13;17.65;26.43;13.61;6.44;22.54;8.99;7.04;10.65;1.97;21.58;29.49;8.37;10.79;10.06;21.25;5.15;35.19;16.36;24.85;11.23;10.3;12.75;12.06 1992-03-02;7.48;5.01;18.12;22.5;10.45;3.31;18.05;17.27;26.5;13.34;6.51;22.76;9.16;7.04;10.73;2.04;21.74;29.89;8.27;10.75;10.24;21.24;5.12;35.14;16.31;24.82;11.14;10.56;12.75;12.11 1992-03-03;7.8;5.07;18.25;22.74;10.37;3.37;18.08;17.32;26.58;13.25;6.43;22.61;9.35;7.01;11.05;2.02;21.93;30.04;8.27;10.63;10.18;20.83;5.14;35;16.23;25.01;11.23;10.91;12.57;12.14 1992-03-04;7.66;5.13;18.56;22.92;10.47;3.39;17.86;17.03;26.21;13.1;6.36;22.46;9.52;6.93;10.79;1.98;21.71;30.24;8.12;10.42;10.12;20.48;5.1;34.9;16.07;24.85;11.07;10.81;12.28;12.17 1992-03-05;7.46;5.16;18.49;22.62;10.24;3.35;17.83;16.94;25.84;13.25;6.37;22.24;9.36;6.88;10.57;1.97;21.52;29.89;7.84;10.37;9.93;20.48;5.05;34.76;15.88;24.4;10.84;10.61;12.57;12.18 1992-03-06;7.35;5.19;18.62;22.38;10.16;3.25;17.5;16.79;25.69;13.25;6.35;22.16;9.1;6.75;10.52;1.94;21.46;29.59;7.74;10.25;9.93;20.31;4.93;34.95;16.05;24.24;10.81;10.45;12.48;12.17 1992-03-09;7.18;5.31;18.68;21.77;10.09;3.23;17.84;16.7;25.47;13.22;6.35;22.46;9.25;6.72;10.44;1.94;21.71;29.24;8.12;10.45;9.97;20.49;4.96;35.14;16.32;24.15;10.95;10.38;12.42;11.89 1992-03-10;7.15;5.28;18.99;21.95;9.91;3.23;18.09;16.79;25.24;13.19;6.37;22.46;9.44;6.78;10.65;2;21.83;29.34;8.05;10.3;9.93;20.6;5.07;35.1;16.51;24.3;10.84;10.63;12.45;11.89 1992-03-11;7.09;5.19;18.86;21.77;9.81;3.21;18;16.79;25.1;13.19;6.32;22.46;9.39;6.74;10.57;1.94;21.8;29.04;7.96;10.26;10.34;20.36;5.01;34.71;16.45;24.09;10.77;10.51;12.36;11.65 1992-03-12;7.05;5.07;18.68;21.71;9.75;3.19;18.06;16.84;25.1;13.46;6.32;22.76;9.41;6.82;10.33;1.99;22.14;29.29;7.84;10.23;10.62;19.97;5.05;34.52;16.59;24.12;10.72;10.61;12.48;11.55 1992-03-13;7.31;5.13;18.86;21.71;10.06;3.21;18.11;16.98;25.24;13.61;6.39;22.31;9.53;6.89;10.41;1.99;22.27;29.69;7.99;10.23;10.59;20;5.04;34.81;16.72;24.18;10.84;10.58;12.36;11.68 1992-03-16;7.54;5.16;18.8;21.83;9.99;3.21;18.2;16.98;24.13;13.55;6.39;22.31;9.52;7.14;10.38;2.03;22.05;29.69;8.02;10.37;10.56;19.97;5.18;34.71;16.86;24.09;10.88;10.74;12.54;11.76 1992-03-17;7.56;5.31;19.3;21.95;9.88;3.19;18.34;17.32;23.76;13.55;6.44;22.61;9.72;7.26;10.68;2.04;21.77;29.74;8.3;10.38;10.65;20.27;5.33;35;16.91;24.43;10.95;10.66;12.7;11.82 1992-03-18;7.43;5.31;19.42;22.19;10.19;3.21;18.11;17.22;23.91;13.28;6.43;22.99;9.84;7.19;10.68;2.07;21.74;30.44;8.37;10.25;10.99;20.04;5.27;34.85;16.64;24.24;10.84;10.79;12.58;11.87 1992-03-19;7.44;5.34;19.66;21.95;10.19;3.2;17.95;17.41;23.99;13.19;6.4;23.06;9.95;7.21;10.6;2.04;21.34;31.14;8.61;10.26;10.8;20.07;5.31;34.81;16.51;24.3;10.91;10.91;12.55;11.88 1992-03-20;7.44;5.37;20.03;21.65;10.22;3.18;18.03;17.6;24.06;13.05;6.44;23.51;10.16;7.22;11.24;2.02;21.4;30.69;8.8;10.23;10.71;19.92;5.35;34.9;16.56;24.58;10.93;10.97;12.58;11.75 1992-03-23;7.46;5.37;19.97;21.28;10.16;3.17;18.2;17.89;23.99;13.16;6.4;23.21;10.24;7.25;11.38;1.97;21.27;30.89;8.65;10.09;10.59;19.94;5.35;34.56;16.45;24.46;10.91;11.02;12.43;11.75 1992-03-24;7.52;5.56;19.73;21.1;10.09;3.23;18.14;18.03;23.91;13.13;6.37;22.46;10.32;7.25;11.46;1.9;21.18;30.64;8.55;10.33;10.43;20.31;5.31;34.71;16.35;24.58;10.88;10.81;12.55;11.6 1992-03-25;7.67;5.68;20.1;21.16;10.27;3.31;18.31;17.94;23.62;13.1;6.38;22.61;10.13;7.22;11.48;1.87;21.15;30.04;8.55;10.38;10.31;20.31;5.35;34.32;16.48;24.73;10.81;10.79;12.64;11.72 1992-03-26;7.71;5.8;20.04;21.34;10.42;3.36;18.36;18.03;24.13;13.28;6.3;22.84;9.9;7.34;11.75;1.83;20.9;30.24;8.71;10.45;10.43;20.04;5.21;34.08;16.51;24.7;10.86;10.76;12.61;11.6 1992-03-27;7.5;5.62;19.91;21.22;10.27;3.26;18.42;18.22;24.13;13.13;6.24;22.09;9.85;7.25;11.27;1.72;20.68;29.54;8.61;10.26;10.18;19.75;5.05;34.13;16.32;24.46;10.79;10.63;12.58;11.59 1992-03-30;7.47;5.62;20.22;21.22;10.34;3.32;18.28;18.03;24.13;13.1;6.23;22.16;9.81;7.04;11.3;1.66;20.72;29.19;8.3;10.19;10.06;19.9;5;34.32;16.18;24.49;10.79;10.81;12.52;11.81 1992-03-31;7.46;5.59;20.1;21.28;10.27;3.25;18.2;18.18;24.06;13.05;6.21;22.01;9.92;7.12;10.84;1.72;20.75;29.39;8.22;10.39;9.9;19.92;4.94;34.32;16.27;25.01;10.7;10.63;12.58;11.89 1992-04-01;7.44;5.59;19.91;21.95;10.14;3.22;18.25;18.03;24.5;13.13;6.26;22.31;9.87;7.08;10.73;1.73;20.59;29.44;8.19;10.46;10.06;20.26;5.02;34.08;16.4;25.04;10.81;10.68;12.52;12.09 1992-04-02;7.46;5.49;19.97;21.95;10.11;3.1;18;17.75;23.91;13.05;6.16;21.86;9.98;6.88;11.13;1.72;20.44;29.19;7.91;10.34;10.09;19.94;4.88;33.98;16.48;24.79;10.7;10.79;12.29;12.27 1992-04-03;7.19;5.43;20.71;21.89;10.29;3.11;18.48;17.8;23.69;13.31;6.13;21.79;9.85;6.9;11.03;1.7;20.31;28.79;7.78;10.5;10.28;20.02;4.9;34.18;16.61;24.95;10.74;10.66;12.2;12.42 1992-04-06;7.33;5.62;20.59;21.71;10.27;3.17;18.56;18.42;23.69;13.76;6.2;22.01;9.96;7.12;11.16;1.8;20.65;28.89;8.06;10.41;10.46;20.22;5.05;34.13;16.72;24.64;10.97;10.66;12.49;12.48 1992-04-07;7.23;5.46;20.71;21.22;10.14;3.06;18;17.7;23.1;13.49;6.07;22.76;9.75;6.94;11.03;1.75;20.47;28.54;7.69;10.22;10.37;19.85;4.83;33.55;16.35;23.91;10.88;10.68;12.2;12.12 1992-04-08;7.09;5.4;20.16;20.98;9.86;2.99;17.81;17.94;22.8;13.64;5.97;22.61;9.52;6.92;10.92;1.79;21.09;27.54;7.41;10.27;10.31;19.83;4.89;33.6;16.18;23.63;10.72;10.68;12.14;11.75 1992-04-09;7.15;5.49;20.53;20.86;9.86;3.05;18.09;18.13;22.8;13.64;6.12;22.84;9.68;7.11;11.16;1.78;21.15;28.29;7.66;10.41;10.46;20.33;5;33.89;16.29;24.15;10.81;10.86;12.49;11.88 1992-04-10;7.19;5.46;20.65;21.77;9.99;3.12;18.34;18.08;22.95;13.73;6.23;23.21;9.24;7.08;11.54;1.59;21.37;28.19;7.97;10.74;10.4;20.63;4.83;33.98;16.56;24.4;11.07;11.04;12.49;11.99 1992-04-13;7.8;5.49;20.59;22.19;10.14;3.19;18.23;18.08;23.1;13.49;6.16;23.44;9.45;7.21;11.56;1.55;21.74;27.94;7.97;10.77;10.15;20.75;4.9;34.13;16.8;24.46;11.3;10.99;12.64;11.96 1992-04-14;7.59;5.52;21.02;22.5;10.2;3.22;18.25;18.37;23.32;13.73;6.29;23.96;9.84;7.38;11.72;1.62;21.93;28.89;8.57;10.9;10.34;21.02;4.88;35.48;16.94;25.56;11.49;10.99;12.91;11.74 1992-04-15;7.89;5.59;21.14;22.86;11.1;3.14;18.56;18.84;23.54;14.06;6.39;23.96;10.15;7.52;11.91;1.66;21.99;30.44;8.54;10.71;10.49;20.48;5.37;36.01;16.94;25.56;11.56;11.02;13.05;11.78 1992-04-16;8.11;5.62;21.14;22.92;11.02;3.2;18.5;19.18;23.91;14;6.47;25.39;10.07;7.3;12.23;1.62;22.02;30.19;8.6;10.59;10.56;20.16;5.32;35.87;16.75;25.28;11.59;11.45;12.88;11.93 1992-04-20;8.22;5.56;21.08;22.68;11.54;3.12;18.11;18.89;23.32;13.97;6.45;25.62;9.9;7.08;12.13;1.59;22.24;30.29;8.5;10.31;10.28;19.55;4.92;35.97;16.37;24.46;11.66;11.32;12.49;11.87 1992-04-21;8.05;5.49;21.33;22.5;11.28;3.09;18.09;19.32;23.47;14.09;6.37;25.54;9.55;6.99;12.18;1.57;22.36;30.24;8.72;10.23;10.15;19.63;4.84;36.84;16.27;24.58;11.61;11.35;12.43;11.9 1992-04-22;7.93;5.62;21.64;22.31;11.69;3.1;18.09;18.99;23.25;13.82;6.33;25.24;9.65;6.94;12.07;1.62;22.39;30.54;9.04;9.91;10.18;19.31;4.9;37.22;16.1;24.55;11.73;11.17;12.38;12.04 1992-04-23;7.99;5.74;21.58;22.07;11.69;3.11;18.34;19.85;23.1;14.12;6.28;25.47;9.81;6.96;12.66;1.62;22.17;30.49;9.16;9.69;10.52;18.92;4.82;36.84;16.48;24.4;11.78;11.14;12.43;11.98 1992-04-24;8.11;5.52;21.39;22.01;11.66;3.1;18.03;19.46;23.1;14.03;6.22;23.81;9.67;6.78;12.45;1.61;21.9;29.74;8.97;9.82;10.93;19.02;4.68;35.82;16.29;24.98;11.8;10.84;12.23;11.88 1992-04-27;7.83;5.34;21.45;21.83;11.46;3.12;17.89;18.99;22.88;14;6.22;24.04;9.52;6.79;12.37;1.59;21.9;28.94;9.04;9.98;10.83;19.12;4.72;35.92;16.48;25.31;11.89;10.97;12.26;11.72 1992-04-28;7.96;5.31;21.27;21.53;11.48;3.12;17.89;19.46;22.8;14.12;6.23;24.26;9.28;6.71;12.4;1.58;21.99;29.64;8.94;10.05;10.93;19.11;4.54;35.87;16.78;24.88;11.87;11.02;12.26;11.56 1992-04-29;7.94;5.4;21.33;21.28;11.54;3.21;18.17;20.09;23.69;14.12;6.21;25.47;9.85;6.81;12.58;1.62;21.9;29.39;8.91;10.07;11.15;19.46;4.64;36.16;16.83;24.61;11.78;11.02;12.29;11.66 1992-04-30;8.23;5.49;21.33;21.34;11.56;3.28;18.48;20.71;23.47;14.3;6.28;24.94;9.85;6.86;12.5;1.66;22.55;29.74;8.82;10.11;11.02;19.63;4.59;36.26;16.72;25.25;11.75;11.04;12.35;11.44 1992-05-01;8.1;5.49;21.27;21.22;11.38;3.37;18.45;20.61;23.32;14.12;6.21;24.56;9.84;6.78;12.72;1.64;22.52;29.34;8.97;10.21;10.77;19.48;4.74;35.87;16.61;25.01;11.75;11.02;12.17;11.46 1992-05-04;8.06;5.43;21.64;20.98;11.56;3.32;18.59;20.66;23.84;14.3;6.33;24.41;9.92;6.9;12.58;1.63;22.98;29.64;9.35;10.38;10.83;19.97;4.75;36.06;16.88;25.34;11.75;11.2;12.26;11.61 1992-05-05;8.03;5.49;21.7;20.74;11.02;3.29;18.42;20.47;23.47;14.27;6.31;24.34;10.07;7.04;12.48;1.69;23.32;29.24;9.48;10.35;10.87;20;4.85;36.11;16.96;24.85;11.68;10.89;12.29;11.63 1992-05-06;7.94;5.52;21.76;21.04;11.54;3.29;18.39;20.47;23.32;14.15;6.31;24.34;10.07;7;12.61;1.67;23.2;28.84;9.67;10.13;10.99;19.85;4.83;36.16;16.99;25.19;11.68;11.02;12.26;11.8 1992-05-07;8.04;5.43;21.7;21.41;11.46;3.23;18.56;20.23;23.76;13.97;6.3;23.89;9.96;7.01;12.5;1.67;23.29;28.59;9.54;10.21;11.02;20.04;4.79;35.97;16.96;25.31;11.54;10.86;12.23;11.78 1992-05-08;8.06;5.34;21.58;21.41;11.43;3.23;18.81;20.18;24.13;14.03;6.35;23.96;9.88;7.07;12.48;1.66;23.14;28.74;9.38;10.17;11.05;20.07;4.77;36.16;16.75;25.56;11.73;10.89;12.29;11.8 1992-05-11;8.31;5.56;21.27;21.34;11.82;3.22;19;20.45;23.84;14.18;6.48;23.66;9.73;7.23;12.58;1.65;23.32;28.44;9.48;10.3;11.3;20.19;4.75;36.74;16.96;25.59;11.7;11.04;12.49;11.78 1992-05-12;8.23;5.56;21.27;21.28;11.74;3.2;19.09;20.01;23.76;14.03;6.47;23.89;9.78;7.3;12.77;1.6;23.23;28.34;9.51;10.13;10.96;20.04;4.76;37.42;16.86;25.34;11.63;11.14;12.58;11.65 1992-05-13;8.28;5.65;21.14;21.28;11.61;3.17;19.48;20.45;24.65;14.18;6.42;23.96;9.61;7.25;12.69;1.59;22.95;28.64;9.7;10.19;10.93;20.02;4.7;37.32;16.78;25.4;11.7;11.09;12.49;11.93 1992-05-14;8.19;5.52;21.27;21.28;11.64;3.18;19.2;20.45;24.28;14.3;6.38;23.66;9.47;7.08;12.64;1.52;22.8;28.59;9.54;10.04;10.83;19.75;4.61;36.59;16.78;25.53;11.96;10.94;12.32;11.81 1992-05-15;8.04;5.43;21.02;21.16;11.43;3.14;19.31;20.54;24.06;14.12;6.33;23.59;9.53;7.01;12.56;1.5;22.77;28.84;9.41;9.97;10.71;19.61;4.58;36.64;16.67;25.43;11.87;10.79;12.23;12 1992-05-18;8.21;5.4;21.33;21.1;11.54;3.13;19.7;20.3;24.21;14.24;6.3;23.66;9.16;7.15;12.69;1.47;22.55;28.71;9.45;10.05;10.87;19.72;4.7;36.86;16.64;25.5;12.01;10.91;12.52;12.44 1992-05-19;8.24;5.49;21.39;21.22;11.72;3.13;20.09;20.45;24.36;14.3;6.4;23.59;9.13;7.25;12.8;1.46;22.98;28.41;9.48;10.2;11.11;20.17;4.77;37.05;16.48;25.43;12.01;11.01;12.73;12.84 1992-05-20;8.17;5.62;21.7;21.41;11.92;3.12;19.81;20.64;24.13;14.12;6.36;23.44;9.27;7.32;12.77;1.49;22.77;28.61;9.45;10.08;11.46;20.09;4.86;37.05;16.61;25.28;11.87;10.85;12.52;12.37 1992-05-21;8.16;5.56;21.08;21.41;12.23;3.11;19.76;20.45;23.84;14.21;6.29;23.44;9.44;7.29;12.53;1.48;22.73;28.36;9.35;10.07;11.61;20.04;4.86;36.71;16.51;25.28;11.66;10.88;12.32;12.09 1992-05-22;8.17;5.59;21.14;21.22;12.08;3.12;19.7;20.21;23.91;14.42;6.28;23.51;9.58;7.37;12.53;1.51;22.8;28.41;9.35;10.16;11.39;20.66;4.82;36.76;16.32;25.07;11.63;10.85;12.38;11.89 1992-05-26;8.21;5.52;20.53;21.04;12.26;3.11;19.31;20.64;23.84;15.25;6.15;22.84;9.38;7.3;12.29;1.48;22.49;28.31;9.04;9.87;11.18;20.16;4.81;36.27;15.97;24.88;11.4;10.52;12.23;11.74 1992-05-27;8.17;5.56;20.59;21.22;12.28;3.11;19.64;20.25;23.99;14.71;6.22;23.51;9.28;7.44;12.53;1.54;22.58;28.01;9.04;10.11;11.21;20.11;4.79;36.76;16.18;25.28;11.54;10.65;12.26;11.74 1992-05-28;8.27;5.59;20.96;21.34;12.28;3.11;19.81;20.3;23.76;14.77;6.32;23.59;9.39;7.6;12.39;1.57;22.64;28.06;9.01;10.42;11.55;20.71;4.96;37.05;16.53;25.31;11.47;10.78;12.61;12.01 1992-05-29;8.25;5.56;20.96;21.28;12.44;3.1;19.59;20.3;23.91;14.45;6.26;23.96;9.36;7.77;12.5;1.55;22.55;28.31;9.16;10.38;11.64;20.46;5.04;37.3;16.64;25.13;11.35;10.83;12.52;11.93 1992-06-01;8.37;5.71;20.77;21.34;12.62;3.11;19.92;20.4;23.99;14.62;6.26;25.19;9.33;7.78;12.5;1.59;22.52;28.31;9.29;10.5;11.7;20.87;5.18;37.35;16.56;25.5;11.45;10.7;12.58;12.13 1992-06-02;8.39;5.71;20.53;20.86;12.72;3.08;19.7;20.54;23.91;14.62;6.18;24.59;9.33;7.65;13.12;1.59;22.52;28.11;9.38;9.89;11.77;20.25;5.12;36.81;16.45;25.19;11.3;10.7;12.58;12.25 1992-06-03;8.49;5.92;20.53;21.16;12.69;3.06;19.59;20.16;24.14;14.98;6.23;25.34;9.22;7.74;13.07;1.6;22.3;27.61;9.48;9.65;11.52;20.25;5.12;36.71;16.43;25.4;11.3;10.78;12.88;12.29 1992-06-04;8.47;5.86;20.53;21.34;12.57;3.01;19.03;19.96;24.14;15.01;6.25;26.48;8.85;7.7;13.09;1.56;22.11;27.76;9.54;9.64;11.42;20.35;5.11;36.57;16.21;25.19;11.3;10.83;13.03;11.7 1992-06-05;8.4;5.77;20.77;21.77;12.31;3.03;19.53;19.77;24.14;14.95;6.35;26.71;8.91;7.62;13.07;1.55;22.45;27.25;9.51;9.65;11.55;20.14;5.04;37.3;15.97;24.61;11.38;10.78;12.82;11.46 1992-06-08;8.4;5.86;21.02;21.83;12.28;3.14;19.42;19.68;24.51;14.89;6.25;26.63;9.01;7.6;12.83;1.57;22.61;27;9.54;9.69;11.55;20.04;4.93;37.25;16.35;24.95;11.52;10.83;12.79;11.66 1992-06-09;8.27;5.83;20.96;21.41;12.28;3.01;19.26;19.92;24.21;15.13;6.24;26.33;8.95;7.52;12.8;1.58;22.52;26.05;9.51;9.67;11.39;19.89;4.79;36.76;16.03;24.58;11.52;10.62;12.8;11.5 1992-06-10;8.15;5.92;21.08;21.04;12.1;2.98;19.04;19.72;24.21;14.98;6.22;26.48;8.7;7.47;12.42;1.56;22.39;26.65;9.57;9.43;11.24;19.58;4.69;36.81;15.62;24.3;11.35;10.6;12.65;11.35 1992-06-11;8.06;5.83;21.14;21.47;11.69;3.02;19.09;20.01;23.84;15.07;6.29;26.1;8.87;7.58;12.47;1.55;22.86;26.65;9.51;9.67;11.05;20.09;4.5;37.15;15.65;24.3;11.63;10.44;12.74;11.54 1992-06-12;8.13;5.77;21.39;21.28;11.66;3.07;18.87;19.92;23.91;14.74;6.25;26.18;8.84;7.52;12.42;1.54;23.11;27.2;9.41;9.64;11.11;20.09;4.69;37.64;16.05;24.46;11.59;10.52;12.8;11.5 1992-06-15;8.12;5.77;21.27;21.34;11.66;3.12;18.76;20.3;23.99;14.8;6.27;26.56;8.68;7.62;12.31;1.51;23.39;26.85;9.35;9.48;11.11;19.99;4.73;37.78;15.78;24.27;11.63;10.44;12.98;11.58 1992-06-16;8.12;5.68;20.96;21.22;11.59;3.11;18.2;20.21;23.91;14.8;6.34;26.71;8.44;7.63;12.31;1.51;23.14;27.15;9.26;9.45;11.15;19.89;4.55;37.78;15.22;23.91;11.66;10.36;12.95;11.46 1992-06-17;8.19;5.65;21.02;20.92;11.05;3.02;17.59;19.92;23.69;14.8;6.23;25.27;8.05;7.38;12.26;1.48;23.01;27;8.76;9.24;11.02;19.28;4.52;37.59;15.35;22.74;11.54;10.62;12.77;11.35 1992-06-18;7.88;5.65;20.47;20.43;11.17;3.01;17.7;19.44;23.76;14.62;6.23;25.95;8.04;7.29;11.86;1.59;23.48;26.95;8.88;9.37;11.18;19.48;4.52;37.44;15.57;22.56;11.49;10.52;12.83;11.31 1992-06-19;7.82;5.68;20.84;20.43;11.23;3.02;18.03;19.53;23.54;14.86;6.23;26.63;8.24;7.18;11.75;1.64;23.6;27.1;8.97;9.51;11.3;19.69;4.59;37.44;15.7;22.68;11.61;10.42;12.89;11.46 1992-06-22;7.84;5.8;20.71;20.31;10.97;3.07;17.98;19.15;23.39;14.77;6.25;26.26;8.42;7.3;11.53;1.68;23.67;27;8.88;9.67;11.24;20.6;4.64;37.44;15.81;23.11;11.56;10.42;12.8;11.38 1992-06-23;7.79;5.8;20.96;20.31;11.07;3.06;17.92;19.34;23.46;14.62;6.26;26.41;8.51;7.45;11.34;1.71;23.82;27.05;8.97;9.61;11.27;20.2;4.59;37.35;15.81;22.99;11.42;10.54;12.74;11.03 1992-06-24;7.83;5.71;20.59;19.95;11.05;3.02;17.81;19.48;23.54;14.65;6.26;26.56;8.53;7.16;11.45;1.7;24.26;27.5;8.94;9.37;11.3;19.63;4.52;37.3;15.95;22.87;11.28;10.44;12.56;10.99 1992-06-25;7.87;5.71;20.47;19.65;10.71;3.01;18.03;19.63;23.54;14.62;6.33;26.1;8.53;7.01;11.48;1.69;24.13;27.86;9.1;9.37;11.42;19.53;4.38;37.35;15.84;22.74;11.21;10.52;12.54;11.31 1992-06-26;7.84;5.68;20.65;19.4;10.58;3.04;17.75;19.58;23.91;14.65;6.39;25.88;8.42;7.05;11.56;1.72;24.16;27.5;9.32;9.59;11.46;19.38;4.17;37.3;15.84;22.56;11.28;10.52;12.65;11.15 1992-06-29;7.96;5.8;21.08;18.92;10.89;3.16;18.03;19.44;23.99;14.83;6.47;26.56;8.67;7.36;11.75;1.8;24.5;27.81;9.33;9.75;11.7;19.94;4.52;37.59;15.76;22.44;11.42;10.65;12.83;11.23 1992-06-30;8.07;5.74;21.21;19.34;11.07;3.1;17.87;19.44;24.06;14.74;6.37;26.71;8.48;7.4;11.59;1.77;24.32;28.06;9.4;9.59;11.42;19.89;4.38;37.83;15.89;22.5;11.49;10.78;12.71;11.35 1992-07-01;8.25;5.8;21.58;19.95;10.84;3.19;18.42;19.68;24.29;14.71;6.43;26.1;8.65;7.56;11.75;1.8;24.41;28.21;9.59;9.77;11.61;20.25;4.51;38.42;16.43;22.68;11.73;10.7;12.68;11.54 1992-07-02;7.99;5.8;21.64;19.95;10.71;3.16;18.7;19.34;23.91;14.74;6.33;24.97;8.24;7.61;11.75;1.74;24.07;27.45;9.84;9.77;11.55;20.2;4.37;37.44;16.81;23.36;11.85;10.7;12.8;11.35 1992-07-06;7.82;5.99;21.82;20.13;10.58;3.22;18.98;19.24;24.51;14.8;6.34;24.74;8.02;7.63;11.42;1.77;24.38;27.3;9.59;10.01;11.49;20.81;4.34;37.93;17.03;24.03;12.15;10.49;13.1;11.01 1992-07-07;7.62;5.89;21.58;20.01;10.43;3.11;18.76;18.81;23.99;14.71;6.24;24.74;7.87;7.43;11.1;1.74;24.04;26.4;9.52;9.91;11.21;20.5;4.25;37.83;16.78;23.91;12.15;10.52;12.74;10.89 1992-07-08;7.71;5.95;21.64;19.59;10.33;3.13;18.98;18.81;24.74;14.71;6.31;24.51;8.02;7.57;11.02;1.77;24.32;26.25;9.49;10.12;10.96;20.76;4.29;37.83;16.95;23.91;12.18;10.36;12.83;10.85 1992-07-09;7.86;5.86;21.7;19.4;10.79;3.18;19.26;18.95;24.81;14.68;6.37;25.04;8.27;7.73;11.15;1.79;24.22;26.7;9.68;10.1;11.33;20.76;4.31;37.88;17.19;23.91;12.18;10.39;13.04;10.77 1992-07-10;7.76;5.92;21.51;18.92;11.07;3.2;19.04;18.76;24.89;14.65;6.26;24.89;8.28;7.78;11.34;1.76;24.26;26.55;9.84;10.04;11.67;20.55;4.34;37.78;17.11;24.27;12.1;10.57;12.98;10.85 1992-07-13;7.82;5.89;21.58;19.22;11.02;3.16;18.81;18.86;24.96;14.56;6.29;25.34;8.45;7.73;11.45;1.76;24.32;26.85;9.55;10.04;11.55;20.55;4.38;37.98;16.97;24.46;12.08;10.62;13.04;10.73 1992-07-14;7.88;6.08;21.76;19.1;11.08;3.3;18.54;19.15;25.49;14.77;6.38;25.57;8.51;7.8;11.48;1.81;24.32;26.7;9.59;9.91;11.46;20.4;4.45;37.98;17.05;24.58;12.13;10.54;13.13;11.28 1992-07-15;7.66;5.99;21.76;19.34;11.36;3.33;18.09;19;25.64;14.62;6.4;25.34;8.64;7.82;11.61;1.81;24.66;25.7;9.33;9.96;11.46;20.35;4.47;38.52;16.95;25.01;12.27;10.57;13.01;11.52 1992-07-16;7.68;6.02;22.13;19.65;11.57;3.33;18.09;19.34;25.64;14.89;6.34;25.12;8.58;7.8;11.59;1.8;24.91;25.95;9.02;10.01;11.46;20.45;4.52;38.81;16.97;25.01;12.58;10.65;13.04;11.44 1992-07-17;7.74;5.99;21.95;19.53;11.31;3.28;18.26;19.1;25.26;14.8;6.35;24.74;8.5;7.82;11.45;1.74;23.6;25.7;9.08;9.93;11.46;20.4;4.39;38.56;16.95;24.82;12.58;10.52;13.01;11.28 1992-07-20;7.62;5.89;21.88;19.59;11.1;3.28;18.31;19;25.04;14.8;6.33;24.43;8.41;7.76;11.32;1.73;23.08;25.95;9.33;9.83;11.18;20.14;4.33;38.37;16.81;24.33;12.46;10.57;12.92;11.24 1992-07-21;7.58;5.89;21.76;19.46;11.03;3.36;18.48;19.05;25.04;14.71;6.32;24.21;8.58;7.84;11.45;1.76;23.29;25.8;9.11;9.77;11.33;20.04;4.48;38.37;16.86;24.76;12.39;11.03;12.95;11.32 1992-07-22;7.55;5.86;21.33;19.28;10.84;3.35;18.14;18.81;24.89;14.77;6.27;23.6;8.58;7.73;11.32;1.72;22.98;25.5;8.83;9.85;11.08;20.14;4.38;38.37;16.73;24.33;12.32;11.09;12.95;11.24 1992-07-23;7.56;5.89;21.39;19.4;10.84;3.36;18.14;18.95;24.96;15.01;6.3;23.68;8.7;7.84;11.64;1.79;23.04;25.45;8.61;9.8;10.52;20.04;4.44;38.32;16.81;24.46;12.37;11.09;13.07;11.17 1992-07-24;7.68;5.71;21.21;19.28;11.15;3.33;18.09;18.86;24.89;14.86;6.12;23.83;8.81;7.88;11.75;1.81;23.04;25.35;8.64;9.85;10.87;20.09;4.55;38.37;16.76;24.21;12.32;11.11;12.98;11.2 1992-07-27;7.7;5.62;21.21;19.04;11.31;3.32;18.03;18.91;24.96;14.77;6.14;24.21;8.82;8.06;11.67;1.76;22.95;25.2;8.67;10.1;10.83;20.76;4.56;38.47;16.62;23.85;12.46;11.09;12.98;11.24 1992-07-28;7.83;5.68;21.64;18.92;11.36;3.39;18.31;19.1;25.64;14.8;6.21;25.12;8.9;8.23;11.75;1.84;23.29;25.9;8.8;10.44;10.96;20.81;4.62;39.15;16.97;23.97;12.41;11.27;13.04;11.17 1992-07-29;8.02;5.71;21.7;18.92;11.44;3.47;18.7;20.16;26.31;14.77;6.32;25.27;9.1;8.15;12.12;1.83;23.45;26.45;8.73;10.5;11.11;20.91;4.62;38.91;17.08;24.15;12.53;11.78;13.22;11.36 1992-07-30;7.88;5.68;21.64;19.1;11.44;3.49;18.54;20.21;26.16;15.1;6.25;25.19;9.12;8.25;12.07;1.83;23.7;26.7;8.76;10.63;11.02;21.16;4.57;39.05;17.16;24.52;12.51;11.78;13.22;11.44 1992-07-31;7.84;5.68;21.64;19.4;11.41;3.55;18.7;20.64;26.09;15.13;6.27;25.27;9.05;8.29;11.96;1.86;23.54;26.8;8.83;10.55;10.9;21.16;4.55;39;17.27;24.76;12.56;11.76;13.22;11.32 1992-08-03;7.79;5.65;21.64;19.59;11.31;3.54;19.21;20.69;26.01;15.31;6.16;24.89;9.04;8.52;12.04;1.89;23.57;26.6;8.76;10.71;10.62;21.57;4.61;39.34;17.41;24.82;12.49;11.73;13.24;11.32 1992-08-04;7.68;5.55;21.64;19.53;11.18;3.53;19.04;20.49;26.24;15.49;6.18;24.43;9.15;8.44;12.18;1.88;23.42;26.4;8.7;10.66;10.62;21.67;4.62;39.34;17.38;24.64;12.53;11.81;13.22;11.17 1992-08-05;7.62;5.55;21.39;19.59;11.08;3.53;18.98;20.69;26.54;15.25;6.13;23.75;8.91;8.39;11.99;1.85;22.77;26.3;8.48;10.66;10.65;21.47;4.5;39.44;17.46;24.58;12.58;11.7;13.36;11.09 1992-08-06;7.52;5.46;21.64;19.59;10.92;3.55;18.98;20.54;26.31;15.22;6.2;22.61;8.81;8.42;12.07;1.82;21.93;25.95;8.51;10.66;10.56;21.22;4.47;39.2;17.49;24.27;12.49;11.68;13.48;11.09 1992-08-07;7.52;5.46;21.51;19.53;10.9;3.46;19.04;20.4;26.24;15.13;6.18;22.46;7.25;8.42;12.04;1.82;21.65;25.65;8.45;10.68;10.49;21.27;4.42;39.1;17.32;24.4;12.46;11.63;13.57;11.24 1992-08-10;7.42;5.46;21.39;19.28;10.82;3.47;19.26;20.37;26.24;15.34;6.2;22.99;7.45;8.6;12.07;1.84;21.99;25.75;8.26;10.68;10.4;21.22;4.43;39.1;17.43;24.09;12.44;11.45;13.54;11.17 1992-08-11;7.32;5.49;21.45;19.22;10.66;3.49;19.15;20.33;25.86;15.34;6.21;23.07;7.45;8.58;11.99;1.83;21.86;25.2;8.51;10.52;10.68;21.22;4.46;39;17.27;23.6;12.58;11.39;13.6;11.24 1992-08-12;7.31;5.46;21.39;19.22;10.35;3.43;19.21;20.13;26.01;15.1;6.15;22.54;7.44;8.5;12.04;1.8;21.96;25.45;8.51;10.47;10.65;20.96;4.44;38.81;17.22;23.36;12.51;11.39;13.57;11.32 1992-08-13;7.26;5.37;21.33;19.1;10.33;3.41;19.32;19.94;26.39;15.28;6.16;22.16;7.48;8.56;11.64;1.82;21.9;24.79;8.54;10.44;10.65;21.22;4.43;38.71;17.24;23.48;12.58;11.37;13.69;11.44 1992-08-14;7.31;5.46;21.39;19.16;10.3;3.44;19.37;20.08;26.46;15.25;6.18;22.63;7.42;8.46;11.53;1.85;21.96;25.25;8.76;10.68;10.52;21.57;4.44;39.1;17.27;23.6;12.82;11.7;13.95;11.4 1992-08-17;7.27;5.52;21.51;19.34;9.97;3.48;19.37;19.99;26.46;15.16;6.23;22.86;7.47;8.56;11.67;1.82;22.02;25.52;8.7;10.87;10.56;21.22;4.34;39.37;17.35;23.85;13.08;11.62;13.9;11.4 1992-08-18;7.24;5.49;21.33;19.16;10.04;3.47;19.43;19.89;26.39;15.34;6.28;22.86;7.05;8.62;11.61;1.8;21.86;25.47;8.64;10.95;10.74;21.27;4.34;39.37;17.43;23.97;13.11;11.67;13.9;11.28 1992-08-19;7.24;5.34;21.33;18.98;10.02;3.43;19.26;19.79;26.39;15.46;6.24;22.33;7.04;8.62;11.5;1.74;21.52;25.42;8.29;10.9;10.65;21.06;4.33;39.37;17.3;23.72;13.06;11.41;13.84;10.85 1992-08-20;7.26;5.34;21.21;18.98;9.86;3.4;19.48;19.7;26.61;15.58;6.24;21.87;6.99;8.6;11.56;1.78;21.34;25.21;8.51;10.82;10.77;21.11;4.4;39.56;17.35;23.6;13.06;11.38;13.87;10.81 1992-08-21;6.92;5.12;21.08;18.68;9.86;3.35;19.09;19.36;25.94;15.07;6.15;21.71;6.99;8.58;11.48;1.76;21.37;24.86;8.42;10.41;10.56;20.71;4.36;38.97;17.27;23.6;13.11;11.28;13.69;10.61 1992-08-24;6.8;5.12;20.84;18.62;9.68;3.27;19.04;19.36;26.09;15.31;6.07;20.87;6.91;8.5;11.15;1.71;21.15;24.91;8.13;10.57;10.4;20.55;4.31;38.73;17.19;23.48;12.96;11.1;13.57;10.34 1992-08-25;6.84;5.18;20.96;18.25;9.63;3.29;19.04;19.45;26.46;15.19;6.06;20.72;7.01;8.31;11.04;1.75;21.65;25.06;7.97;10.57;10.37;20.81;4.4;38.48;17.24;23.48;13.08;11.15;13.57;10.34 1992-08-26;6.9;5.18;20.96;18.01;9.84;3.28;19.09;19.55;27.37;15.25;6.04;20.95;6.96;8.39;11.37;1.77;21.46;25.01;8.1;10.87;10.59;20.76;4.48;38.83;17.43;23.11;12.96;11.23;13.72;10.65 1992-08-27;6.9;5.21;20.77;18.19;9.97;3.33;19.15;19.26;27.29;15.16;6.08;20.72;6.9;8.62;11.61;1.8;21.71;24.96;8.29;10.84;10.74;20.35;4.6;38.48;17.57;23.3;12.87;11.33;13.57;10.81 1992-08-28;7.08;5.18;20.84;18.13;9.99;3.29;19.37;19.4;27.29;15.28;6.01;20.56;6.87;8.72;11.5;1.8;21.68;25.16;8.32;10.76;10.62;20.14;4.65;38.73;17.68;23.11;12.7;11.49;13.6;11.01 1992-08-31;6.91;5.15;20.84;18.07;9.97;3.21;19.21;19.16;26.84;15.31;6.06;21.25;7.05;8.81;11.34;1.8;21.52;25.16;8.23;10.63;10.56;19.94;4.66;38.73;17.73;22.93;12.68;11.43;13.51;10.85 1992-09-01;6.96;5.25;20.84;18.07;9.97;3.3;19.54;18.97;27.14;15.34;6.08;21.1;7.1;8.97;11.37;1.84;21.77;25.57;8.42;10.84;10.46;19.79;4.66;38.83;17.89;22.87;12.89;11.46;13.55;10.85 1992-09-02;7.26;5.34;20.96;18.25;10.1;3.3;19.48;19.16;27.6;15.31;6.1;21.1;7.19;8.91;11.45;1.89;21.74;26.12;8.51;10.87;10.59;19.68;4.71;39.32;18.19;22.93;12.84;11.49;13.52;10.93 1992-09-03;7.22;5.37;20.96;18.13;10.23;3.29;19.48;19.26;27.52;14.83;6.12;21.33;6.99;8.79;11.53;1.94;21.52;26.07;8.29;11.33;10.8;19.79;4.79;39.12;18.38;22.81;12.82;11.56;13.64;11.05 1992-09-04;7.11;5.43;20.9;18.19;10.17;3.27;19.48;19.06;27.07;14.89;6.11;21.56;6.88;8.72;11.5;1.9;21.37;25.92;8.42;11.27;10.59;20.09;4.75;39.12;18.32;22.68;12.84;11.59;13.52;10.93 1992-09-08;7;5.43;20.77;17.95;9.86;3.24;19.48;18.92;27.14;14.89;6.07;20.87;6.96;8.72;11.34;1.9;21.4;25.21;7.97;11.3;10.74;19.79;4.8;38.97;18.41;22.74;12.8;11.54;13.52;10.93 1992-09-09;7.14;5.43;21.02;17.89;9.97;3.22;19.77;18.92;27.07;14.95;6.1;20.87;7.1;8.81;11.21;1.96;21.59;25.32;7.85;11.19;10.83;19.73;4.88;39.22;18.33;23.05;12.77;11.43;13.7;11.09 1992-09-10;7.4;5.4;21.51;17.95;10.2;3.35;19.77;18.43;27.45;14.98;6.16;20.87;7.05;8.93;11.42;2;21.74;26.17;7.94;11.27;10.8;19.63;4.94;39.27;18.38;23.72;12.77;11.46;13.85;11.56 1992-09-11;7.3;5.37;21.58;18.01;10.2;3.28;19.83;18.34;26.99;14.98;6.15;20.64;7.07;8.93;11.56;1.99;21.86;26.68;7.78;11.14;10.87;19.68;4.92;39.07;18.36;23.97;12.53;11.36;13.85;11.68 1992-09-14;7.51;5.58;22.32;18.31;10.95;3.43;19.88;18.92;27.45;14.95;6.35;21.41;7.38;8.99;12.1;2.04;21.96;27.18;8.16;11.14;11.27;19.94;5.11;40.5;18.52;24.33;12.63;11.72;13.97;11.52 1992-09-15;7.3;5.55;22.01;17.83;10.79;3.33;19.83;18.58;26.76;14.86;6.33;20.79;7.27;8.97;12.07;1.98;21.24;26.63;7.97;10.87;11.11;19.48;5.08;40.1;18.41;23.78;12.46;11.51;13.85;11.44 1992-09-16;7.36;5.58;21.76;17.34;10.69;3.29;20.05;18.14;26.92;15.04;6.39;20.41;7.13;8.97;11.94;1.98;20.65;26.38;7.94;10.95;11.08;19.27;5.02;40.5;18.41;23.72;12.44;11.28;13.85;11.56 1992-09-17;7.3;5.55;21.45;17.22;10.79;3.32;20;18.53;26.76;15.04;6.47;20.49;7.27;8.95;12.1;2;20.81;26.78;7.88;10.87;11.05;19.27;5.07;40.05;18.66;23.91;12.44;10.68;13.88;11.56 1992-09-18;7.32;5.55;21.7;16.74;10.82;3.3;20.16;18.97;26.84;15.25;6.52;20.95;7.31;9.12;12.07;2.03;20.75;26.98;7.85;11.06;11.08;19.43;4.99;39.81;18.71;23.85;12.6;10.47;13.88;11.56 1992-09-21;7.32;5.52;21.88;17.22;10.82;3.32;20.05;18.82;26.61;15.28;6.43;21.02;7.33;9.28;11.86;2.02;20.96;27.08;7.78;11.06;11.11;19.07;4.95;39.76;18.79;23.66;12.37;10.24;13.97;11.64 1992-09-22;7.23;5.43;21.58;17.04;10.69;3.47;18.93;18.68;26.31;15.16;6.33;20.26;7.19;9.2;11.42;2;20.68;26.88;7.66;10.9;10.99;19.12;4.86;39.32;18.68;23.36;12.27;10.16;13.82;11.56 1992-09-23;7.18;5.49;21.88;16.98;10.48;3.45;18.26;18.58;26.92;15.28;6.36;19.72;7.24;9.36;11.64;2.07;20.78;26.27;7.78;10.98;11.05;19.17;4.95;39.71;18.57;23.91;12.41;10.16;14;11.52 1992-09-24;7.24;5.52;21.58;17.34;10.66;3.59;18.54;18.58;27.14;15.19;6.38;20.33;7.11;9.36;11.8;2.05;20.5;26.73;7.78;10.87;11.11;18.71;5.02;39.91;18.79;23.97;12.56;10.08;14.03;11.4 1992-09-25;7.1;5.43;21.45;17.22;10.74;3.47;18.43;18.29;26.69;15.13;6.38;19.64;7.11;9.2;11.5;2.01;20.44;26.27;7.94;10.25;10.96;17.94;4.92;39.61;18.57;23.66;12.6;10;13.79;11.44 1992-09-28;7.14;5.46;21.58;17.22;11.03;3.45;18.48;18.58;26.84;15.4;6.49;19.64;7.1;9.22;11.59;2.03;20.56;26.27;8.1;10.22;11.08;17.74;4.81;40;18.6;23.85;12.72;10.08;14;11.48 1992-09-29;7.02;5.43;21.45;17.34;10.77;3.41;18.26;18.58;26.92;15.22;6.4;19.64;7.01;9.1;11.45;2.04;20.13;25.87;8.13;10.25;11.05;18.04;4.92;40.25;18.63;23.91;12.84;9.93;13.94;11.48 1992-09-30;7.08;5.46;21.51;17.83;10.77;3.53;18.15;18.29;26.99;15.22;6.41;19.72;6.87;9.14;11.26;2.04;20.06;25.82;8.34;10.14;11.02;18.25;5.03;40.3;18.47;24.15;13.06;10.19;14;11.4 1992-10-01;7;5.4;21.21;17.65;10.61;3.58;17.92;18.39;27.29;15.19;6.38;19.41;6.56;9.14;11.37;1.98;19.91;25.11;8.37;10.06;11.02;18.09;4.98;39.66;18.38;24.15;13.06;10.19;13.97;11.17 1992-10-02;6.9;5.31;20.84;17.46;10.25;3.51;17.59;18.14;26.84;15.07;6.21;18.95;6.54;8.85;11.15;1.94;19.5;24.56;8.18;9.87;10.9;17.63;4.92;39.41;18.17;23.85;12.94;10;13.73;10.97 1992-10-05;6.86;5.24;20.65;17.83;10.15;3.51;17.64;17.8;25.85;14.89;6.17;19.1;6.67;8.83;10.96;1.98;19.6;24.46;8.11;9.9;10.65;17.58;5.11;39.02;18.03;24.15;12.86;9.77;13.55;10.98 1992-10-06;6.91;5.21;20.47;17.95;10.17;3.51;17.36;17.9;26.31;14.8;6.1;18.95;6.67;8.83;11.18;2.04;19.82;24.91;8.14;9.69;10.65;17.38;5.16;38.68;18;24.27;12.77;9.69;13.7;10.87 1992-10-07;6.87;5.21;20.47;17.59;10.1;3.44;16.8;17.66;26.08;14.74;6.04;18.41;6.61;8.6;11.34;2.04;19.47;24.25;8.08;9.79;10.52;17.38;5.07;38.33;17.76;23.97;12.65;9.72;13.58;10.79 1992-10-08;6.87;5.18;20.65;17.59;10.07;3.52;16.86;18.14;25.93;14.98;6.19;18.49;6.57;8.77;11.1;2.06;19.72;24.71;7.95;10.12;10.74;17.33;5.21;39.17;18.03;24.4;12.74;9.67;13.88;11.06 1992-10-09;6.86;5.12;20.59;17.65;10.04;3.49;16.58;17.95;25.55;14.68;6.14;17.88;6.36;8.56;10.96;2.07;19.5;24.51;7.92;10.06;10.68;16.86;5.15;38.48;17.81;24.09;12.81;9.62;13.73;10.79 1992-10-12;6.94;5.09;20.78;17.77;10.25;3.43;16.52;18.34;25.7;14.65;6.17;18.87;6.5;8.77;10.99;2.05;19.5;24.86;8.11;10.36;10.8;17.12;5.24;39.07;18.03;24.27;13.18;9.85;13.88;11.14 1992-10-13;7.06;5.09;20.9;18.13;10.54;3.41;16.97;18.24;25.63;14.71;6.13;19.18;6.7;8.87;11.32;2.01;19.57;25.42;8.08;10.36;10.74;17.48;5.27;38.78;18.3;24.7;13.25;9.95;13.76;11.38 1992-10-14;6.98;5.09;20.71;17.95;10.64;3.43;17.25;18.14;25.48;14.8;6.14;18.87;6.62;8.95;11.53;1.96;19.38;24.71;8.11;10.33;10.68;17.84;5.22;38.78;18.3;24.88;13.22;9.82;13.85;11.18 1992-10-15;6.87;5.12;20.71;18.07;10.66;3.39;17.59;18.19;25.63;14.95;6.15;18.72;6.67;8.97;11.48;1.99;18.11;24.86;7.98;10.55;10.56;17.99;5.28;39.07;17.38;24.82;13.2;9.67;13.82;11.22 1992-10-16;7.06;4.99;20.78;17.95;10.59;3.43;18.09;18.43;25.4;15.04;6.25;18.03;6.88;9.14;11.59;1.97;17.58;25.62;8.02;10.49;10.56;17.43;5.34;38.87;16.83;24.95;13.25;9.85;14.09;11.34 1992-10-19;7.16;5.15;20.96;17.89;10.87;3.46;18.43;18.43;25.55;15.07;6.26;17.88;6.97;9.3;11.5;2.05;17.02;25.77;8.56;10.49;10.56;18.15;5.49;38.73;16.69;25.25;13.44;9.9;14.35;11.42 1992-10-20;7.18;5.24;20.78;17.95;11.06;3.46;18.26;18.24;25.7;14.92;6.27;18.26;6.96;9.36;11.72;2.08;16.99;25.87;8.56;10.6;10.65;17.27;5.49;38.92;16.97;25.01;13.32;9.69;14.5;11.34 1992-10-21;7.26;5.12;20.22;18.13;10.95;3.44;18.15;17.95;25.48;14.92;6.23;19.03;6.81;9.51;11.86;2.14;17.02;25.87;8.59;10.84;10.59;17.22;5.62;39.22;17.13;25.13;12.93;9.46;14.68;11.42 1992-10-22;7.34;5.12;20.71;18.07;11.08;3.45;18.15;18.09;25.55;14.77;6.26;20.18;6.67;9.32;11.86;2.11;17.02;25.82;8.65;10.82;10.65;17.12;5.61;39.81;16.83;25.37;12.65;9.46;14.53;11.58 1992-10-23;7.32;5.09;21.27;17.83;10.82;3.42;17.92;18.24;25.48;14.77;6.22;20.56;6.79;9.34;12.07;2.09;17.18;25.87;8.72;10.6;10.68;16.86;5.54;40.55;16.23;24.95;12.65;9.41;14.44;12.13 1992-10-26;7.39;5.12;21.82;17.34;10.77;3.47;18.26;18.39;25.55;14.74;6.3;20.95;6.84;9.43;12.34;2.13;16.77;25.97;9.04;10.68;11.02;17.63;5.62;41.18;16.48;26.17;12.79;9.36;14.56;12.28 1992-10-27;7.27;5.12;21.76;17.71;10.8;3.47;18.54;18.73;25.4;14.95;6.28;19.87;6.79;9.41;12.21;2.09;16.34;25.97;8.88;10.57;11.36;17.68;5.5;40.5;16.64;25.92;12.84;9.33;14.62;12.52 1992-10-28;7.47;5.21;21.82;17.52;10.82;3.49;18.54;18.97;24.94;14.89;6.37;19.26;6.94;9.47;12.15;2.09;16.68;26.27;8.88;10.65;11.33;17.84;5.53;40.79;16.75;25.68;12.89;9.51;14.65;12.68 1992-10-29;7.48;5.24;21.64;17.52;10.75;3.47;18.6;18.97;24.72;14.8;6.35;19.26;7.08;9.51;12.13;2.07;16.4;26.17;8.88;10.68;11.46;17.79;5.62;40.64;16.86;25.74;12.91;9.48;14.68;12.48 1992-10-30;7.46;5.34;21.51;17.46;10.82;3.45;18.2;18.77;24.79;14.59;6.29;18.87;7.01;9.55;12.02;2.1;16.62;26.17;8.78;10.76;11.39;17.99;5.55;40.45;16.56;25.86;12.86;9.51;14.41;12.4 1992-11-02;7.47;5.34;21.76;17.95;10.93;3.49;18.6;19.02;25.1;14.36;6.43;19.56;7.24;9.61;12.05;2.11;17.11;26.58;8.94;10.92;11.42;18.3;5.6;41.23;16.78;25.92;13.01;9.54;14.59;12.6 1992-11-03;7.49;5.31;21.39;17.65;11.16;3.43;18.26;19.11;25.32;14.18;6.4;19.79;7.24;9.51;12.32;2.09;17.18;26.83;8.88;10.71;11.49;18.04;5.52;40.84;16.72;25.99;12.79;9.56;14.59;12.48 1992-11-04;7.46;5.18;21.08;17.77;11.11;3.43;18.04;19.02;25.48;14.27;6.42;19.41;7.36;9.55;12.29;2.1;16.96;26.22;8.91;10.57;11.3;17.63;5.53;40.5;16.42;25.5;12.86;9.48;14.68;12.6 1992-11-05;7.41;5.24;21.88;17.59;11.34;3.39;18.32;19.02;25.32;14.12;6.41;19.3;7.16;9.74;12.32;2.18;16.37;26.63;8.97;10.38;11.36;17.33;5.74;41.09;17.13;26.05;12.67;9.48;14.71;12.6 1992-11-06;7.41;5.18;22.13;17.4;11.37;3.46;18.32;18.75;25.25;13.88;6.35;18.92;7.24;9.69;12.45;2.14;16.46;26.58;9.01;10.57;11.46;17.27;5.8;41.23;16.99;26.05;12.43;9.48;14.71;12.64 1992-11-09;7.35;5.27;22.07;17.52;11.34;3.44;18.43;18.8;25.17;13.94;6.39;19.07;7.14;9.82;12.45;2.15;16.77;26.17;9.1;10.6;11.33;17.27;5.74;41.28;16.78;25.74;12.31;9.43;14.85;12.87 1992-11-10;7.27;5.37;21.88;17.34;11.19;3.48;18.32;18.21;25.1;14.03;6.33;18.92;7.28;9.9;12.34;2.17;16.37;25.52;9.17;10.68;11.39;17.58;5.8;41.28;16.83;25.8;12.33;9.36;14.83;13.15 1992-11-11;7.26;5.37;22.5;17.04;11.06;3.59;18.76;18.36;24.79;13.94;6.42;18.61;7.28;9.96;12.29;2.19;16.15;25.42;9.26;10.89;11.67;18.4;5.86;40.99;16.94;26.66;12.33;9.36;14.68;13.11 1992-11-12;7.3;5.43;22.62;17.1;11.13;3.66;18.37;18.41;24.57;14;6.45;18.84;7.05;9.9;12.32;2.15;15.93;25.62;9.32;10.92;11.58;18.76;5.84;40.55;17.27;26.66;12.4;9.2;14.59;12.95 1992-11-13;7.15;5.4;22.5;17.1;10.98;3.6;18.6;18.31;24.57;14.12;6.46;19.23;7.04;9.94;12.32;2.18;16.12;25.47;9.36;10.78;11.52;18.66;5.83;40.64;17.32;26.29;12.43;9.25;14.38;12.84 1992-11-16;6.95;5.4;22.99;17.04;10.95;3.6;18.32;18.01;24.34;14.03;6.39;19.23;6.94;9.82;12.15;2.14;16.12;25.38;9.32;10.76;11.74;18.66;5.8;39.92;17.29;26.47;12.55;8.93;14.53;12.68 1992-11-17;6.9;5.43;22.62;16.74;10.98;3.6;18.26;17.96;24.41;14;6.39;18.92;6.82;9.65;12.18;2.11;15.96;24.98;9.2;10.78;11.89;18.81;5.62;39.62;17.4;26.17;12.67;8.87;14.56;12.84 1992-11-18;7.02;5.62;23.12;16.74;11.03;3.55;18.26;18.21;24.41;14.3;6.45;19.07;7.24;9.82;12.15;2.16;15.68;25.28;9.17;10.89;11.89;19.07;5.75;39.57;17.48;26.41;12.96;8.9;14.56;12.68 1992-11-19;7.04;5.56;23.18;16.37;11.08;3.59;18.26;18.11;24.41;14.3;6.4;18.76;7.22;9.88;12.13;2.17;15.22;25.18;9.13;10.87;12.11;18.97;5.88;39.82;17.62;26.72;13.22;8.87;14.62;12.87 1992-11-20;7.15;5.59;23.49;16.61;11.11;3.63;18.32;18.21;24.41;14.47;6.55;19.15;7.51;9.88;11.99;2.19;15.47;24.93;9.1;10.92;11.98;18.91;5.94;39.57;17.38;26.54;13.3;8.93;14.8;13.07 1992-11-23;7.15;5.52;23.49;16.98;11.01;3.63;18.26;17.96;25.1;14.24;6.73;19.15;7.59;9.84;11.94;2.17;15.72;24.82;9.29;10.87;11.95;18.61;5.53;39.82;17.29;26.35;13.3;8.98;14.77;12.91 1992-11-24;7.26;5.65;23.3;16.8;11.19;3.68;18.21;18.16;25.48;14.21;6.77;19.23;7.59;9.98;12.1;2.18;16.12;25.38;9.29;11.11;12.14;18.5;5.72;40.32;17.35;26.72;13.42;9.11;14.88;13.15 1992-11-25;7.33;5.8;23.55;16.43;11.16;3.72;18.27;18.26;26.17;14.27;6.79;19.69;7.82;9.98;12.18;2.19;16.24;25.64;9.55;11.11;11.95;18.61;5.7;40.56;17.29;26.66;13.58;9.27;15;12.91 1992-11-27;7.38;5.77;23.3;16.92;11.24;3.76;18.15;18.65;26.02;14.18;6.79;19.53;8.02;9.96;12.26;2.21;16.4;26.3;9.61;11.03;12.17;18.76;5.73;41.06;17.29;26.6;13.46;9.4;15.15;12.95 1992-11-30;7.54;5.71;23.24;17.04;11.76;3.86;17.87;18.85;25.71;14.18;6.82;19.92;8.19;10.07;12.43;2.22;16.96;26.55;9.58;10.89;12.17;18.5;5.82;40.42;17.35;26.54;13.37;9.42;15.24;13.29 1992-12-01;7.63;5.62;23.3;16.98;11.73;3.91;17.82;19.29;25.63;14.06;6.73;20;7.9;10.13;12.56;2.27;16.83;25.94;9.39;10.89;12.17;18.76;5.82;40.47;17.59;26.29;13.37;9.35;15.18;12.72 1992-12-02;7.58;5.68;23.43;16.49;11.24;3.92;17.76;19.29;25.25;13.94;6.78;20.23;7.84;10.11;12.78;2.28;16.86;26.5;9.39;10.81;12.17;18.81;5.67;40.17;17.65;26.11;13.37;9.4;15.24;12.72 1992-12-03;7.53;5.77;23.3;16.74;11.01;3.9;17.76;19.43;24.87;14;6.69;20.23;7.85;10.4;12.48;2.4;16.71;26.3;9.45;10.87;12.17;18.92;5.73;40.27;17.73;26.23;13.61;9.42;14.97;12.64 1992-12-04;7.54;5.84;23.3;16.74;11.01;3.9;17.82;19.38;25.4;14.27;6.77;21;7.85;10.52;12.59;2.45;16.65;25.89;9.55;11.05;12.14;18.86;5.73;40.12;17.84;26.05;13.49;9.48;15.13;12.84 1992-12-07;7.54;6.18;23.43;16.92;11.01;3.86;17.98;19.48;25.56;14.3;6.79;21.23;7.91;10.73;12.59;2.46;16.37;25.84;9.45;11.24;12.2;19.17;5.84;40.42;17.81;26.23;13.66;9.63;15.25;12.95 1992-12-08;7.61;6.05;23.8;16.8;11.19;3.93;18.04;19.38;25.17;14.39;6.84;21.46;7.95;10.7;12.7;2.43;16.24;26.15;9.52;11.24;12.32;19.28;5.78;40.76;17.81;25.92;13.85;9.66;15.25;13.03 1992-12-09;7.84;6.09;24.1;16.8;11.24;3.88;17.93;19.29;25.1;14.45;6.88;21.31;8.25;10.68;12.81;2.47;15.56;26.55;9.32;11.08;12.17;19.64;5.75;41.21;17.79;26.17;13.71;9.92;15.25;12.87 1992-12-10;7.76;6.15;23.92;16.61;11.16;3.9;17.87;19.04;24.87;14.59;6.83;20.62;8.21;10.7;12.67;2.5;15.34;27.16;9.1;11.14;12.2;19.43;5.56;41.36;17.57;25.99;13.66;10.03;15.1;12.76 1992-12-11;7.73;6.05;23.98;16.68;11.03;3.88;17.93;19.19;25.17;14.5;6.86;20.69;8.1;10.66;12.97;2.45;15.5;27.21;9.23;11.03;12.14;19.59;5.4;41.01;17.35;25.62;13.71;9.82;15.07;12.6 1992-12-14;7.63;6.12;23.86;16.8;10.95;3.88;17.76;18.99;25.02;14.42;6.82;20.38;8.05;10.7;12.72;2.42;15.62;27.16;9.26;11.08;12.01;19.53;5.45;40.96;17.21;25.56;13.68;9.9;15.07;12.76 1992-12-15;7.65;6.09;23.61;16.86;11.03;3.82;18.27;19.34;25.4;14.56;6.89;20.08;7.95;10.68;12.83;2.41;13.95;26.91;9.36;11.05;11.86;19.28;5.4;41.36;16.94;25.5;13.68;9.92;15.13;12.72 1992-12-16;7.63;6.21;23.73;16.86;10.95;3.77;18.27;19.19;25.33;14.56;6.84;20.31;7.87;10.75;12.81;2.6;12.89;26.6;9.29;11.16;11.77;19.17;5.44;40.66;16.75;25.5;13.75;9.77;15.19;12.68 1992-12-17;7.66;6.18;24.17;17.1;11.01;3.77;18.66;19.58;25.17;14.77;6.98;20.08;8.08;11.1;12.75;2.69;13.17;26.25;9.39;11.41;11.89;19.17;5.62;39.82;16.88;25.8;13.95;9.9;15.43;12.99 1992-12-18;7.76;6.15;24.47;17.34;11.29;4.03;19.67;19.92;25.02;14.98;7.11;20.46;8.08;11.06;13.11;2.66;12.77;26.65;9.42;11.65;12.26;19.33;5.62;40.81;16.86;26.54;14.26;10;15.55;13.31 1992-12-21;7.73;6.18;24.72;17.89;11.29;3.93;19.56;19.53;25.1;14.98;7.17;20.46;8.13;11.12;13;2.8;12.14;26.6;9.64;11.54;12.2;19.59;5.66;41.21;17.02;26.54;14.26;10;15.13;13.31 1992-12-22;7.69;6.15;24.84;18.13;11.24;3.93;19.61;18.94;25.02;14.86;7.13;20.08;8.16;11.1;13.16;2.76;12.86;26.76;9.87;11.49;12.2;19.28;5.48;41.01;17.13;26.78;14.14;10.13;14.99;13.35 1992-12-23;7.66;6.18;25.46;18.74;11.26;3.97;19.61;18.75;24.94;14.74;7.08;20.38;8.22;11.18;13.24;2.8;12.73;26.25;9.84;11.16;12.36;18.55;5.45;40.91;16.97;26.96;14.28;10.16;15.31;13.31 1992-12-24;7.63;6.27;26.02;19.04;11.24;3.96;19.56;18.89;24.94;14.8;7.09;20.38;8.18;11.24;13.16;2.8;13.11;26.25;9.84;11.14;12.14;18.45;5.45;41.11;17.05;27.21;14.21;10.08;15.37;13.54 1992-12-28;7.58;6.18;25.58;18.86;11.13;4;19.56;18.94;24.79;14.89;7.12;20.46;8.44;11.12;13.4;2.81;12.86;26.6;9.9;10.95;12.42;18.4;5.47;40.76;17.19;26.84;14.14;10.05;15.37;13.94 1992-12-29;7.59;6.18;25.77;19.22;11.26;3.92;19.33;18.8;24.79;14.68;7.07;20.08;8.51;11.2;13.35;2.77;12.36;26.65;9.9;10.89;12.23;18.19;5.41;39.67;17.1;26.41;14.04;10;15.25;13.9 1992-12-30;7.72;6.27;25.65;19.16;11.32;3.94;19.22;18.89;24.79;14.62;7.1;20.08;8.61;11.24;13.24;2.74;12.45;27.06;9.98;10.97;12.14;18.14;5.37;39.77;17.08;26.54;14.19;10.16;15.31;13.7 1992-12-31;7.7;6.21;25.15;19.46;11.11;3.91;18.83;18.45;24.87;14.56;7;19.92;8.61;11.14;13.16;2.7;12.52;27.11;9.94;10.92;12.11;17.88;5.34;39.87;16.94;26.23;14.26;10.11;15.16;13.54 1993-01-04;7.85;6.31;25.03;19.22;11.26;3.94;18.88;18.89;25.1;14.62;7;20.31;8.39;10.83;13.13;2.69;12.45;26.96;9.94;10.7;12.17;18.09;5.32;39.87;16.77;26.05;14.21;10.26;14.9;13.47 1993-01-05;7.86;6.4;25.34;19.4;11.29;3.94;18.49;19.04;25.71;14.77;7.09;20.54;8.62;10.93;12.97;2.83;12.14;26.6;9.78;10.46;12.11;17.78;5.41;39.52;16.14;25.92;14.18;10.4;14.84;13.56 1993-01-06;7.81;6.37;25.65;19.53;11.55;3.98;18.6;18.85;26.09;14.71;7.06;21;8.96;10.48;12.89;3.07;11.93;26.71;9.88;10.14;12.17;17.32;5.56;39.47;15.79;25.44;14.33;10.4;14.45;13.88 1993-01-07;7.8;6.37;25.52;19.53;11.7;4.04;18.27;18.55;26.09;14.68;7.04;20.62;8.68;10.5;12.62;3.1;11.68;26.25;9.69;9.87;12.11;17.11;5.45;39.47;15.95;25.07;14.35;10.26;14.25;13.6 1993-01-08;7.58;6.31;25.46;18.92;11.81;4;18.1;18.26;25.63;14.45;7.02;20.62;8.71;10.44;12.62;3.07;11.55;26.04;9.75;10.11;12.29;17.52;5.45;39.57;16.25;24.33;14.16;10.16;14.07;13.6 1993-01-11;7.62;6.27;25.4;18.56;11.83;3.93;18.32;17.92;27.63;14.42;6.96;21.16;8.96;10.52;12.81;3.18;11.86;25.64;9.88;10.11;12.23;17.83;5.57;39.52;16.28;24.09;14.16;10.13;13.98;13.4 1993-01-12;7.5;6.31;25.46;18.56;11.68;4.01;18.43;17.77;29.24;14.3;6.97;21.16;8.71;10.54;12.86;3.17;12.11;25.69;9.94;10.14;12.14;17.63;5.61;39.08;16.47;24.15;14.23;10.16;14.1;13.36 1993-01-13;7.38;6.31;25.4;18.56;11.55;4.06;18.6;17.96;29.32;14.36;6.94;21;8.78;10.77;12.62;3.42;11.86;25.13;10.07;10.11;12.26;17.88;5.7;39.47;16.2;24.46;14.47;10.08;14.16;13.64 1993-01-14;7.38;6.34;26.02;18.19;11.53;4.2;19.45;17.87;30.16;14.39;6.95;21;9.13;10.91;12.53;3.5;12.11;24.77;10.4;10;12.42;17.32;5.7;39.62;16.2;24.7;14.64;9.95;14.27;14.03 1993-01-15;7.49;6.34;26.26;18.07;11.79;4.21;19.45;18.06;29.7;14.33;6.93;21.39;8.98;10.87;12.59;3.47;11.99;25.13;10.43;10.14;12.29;17.21;5.61;39.67;15.98;24.95;14.47;9.92;14.33;14.15 1993-01-18;7.49;6.46;26.75;18.25;11.76;4.19;19.39;18.41;30.01;14.15;6.93;21.93;8.88;10.91;12.94;3.63;12.3;25.48;10.62;10.11;12.26;17.06;5.58;39.62;15.73;24.64;14.33;9.82;14.19;14.07 1993-01-19;7.41;6.43;26.75;17.95;11.74;4.12;18.88;18.41;30.31;14.03;6.89;22.62;8.88;10.85;12.89;3.57;12.02;25.18;10.72;9.81;12.26;16.8;5.52;39.23;15.51;24.33;14.38;9.87;14.13;13.99 1993-01-20;7.39;6.43;26.57;17.83;11.63;4.18;18.77;18.36;29.85;13.94;6.77;22.39;8.71;10.68;12.91;3.5;11.65;25.18;10.4;9.89;12.2;17.01;5.52;38.93;15.48;24.21;14.04;9.82;14.16;14.03 1993-01-21;7.43;6.37;27.19;17.65;11.32;4.18;18.83;17.82;29.93;13.85;6.84;23.16;8.84;10.66;12.86;3.48;11.52;25.69;10.23;9.95;12.29;17.32;5.59;39.38;15.79;24.21;14.28;9.9;14.1;14.19 1993-01-22;7.55;6.46;26.57;17.52;11.48;4.24;18.43;17.62;30.01;13.85;6.91;23.47;9.04;10.77;12.56;3.47;12.08;25.54;10.27;9.92;12.01;17.47;5.59;38.73;15.87;24.58;14.18;9.98;14.84;13.95 1993-01-25;7.65;6.34;25.77;17.89;11.37;4.27;18.77;17.72;30.55;14.45;6.96;23.24;9.07;10.91;12.67;3.5;12.14;25.74;10.17;9.73;12.08;17.01;5.53;39.57;15.98;25.07;14.18;10;15.31;13.68 1993-01-26;7.65;6.02;25.89;17.22;11.68;4.28;18.94;18.06;30.93;14.59;6.97;23.63;9.05;10.83;13.02;3.56;12.17;25.94;10.36;9.43;11.98;16.29;5.5;39.08;16.14;24.46;13.99;9.98;15.16;14.55 1993-01-27;7.78;5.8;26.26;16.8;11.84;4.3;18.66;18.01;30.78;14.42;6.93;23.47;8.82;10.62;12.91;3.5;12.33;26.04;10.75;9.57;11.89;16.6;5.39;38.63;16.2;24.27;13.99;9.79;15.25;14.35 1993-01-28;7.98;5.64;26.2;17.1;11.68;4.35;18.55;17.87;30.55;14.68;7;23.32;8.76;10.56;12.75;3.39;12.49;26.55;10.43;9.49;12.11;16.7;5.44;38.78;16.44;24.33;13.87;9.71;15.34;14.51 1993-01-29;8;5.86;26.08;17.1;11.66;4.29;19.05;17.92;30.62;14.56;7.06;23.32;8.87;10.75;12.53;3.32;12.8;26.25;10.46;9.51;12.08;16.65;5.41;38.83;16.42;24.33;13.4;9.84;15.43;14.39 1993-02-01;7.91;6.21;26.63;17.46;11.63;4.37;19.33;18.16;30.47;14.65;7.07;23.55;8.99;10.99;12.7;3.46;13.08;25.89;10.56;9.51;12.23;16.03;5.47;39.13;16.66;24.58;13.67;10.05;15.61;14.39 1993-02-02;7.97;6.21;26.45;17.4;11.79;4.46;18.94;18.41;30.62;14.83;6.96;23.09;8.91;10.95;12.83;3.46;12.95;25.74;10.59;9.41;12.48;15.51;5.56;39.18;16.58;24.46;13.82;9.82;15.7;14.7 1993-02-03;8;6.27;26.69;17.28;12.1;4.61;18.83;18.45;30.24;14.89;7.06;24.17;8.76;10.99;13.46;3.38;12.7;26.6;10.72;9.78;12.45;16.13;5.52;39.92;16.55;24.76;13.82;10.24;15.84;15.02 1993-02-04;8.22;6.27;26.51;16.98;12.25;4.74;18.77;18.45;30.85;14.77;7.1;23.32;8.58;11.01;14.22;3.4;12.77;27.82;10.85;9.87;12.82;15.67;5.31;41.31;16.47;24.89;13.77;10.42;15.79;14.98 1993-02-05;8.39;6.31;26.39;17.28;12.33;4.54;18.55;19.43;31.31;14.74;7.12;23.52;8.44;10.87;14.36;3.32;12.92;28.18;11.04;9.73;12.67;15.82;5.56;43.09;16.53;25.13;13.62;10.29;15.61;14.94 1993-02-08;8.27;6.37;26.57;17.16;12.13;4.58;18.49;19.66;32.77;14.98;7.11;24.14;8.35;10.58;14.03;3.3;13.14;28.13;11.01;9.7;12.54;15.87;5.36;43.19;16.36;25.56;13.55;9.95;15.55;14.94 1993-02-09;8.14;6.27;26.45;17.1;11.97;4.48;18.32;19.51;33;14.89;7.1;23.83;8.3;10.52;13.76;3.44;13.26;27.57;10.91;9.7;12.36;16.13;5.24;43.19;16.09;25.31;13.4;9.95;15.49;14.62 1993-02-10;8.11;6.27;26.57;16.98;11.74;4.55;18.21;19.36;31.93;14.86;7.11;24.37;8.41;10.58;13.98;3.56;12.98;27.62;10.91;9.89;12.48;16.6;5.34;43.29;16.2;25.31;13.5;9.53;15.31;14.74 1993-02-11;8.12;6.31;26.57;16.68;11.94;4.58;18.27;19.46;31.85;14.86;7.08;25.15;8.47;10.64;14.55;3.49;12.7;27.77;10.94;9.78;12.42;16.8;5.33;42.69;16.14;25.56;13.57;9.53;15.13;14.82 1993-02-12;8;6.21;26.63;16.68;11.89;4.52;18.21;19.16;31.77;14.71;6.96;25.23;8.5;10.54;14.12;3.45;12.61;28;10.78;9.78;12.32;16.65;5.23;42.5;16.01;24.89;13.77;9.48;15.16;14.82 1993-02-16;7.76;5.99;25.95;16.37;11.58;4.25;18.27;18.72;30.62;14.8;6.8;23.99;8.33;9.98;14.04;3.29;12.42;26.51;10.43;9.26;12.11;15.62;5.01;41.7;15.46;24.52;13.72;9.27;14.81;14.15 1993-02-17;7.87;6.12;25.77;16.37;11.61;4.27;18.38;18.82;30.39;14.71;6.76;24.61;8.9;10.04;14.17;3.37;12.55;26.82;10.33;9.13;12.05;15.46;5.02;41.11;15.48;24.46;13.72;9.32;14.72;14.19 1993-02-18;7.82;6.02;25.95;16.43;11.68;4.28;18.55;18.32;30.85;14.74;6.71;23.91;9.07;10.25;14.01;3.42;12.55;26.15;10.23;9.02;12.08;15.62;5.1;40.81;15.51;24.21;13.96;9.29;14.66;14.31 1993-02-19;7.69;6.08;26.51;16.31;11.55;4.44;18.77;18.87;30.85;15.31;6.74;24.14;9.22;10.13;14.04;3.59;12.55;26;10.59;8.83;12.29;15.2;4.98;41.55;14.93;24.15;14.09;9.4;14.57;14.19 1993-02-22;7.68;6.12;26.82;16.68;11.61;4.36;18.55;18.87;31.62;15.37;6.81;24.06;9.18;9.86;14.23;3.56;12.73;26.05;10.78;8.5;12.48;15.1;4.8;41.79;14.17;24.4;14.3;9.6;14.39;14.39 1993-02-23;7.7;6.02;26.88;16.8;11.5;4.2;18.6;18.87;31.54;15.13;6.84;22.9;8.9;9.82;14.15;3.52;12.7;26.31;10.49;8.72;12.39;15.51;4.97;41.64;13.97;24.82;14.4;9.49;14.19;13.64 1993-02-24;7.76;6.18;27.74;16.86;11.76;4.26;18.88;18.52;31.23;15.13;6.89;23.44;9.21;10.44;14.28;3.66;12.89;26.67;10.78;9.18;12.32;15.82;5.24;42.04;14.55;24.82;14.4;9.47;14.81;14.03 1993-02-25;7.64;6.08;27.74;16.8;11.74;4.46;19;18.52;32.86;15.16;6.92;23.44;9.36;10.54;14.47;3.67;13.36;26.46;10.72;9.05;12.57;15.82;5.27;41.69;14.41;24.89;14.3;9.6;15.07;14.15 1993-02-26;7.58;6.18;27.56;16.68;12.05;4.43;19.05;18.32;33.25;15.16;6.89;23.13;9.08;10.5;14.39;3.62;13.51;26.31;10.43;9.24;12.57;15.87;5.21;42.14;14.74;25.44;14.5;9.49;15.4;13.99 1993-03-01;7.49;6.21;27.43;16.49;12.02;4.42;18.94;18.22;32.55;15.22;6.83;22.98;9.02;10.35;14.2;3.58;13.6;25.85;10.56;9.32;12.32;16.29;5.09;41.64;14.33;25.8;14.38;9.55;15.64;13.8 1993-03-02;7.58;6.21;27.62;16.55;12.23;4.59;19.39;18.52;32.94;15.37;7;23.52;9.27;10.56;14.34;3.71;13.48;26.05;10.78;9.45;12.73;16.13;5.29;42.29;14.82;25.99;14.62;9.63;16.11;13.92 1993-03-03;7.55;6.27;28.3;16.74;12.31;4.67;19.22;18.72;33.4;15.25;7.01;23.91;9.36;10.6;14.8;3.73;13.73;26;10.81;9.24;12.7;16.03;5.3;41.94;14.63;26.05;14.64;9.6;15.99;14.07 1993-03-04;7.41;6.34;28.23;16.74;12.15;4.56;19.39;18.67;33.48;15.34;6.96;23.68;9.35;10.5;14.58;3.69;13.63;26.41;10.56;8.99;12.82;15.66;5.23;42.29;14.36;26.29;14.64;9.81;15.58;14.15 1993-03-05;7.55;6.46;27.86;16.8;12.2;4.62;19.28;18.47;33.17;15.07;7.02;24.22;9.45;10.44;14.47;3.6;13.73;26.1;10.52;8.78;12.76;15.56;5.17;42.74;14.34;26.23;14.55;9.79;15.52;14.35 1993-03-08;7.78;6.75;28.97;16.74;12.36;4.85;19.67;19.26;33.79;15.37;7.17;24.68;9.61;10.66;14.61;3.7;13.95;27.28;10.78;9.21;13.04;15.87;5.23;43.68;14.11;26.6;14.55;9.94;16.05;14.43 1993-03-09;7.93;7.06;28.91;16.55;12.38;5.42;19.47;18.92;33.87;15.28;7.15;24.92;9.56;10.68;14.66;3.67;14.07;27.28;11.04;9.37;13.1;15.82;5.27;43.68;14.2;26.17;14.4;9.97;16.05;14.35 1993-03-10;7.77;6.84;28.67;16.92;12.31;5.68;19.35;18.97;33.71;15.22;7.19;24.92;9.64;10.62;14.58;3.64;13.88;27.18;11.33;9.73;13.07;16.6;5.31;43.78;14.36;26.17;14.38;10.13;16.11;14.19 1993-03-11;7.66;6.9;28.36;16.8;12.18;5.82;19.3;18.67;33.87;15.1;7.17;24.06;9.61;10.52;14.69;3.63;13.63;26.46;11.17;9.59;13.01;16.29;5.41;43.53;14.56;26.05;14.18;10.1;15.7;14.15 1993-03-12;7.51;7.06;28.17;17.1;12;6;19.07;18.37;33.4;14.92;7.09;23.83;9.53;10.56;14.61;3.66;13.82;26.21;11.01;9.48;12.79;16.23;5.56;43.33;14.45;26.11;13.96;9.84;15.76;14.15 1993-03-15;7.65;6.84;28.67;17.28;12.05;6.03;19.41;18.57;33.4;15.07;7.08;24.14;9.52;10.68;14.77;3.69;13.67;26.67;11.01;9.45;12.95;16.03;5.48;43.33;14.34;25.92;14.09;10;15.81;14.27 1993-03-16;7.64;6.9;28.54;16.98;11.97;5.8;19.47;18.62;33.79;15.25;7.12;23.83;9.58;10.64;14.83;3.72;13.7;26.72;11.14;9.13;13.04;15.66;5.48;43.38;14.34;25.92;14.21;9.94;15.93;14.27 1993-03-17;7.64;6.94;28.23;16.68;12;5.65;19.24;18.42;33.63;15.28;7.14;24.06;9.35;10.58;14.72;3.57;13.54;26.46;10.81;8.78;13.04;15.2;5.34;43.33;14.25;25.68;14.01;9.97;15.83;14.07 1993-03-18;7.66;7.03;28.85;16.74;12.05;5.7;19.35;18.92;34.1;15.46;7.24;24.68;9.39;10.66;14.96;3.6;13.57;26.51;10.75;8.75;13.19;15.09;5.33;43.88;14.22;25.68;14.04;9.84;16.07;14.27 1993-03-19;7.58;7.12;28.85;16.8;12.05;5.47;19.13;18.87;34.72;15.4;7.26;24.68;9.28;10.66;14.86;3.54;13.36;26.67;10.59;8.53;13.29;14.99;5.27;43.73;14.22;25.56;14.04;9.92;15.71;14.11 1993-03-22;7.58;7.12;28.11;16.74;12.15;5.5;18.96;18.77;34.49;15.46;7.28;24.68;8.99;10.52;14.83;3.51;13.32;26.92;10.65;8.59;13.19;14.83;5.21;44.03;14.03;25.31;14.11;10.02;15.65;13.99 1993-03-23;7.46;7.28;28.17;17.16;12.33;5.44;18.73;18.97;34.56;15.4;7.22;24.68;9.19;10.35;15.05;3.5;13.48;26.82;10.49;8.83;13.16;15.35;5.2;43.98;14.06;24.95;14.26;9.92;15.53;13.88 1993-03-24;7.45;7;28.3;16.86;12.38;5.62;18.9;19.16;34.41;15.49;7.36;24.14;8.96;10.11;14.99;3.55;12.7;26.82;10.27;8.59;13.01;14.42;5.39;43.78;13.89;24.64;14.35;9.89;15.47;13.76 1993-03-25;7.42;7.09;28.42;17.16;12.38;5.61;19.24;19.21;35.03;15.64;7.38;23.91;9.18;10.46;14.96;3.59;12.55;26.72;10.3;8.91;13.13;14.73;5.46;43.63;13.64;24.52;14.5;10.18;15.77;13.84 1993-03-26;7.35;7;27.99;16.98;12.36;5.68;18.79;19.41;34.56;15.55;7.35;23.68;9.02;10.35;14.83;3.55;12.77;26.26;10.46;8.59;13.23;14.11;5.41;43.73;13.75;24.15;14.74;10;15.59;13.92 1993-03-29;7.34;6.97;28.11;17.16;12.51;5.65;18.9;19.41;33.79;15.79;7.39;23.91;9.12;10.46;14.64;3.55;12.86;25.85;10.59;8.69;13.35;14.32;5.44;43.93;13.81;24.21;14.84;10.1;15.77;13.76 1993-03-30;7.11;7.06;28.3;17.28;12.51;5.67;19.41;19.41;33.17;15.85;7.44;23.68;9.33;10.29;14.64;3.59;12.42;25.9;10.49;9.13;13.23;14.89;5.69;44.08;14.2;24.33;14.96;10.1;14.76;13.92 1993-03-31;6.97;6.9;27.99;16.98;12.28;5.59;19.24;19.06;33.63;15.76;7.3;23.36;9.38;10.44;14.56;3.57;12.64;25.59;10.48;9.26;13.13;14.68;5.78;43.73;14.2;24.4;15.2;10.02;15.06;14.03 1993-04-01;7.01;7;28.11;16.92;12.28;5.42;19.35;19.11;33.79;15.61;7.34;23.21;9.32;10.29;14.58;3.47;12.89;26;10.58;8.86;13.29;14.26;5.81;43.73;14.22;24.4;15.16;10;14.76;14.03 1993-04-02;6.97;6.87;27.93;16.74;12.13;5.47;18.96;19.21;32.55;15.76;7.29;23.13;8.99;9.98;14.25;3.34;13.08;25.59;10.09;8.72;13.07;14.11;5.61;43.53;10.95;23.78;15.01;9.89;14.47;13.84 1993-04-05;6.91;7.16;27.68;16.92;12.07;5.44;18.51;19.61;32.86;15.96;7.33;23.44;8.98;9.78;14.2;3.42;13.08;25.8;10.35;8.99;12.79;14.16;5.72;43.88;11.06;23.17;15.16;10.05;14.11;13.38 1993-04-06;6.8;7.16;28.3;17.04;12.23;5.36;18.06;19.8;33.09;16.11;7.49;23.83;8.96;9.18;13.82;3.47;12.92;26;10.19;8.69;12.64;14.06;5.61;44.23;10.68;22.87;15.33;10.16;13.16;13.42 1993-04-07;6.74;7.32;28.6;17.59;12.38;5.54;17.83;20;33.71;16.26;7.52;24.37;9.08;9.57;14.12;3.54;12.98;25.54;10.45;8.64;12.51;14.06;5.64;44.43;10.48;22.81;15.13;10.34;13.16;13.11 1993-04-08;6.53;7.32;28.97;17.52;12.41;5.51;17.94;19.76;33.94;16.2;7.54;24.53;9.19;9.55;14.2;3.51;12.49;25.59;10.45;8.37;12.54;13.75;5.56;44.28;10.26;22.87;15.03;10.1;13.7;12.87 1993-04-12;6.69;7.44;29.53;17.83;12.59;5.65;17.77;19.76;34.1;16.38;7.64;24.3;9.32;9.65;14.31;3.65;12.67;25.44;11;8.69;12.73;14.21;5.63;43.98;10.54;23.11;15.33;10.34;14.23;13.22 1993-04-13;6.74;7.48;29.22;17.83;12.7;5.94;17.66;19.9;34.33;16.32;7.63;24.61;9.19;9.82;14.64;3.5;12.27;25.59;11.26;8.56;12.64;14.06;5.55;44.23;10.68;23.54;15.28;10.5;13.75;13.38 1993-04-14;6.77;7.48;28.97;17.83;12.64;6.04;18;19.9;34.25;16.35;7.73;25.23;9.18;9.41;14.8;3.5;12.18;25.85;11.1;8.53;12.36;14;5.56;45.28;10.76;23.6;15.43;10.45;12.92;13.11 1993-04-15;6.82;7.29;29.47;17.95;12.8;5.86;17.89;20.3;34.1;16.2;7.83;24.84;9.1;9.43;14.99;3.47;12.11;26.31;10.71;8.42;12.26;13.75;5.45;45.48;10.81;24.03;15.55;10.47;13.1;13.15 1993-04-16;6.89;7.38;29.59;18.31;12.8;5.79;17.15;21.09;34.18;16.44;7.8;25.15;9.18;9.02;15.35;3.42;12.18;26.62;10.74;8.56;12.17;14.11;5.44;46.33;10.84;23.78;15.82;10.5;12.63;13.07 1993-04-19;6.88;7.29;29.41;18.25;12.93;5.68;17.21;20.84;34.41;16.17;7.78;24.61;9.02;9.13;15.07;3.04;12.24;26.62;10.55;9.02;11.83;14.89;5.44;45.93;10.81;23.42;15.84;10.66;12.69;13.22 1993-04-20;6.97;7.09;28.54;17.95;12.81;5.59;17.38;20.6;34.02;15.87;7.73;24.3;9.04;8.97;14.8;3.14;12.58;27.43;10.45;9.24;11.67;15.56;5.42;45.13;10.9;23.23;15.77;10.4;12.51;13.11 1993-04-21;7.12;7.25;28.3;18.19;12.96;5.51;17.6;20.35;34.1;15.79;7.61;24.14;9.21;9.27;14.5;3.19;12.21;27.33;10.32;9.18;11.86;15.25;5.3;45.63;10.81;23.11;15.62;10.21;12.63;12.83 1993-04-22;7.03;7.19;28.17;18.37;14.05;5.54;17.55;20.45;33.87;15.7;7.56;23.99;9.18;9.27;14.15;2.98;12.05;27.43;10.16;8.83;11.64;14.58;5.2;45.83;10.59;23.11;15.25;10.4;12.69;12.71 1993-04-23;6.91;7.44;27.68;18.43;13.92;5.51;17.55;20.5;33.56;15.31;7.63;25.15;9.05;9.16;14.47;2.88;11.86;26.92;9.83;8.67;11.46;14.94;5.09;45.18;10.43;23.17;15.21;10.5;12.69;12.79 1993-04-26;7.07;7.22;27.62;18.13;13.95;5.04;17.89;20.89;33.09;15.34;7.54;24.61;8.71;8.97;13.9;2.72;12.02;26.92;9.57;8.61;11.46;14.99;5.02;44.78;10.37;23.48;15.43;10.45;12.63;12.95 1993-04-27;7.11;7.19;27.74;18.37;13.95;5.33;17.89;20.69;32.47;15.58;7.58;25.07;8.9;9.24;13.68;2.86;12.02;26.92;9.83;9.29;11.83;15.4;5.16;44.53;10.18;23.91;15.3;10.4;12.87;12.91 1993-04-28;7.05;7.06;28.05;18.13;13.98;5.42;17.77;20.94;29.29;15.67;7.4;26.31;8.99;9.3;13.6;2.94;12.39;26.77;9.93;9.26;11.92;15.51;5.38;44.38;10.12;23.54;14.94;10.42;12.75;12.99 1993-04-29;7.14;7.22;27.68;18.43;14.34;5.38;17.94;20.94;29.99;15.73;7.51;25.46;9.08;9.19;13.87;2.98;12.14;26.77;10.03;9.21;11.77;15.35;5.34;44.53;10.48;23.6;15.06;10.4;12.69;13.07 1993-04-30;7.15;7.13;27.56;18.43;14.42;5.57;17.77;20.6;30.22;15.73;7.42;25.38;9.22;9.3;14.25;2.96;12.08;26.92;9.93;9.48;11.95;15.35;5.34;44.43;10.43;24.03;15.18;10.45;12.69;12.87 1993-05-03;7.1;7.13;27.99;18.37;14.34;5.45;17.89;20.6;30.77;15.79;7.44;26.31;9.21;9.38;14.2;3.02;12.24;26.97;9.96;9.75;12.36;15.87;5.38;45.33;10.54;23.97;15.23;10.53;12.45;12.71 1993-05-04;7.03;7.19;28.11;18.68;14.24;5.53;17.77;20.55;31;15.61;7.35;26;9.33;9.43;14.09;3.15;12.24;27.08;10.25;9.56;12.2;15.92;5.5;45.23;10.54;24.09;15.23;10.34;12.75;12.71 1993-05-05;6.99;7.06;28.23;18.92;14.31;5.5;17.72;20.94;30.84;15.46;7.56;25.54;9.39;9.71;14.23;3.16;12.27;26.56;9.99;9.7;12.14;15.87;5.58;45.18;10.68;24.03;15.06;10.55;12.69;12.44 1993-05-06;6.99;7.25;28.11;19.16;14.26;5.45;17.55;20.6;30.3;15.58;7.66;24.99;9.5;9.65;14.04;3.15;11.99;26.62;9.86;9.48;12.14;15.56;5.45;45.68;10.9;23.48;14.86;10.85;12.63;12.16 1993-05-07;6.92;7.09;27.8;18.92;14.13;5.41;17.49;20.55;30.69;15.28;7.72;24.96;9.78;9.76;13.74;3.17;12.08;26.87;9.77;9.4;12.17;15.4;5.44;45.63;11.31;24.03;14.64;10.9;12.45;12.24 1993-05-10;6.88;7.06;27.62;18.56;14.34;5.57;17.66;20.52;31.39;15.16;7.71;25.35;9.68;9.65;13.76;3.19;12.14;26.72;9.93;9.54;12.17;15.66;5.57;44.93;11.7;23.97;14.79;10.93;12.39;12.47 1993-05-11;7;7.22;27.68;18.92;14.52;5.62;18.11;20.37;31.85;15.19;7.62;25.67;9.67;9.63;13.87;3.09;12.14;27.13;10.25;9.75;12.23;15.61;5.48;45.58;11.42;24.21;14.96;10.95;12.33;12.63 1993-05-12;7.18;7.13;27.43;19.1;14.55;5.64;17.94;20.37;32.86;15.28;7.65;25.74;9.62;9.65;13.98;3.05;11.93;27.33;10.22;9.51;12.32;15.25;5.39;45.93;11.09;24.34;14.94;10.93;12.81;12.51 1993-05-13;7.18;7;26.57;19.16;14.63;5.54;17.72;20.72;32.24;15.13;7.56;25.12;9.39;9.38;13.9;3.04;11.8;27.08;9.67;9.26;12.14;15.04;5.36;45.58;11.23;23.91;14.84;10.98;12.63;12.24 1993-05-14;7.15;7;27.06;19.34;14.47;5.38;18;20.52;31.85;15.19;7.64;24.5;9.67;9.41;14.01;3.03;11.9;26.97;9.51;9.46;12.08;15.51;5.34;45.13;11.29;24.09;14.86;10.98;12.92;12.44 1993-05-17;7.25;6.94;27.31;19.46;14.37;5.39;18.11;20.47;32.01;15.34;7.67;24.89;9.81;9.35;14.1;3.08;11.83;26.79;9.38;9.56;12.01;16.03;5.41;45.26;11.31;24.09;14.76;11.1;12.87;12.51 1993-05-18;7.34;7.06;28.36;19.4;14.16;5.44;18.06;20.32;31.77;15.31;7.56;24.5;10.44;9.74;14.07;3.15;12.18;26.68;9.34;9.56;11.89;15.92;5.53;45.36;11.23;24.03;14.71;11.07;12.75;12.63 1993-05-19;7.48;7.22;29.71;19.65;14.31;5.48;18.68;20.67;32.24;15.4;7.64;24.81;10.78;10.15;14.37;3.25;12.33;27.15;9.7;9.81;12.45;16.13;5.78;45.72;11.29;24.58;14.91;11.13;13.22;13.11 1993-05-20;7.4;7.35;29.59;19.71;14.5;5.62;19.01;20.87;32.55;15.55;7.62;24.89;10.69;10.34;14.46;3.24;12.24;27.09;9.8;9.95;12.51;16.23;5.88;46.37;11.17;24.76;14.86;11.4;13.52;13.9 1993-05-21;7.36;7.19;29.16;19.4;14.39;5.61;18.51;20.67;32.55;15.43;7.55;24.65;10.3;10.2;14.51;3.22;12.02;26.99;9.47;9.87;12.48;15.82;5.78;46.32;11.12;24.58;14.76;11.48;12.98;13.58 1993-05-24;7.38;7.16;29.84;19.46;14.44;5.57;18.51;20.82;32.7;15.49;7.6;24.89;10.55;10.09;14.54;3.23;12.36;27.04;9.57;9.87;12.48;15.92;5.76;45.87;11.2;24.4;14.69;11.45;13.28;13.97 1993-05-25;7.53;7.22;30.58;19.53;14.55;5.56;18.56;20.97;32.86;15.49;7.56;24.81;10.27;10.15;14.65;3.23;12.52;27.61;9.7;9.76;12.42;15.82;5.7;45.87;11.31;24.34;14.69;11.1;13.46;13.86 1993-05-26;7.48;7.32;30.58;19.4;14.65;5.74;18.73;21.22;33.02;15.4;7.62;25.04;10.62;10.26;14.7;3.44;13.11;27.66;10.19;9.92;12.42;16.18;5.95;46.02;11.45;24.4;14.94;11.29;13.34;14.01 1993-05-27;7.51;7.38;30.39;19.34;15.15;5.74;18.62;21.27;32.63;15.46;7.69;24.89;10.45;10.23;14.7;3.5;13.23;28.02;9.96;9.67;12.32;15.66;5.88;45.92;11.23;23.97;15.03;11.53;13.16;14.01 1993-05-28;7.34;7.32;30.33;19.22;14.91;5.62;18.73;21.02;32.39;15.61;7.6;25.04;10.27;10.18;14.65;3.45;13.11;27.51;9.96;9.76;12.36;15.87;5.79;45.42;11.17;24.03;15.08;11.32;13.22;13.9 1993-06-01;7.45;7.25;30.58;19.28;15.46;5.62;18.73;21.17;32.31;15.52;7.7;25.2;10.55;10.2;14.51;3.59;12.92;27.46;10.12;9.78;12.45;15.82;6.02;45.87;11.31;24.15;15.18;11.37;13.34;13.9 1993-06-02;7.55;7.19;30.58;19.28;15.56;5.71;18.79;21.02;31.84;15.46;7.7;25.2;10.58;10.2;14.43;3.57;13.39;27.3;9.86;9.67;12.51;15.56;5.98;46.27;11.17;24.21;15.13;11.4;13.46;13.78 1993-06-03;7.55;7.32;30.33;19.22;15.41;5.65;18.62;20.82;31.77;15.49;7.71;25.59;10.69;10.04;14.37;3.54;13.39;27.76;9.83;9.54;12.76;15.4;5.91;46.52;11.17;23.91;15.18;11.42;13.04;13.9 1993-06-04;7.59;7.35;30.45;19.22;15.56;5.57;18.56;20.77;32.39;15.55;7.69;25.9;10.72;9.79;14.4;3.5;13.42;27.4;9.64;9.37;12.57;15.3;5.88;46.47;11.12;23.6;15.13;11.29;12.69;13.97 1993-06-07;7.55;7.29;30.64;18.86;15.72;5.33;18.51;20.97;32.24;15.58;7.67;25.9;10.52;9.32;14.54;3.61;12.98;26.94;9.21;9.37;12.29;15.3;5.83;46.82;11.09;23.54;15.08;11.29;12.63;13.94 1993-06-08;7.46;7.19;30.52;18.56;15.67;5.38;18.34;20.87;31.92;15.79;7.65;25.28;10.45;9.46;14.51;3.52;12.98;26.63;9.41;9.4;12.23;15.25;5.77;46.67;10.98;23.36;14.98;11.26;12.58;13.82 1993-06-09;7.37;7.25;30.33;18.8;15.43;5.35;18.07;20.87;31.3;16.05;7.65;25.59;10.62;9.49;14.51;3.47;13.14;26.89;9.67;9.48;12.29;15.35;5.69;46.57;10.85;23.3;15.33;11.29;12.64;13.66 1993-06-10;7.33;7.38;30.33;18.62;15.64;5.33;18.58;20.92;31.69;15.96;7.65;25.67;10.44;9.68;14.73;3.4;13.04;26.37;9.7;9.73;12.39;15.72;5.7;42.55;10.93;23.42;15.18;11.24;12.52;13.62 1993-06-11;7.22;7.57;30.64;18.86;15.8;5.36;18.92;20.57;32;15.55;7.72;25.43;10.62;9.57;14.73;3.51;13.04;26.58;9.99;9.78;12.42;16.13;5.59;43.66;11.15;23.36;15.33;11.24;12.88;13.78 1993-06-14;7.25;7.48;31.13;18.86;16.19;5.56;18.98;20.52;33.64;15.61;7.61;25.28;10.78;9.49;14.73;3.55;12.92;26.53;10.09;9.81;12.33;16.29;5.77;43.86;11.13;23.6;15.33;11.29;12.82;13.7 1993-06-15;7.12;7.54;31.19;19.04;16.16;5.5;18.98;19.82;32.78;15.43;7.71;25.12;10.72;9.52;14.73;3.59;12.39;26.17;10.09;9.84;12.01;15.87;5.78;43.25;11.04;23.6;15.13;11.34;12.58;13.82 1993-06-16;7.15;7.57;30.64;19.1;16.06;5.5;19.04;19.77;33.41;15.79;7.81;25.74;10.3;9.41;14.65;3.51;12.52;26.06;10.12;9.89;12.17;16.08;5.7;43.71;11.07;23.85;14.98;11.34;12.23;13.66 1993-06-17;7.26;7.63;30.76;18.8;16.11;5.5;19.15;20.02;33.17;15.99;7.8;25.98;9.98;9.27;14.35;3.49;12.33;26.68;10.25;10;12.33;16.13;5.68;43.71;10.87;23.97;14.98;11.53;12.29;13.66 1993-06-18;7.34;7.63;30.21;18.8;16.08;5.45;18.81;19.97;33.33;15.67;7.77;26.06;9.89;9.41;14.32;3.44;12.27;26.94;10.09;9.37;12.29;15.45;5.47;43.05;10.85;23.97;14.74;11.53;11.93;13.46 1993-06-21;7.36;7.54;30.33;18.68;15.77;5.54;18.7;19.87;33.49;15.61;7.8;26.76;10.02;9.27;14.68;3.53;12.24;26.99;10.42;9.29;12.23;15.45;5.54;43.6;10.76;24.15;14.89;11.69;11.93;13.46 1993-06-22;7.38;7.67;30.52;18.56;15.46;5.57;18.64;19.72;33.1;15.76;7.78;27.23;10.04;9.13;14.48;3.45;12.24;26.58;10.61;9.07;12.05;15.14;5.5;43.66;10.76;24.21;14.89;11.69;11.81;13.46 1993-06-23;7.36;7.83;30.7;18.8;15.17;5.54;18.92;18.93;31.84;15.55;7.86;26.84;9.79;9.21;14.48;3.42;12.08;26.27;10.32;8.96;12.08;15.04;5.54;43.45;10.9;24.09;14.84;11.9;12.29;12.79 1993-06-24;7.45;7.83;30.7;18.56;15.15;5.97;19.32;19.28;31.61;15.61;7.82;26.91;9.95;9.41;14.59;3.34;12.11;26.37;10.55;9.15;12.14;15.19;5.53;43.5;11.01;24.58;14.74;11.82;12.58;13.22 1993-06-25;7.44;7.86;30.7;18.56;15.12;6.04;19.32;19.08;31.92;15.58;7.76;26.91;10.19;9.43;14.48;3.4;12.36;26.48;10.61;9.18;12.26;15.25;5.53;43.35;11.01;24.46;14.69;11.77;12.64;13.15 1993-06-28;7.42;7.95;30.89;18.31;15.67;6.38;19.6;19.23;31.92;15.76;7.81;27.69;10.27;9.52;15.17;3.48;12.52;26.37;10.87;9.02;12.39;14.98;5.64;43.45;11.04;24.89;14.94;11.66;12.7;13.26 1993-06-29;7.51;8.02;30.95;18.19;15.51;6.32;19.66;18.93;31.37;15.55;7.83;27.46;10.09;9.52;14.84;3.51;12.27;25.96;10.69;9.18;12.29;15.35;5.56;43.3;11.07;25.25;14.98;11.61;12.47;12.99 1993-06-30;7.61;8.21;31.07;17.95;15.59;6.38;19.49;18.78;31.3;15.76;7.84;27.77;9.98;9.63;14.65;3.42;12.27;26.37;10.69;9.07;12.2;14.83;5.5;43.45;10.85;25.44;15.23;11.56;12.47;12.87 1993-07-01;7.85;7.95;30.95;17.95;15.41;6.29;19.49;18.73;31.53;15.52;7.79;27.46;9.82;9.54;14.46;3.36;12.24;26.94;10.63;8.83;12.17;14.62;5.45;43.5;10.87;25.31;15.52;11.29;12.23;12.87 1993-07-02;7.78;7.95;30.7;17.83;15.23;6.12;19.38;18.88;31.61;15.4;7.83;27.23;9.92;9.6;14.37;3.35;11.99;26.58;10.43;8.72;12.2;14.41;5.45;43.4;10.82;25.19;15.43;11.21;12.17;12.89 1993-07-06;7.64;7.95;30.21;17.71;15.3;6.07;18.98;18.43;31.37;15.25;7.75;27.54;9.3;9.24;14.1;3.31;11.65;26.37;10.53;8.66;12.14;14.31;5.38;42.95;10.62;24.95;15.53;11.05;12.05;12.65 1993-07-07;7.66;8.05;30.33;17.65;15.59;6.27;19.43;18.68;31.61;15.31;7.75;27.85;9.52;9.35;14.43;3.27;11.59;25.96;10.56;8.66;12.14;14.31;5.21;42.95;10.68;25.37;15.43;11.26;12.11;12.26 1993-07-08;7.64;7.92;30.58;18.01;15.64;6.48;19.77;19.03;32.08;15.34;7.95;29.25;9.7;9.52;14.57;3.4;11.59;26.27;10.63;8.77;12.17;14.51;5.3;43;10.87;25.62;15.67;11.32;12.58;12.26 1993-07-09;7.78;7.95;30.52;18.13;15.64;6.33;19.66;19.03;32.47;15.22;7.95;29.64;9.72;9.41;14.57;3.48;11.59;26.27;10.56;8.69;12.11;14.51;5.29;43.1;11.04;25.56;15.62;11.61;12.47;12.41 1993-07-12;7.67;8.05;30.89;18.13;15.85;6.54;20.06;18.98;32.16;15.37;7.98;29.25;9.82;9.52;14.57;3.46;11.96;26.27;10.6;8.72;12.14;14.41;5.23;43.05;11.13;25.92;15.67;11.66;12.41;11.9 1993-07-13;7.68;8.15;30.7;18.19;15.9;6.35;19.83;19.43;32;15.43;8.03;29.25;9.65;9.87;14.62;3.39;11.83;26.01;10.33;8.88;12.08;14.41;5.17;42.95;11.04;25.19;15.62;11.8;12.52;11.82 1993-07-14;7.76;8.18;30.89;18.31;15.96;6.24;20.11;19.58;32.08;15.4;8.08;29.64;9.64;9.82;14.76;3.32;11.77;26.43;10.2;8.85;12.29;14.51;5.27;43.35;11.21;25.68;15.58;11.85;12.64;12.02 1993-07-15;7.79;8.11;31.56;18.19;16.09;6.29;20.17;19.38;32.16;15.31;8.1;29.8;9.35;9.79;14.92;3.28;11.8;26.43;10.4;8.66;12.36;14.1;5.22;44.26;11.21;25.25;15.87;11.74;12.58;11.98 1993-07-16;7.63;8.15;31.13;18.13;16.27;6.24;20;19.48;31.92;15.13;8.18;29.8;9.27;9.63;15.06;3.14;11.34;26.58;10.43;8.58;12.29;13.84;5.07;44.41;10.73;24.7;15.92;11.42;12.41;11.94 1993-07-19;7.66;8.24;31.69;18.25;16.61;6.35;20.11;19.48;31.69;15.43;8.15;29.8;9.08;9.46;15.22;3.16;10.84;26.63;10.4;8.64;12.26;13.42;4.92;44.36;10.82;24.34;15.92;11.13;12.35;11.58 1993-07-20;7.67;8.18;31.87;18.43;16.27;6.47;20.23;19.43;32.24;15.28;8.12;30.5;9.3;9.46;15.28;3.23;10.65;26.48;10.4;8.69;12.11;13.89;5.03;44.26;10.9;24.58;15.92;11.4;12.23;11.58 1993-07-21;7.61;8.31;31.93;18.49;16.32;6.54;20.06;19.68;31.92;15.28;8.11;30.19;9.33;9.49;15.31;3.18;10.84;26.63;10.56;8.36;12.17;13.78;4.94;44.76;10.71;24.34;16.02;11.74;12.17;11.51 1993-07-22;7.56;8.27;31.5;18.19;16.19;6.35;19.83;19.58;31.92;15.28;8.03;29.72;9.27;9.35;15.14;3.11;10.78;26.37;10.43;8.31;12.11;13.52;4.85;43.76;10.65;23.91;15.97;11.72;11.93;11.74 1993-07-23;7.67;8.37;31.32;18.31;16.74;6.48;19.94;19.38;32.24;15.52;8.01;29.18;9.52;9.54;15.14;3.22;10.5;26.63;10.53;8.39;12.08;13.63;4.85;43.96;10.65;23.78;15.97;11.72;12.05;12.41 1993-07-26;7.72;8.79;31.87;18.74;16.64;6.48;19.83;19.68;32;15.64;8.09;29.72;9.35;9.6;15.22;3.29;10.53;26.99;10.66;8.36;12.11;13.42;4.89;44.21;10.51;23.66;16.02;11.74;12.05;12.57 1993-07-27;7.89;8.72;31.69;18.74;16.48;6.48;19.72;19.38;31.92;15.87;8.05;29.33;9.28;9.46;15.31;3.3;11.34;26.73;10.53;8.31;12.39;13.42;4.72;44.01;10.65;24.27;15.97;11.64;11.87;12.65 1993-07-28;8.01;8.5;31.56;18.68;16.25;6.51;19.77;18.83;32.78;15.85;8.01;29.33;9.12;9.74;15.12;3.33;10.93;26.53;10.69;8.23;12.7;12.84;4.89;43.6;10.59;24.03;15.92;11.69;11.93;12.57 1993-07-29;7.8;8.5;31.69;18.98;16.14;6.59;19.94;18.98;33.72;15.76;8.09;29.64;8.75;9.82;15.66;3.3;10.9;26.43;10.76;8.03;12.95;12.74;4.94;43.76;10.65;24.15;16.12;11.69;12.23;12.22 1993-07-30;7.75;8.37;31.26;19.1;16.04;6.54;19.6;18.68;33.57;15.64;8.07;30.27;8.87;9.71;15.39;3.25;11.06;26.27;10.79;7.98;12.79;12.79;4.62;42.25;10.59;23.85;16.07;11.61;12.05;11.86 1993-08-02;7.85;8.47;31.44;18.92;16.3;6.57;19.72;18.68;33.88;15.73;8.11;30.97;8.95;10.07;15.64;3.27;10.9;26.43;10.73;8.17;12.85;12.84;4.55;42.8;10.48;23.78;15.97;11.96;12.17;11.82 1993-08-03;8.04;8.63;31.19;18.86;16.66;6.67;19.66;18.63;34.27;15.52;8.08;30.74;9.15;10.09;15.77;3.3;10.78;26.63;10.89;8.25;12.85;13;4.56;42.5;10.68;23.66;15.82;12.2;12.05;11.82 1993-08-04;8.01;8.72;31.01;18.56;16.66;6.65;19.38;18.43;34.43;15.37;8.05;30.74;8.75;10.29;15.86;3.42;11.03;26.68;11.05;8.23;12.76;12.95;4.56;42.65;10.56;23.42;15.87;11.98;12.11;11.54 1993-08-05;7.93;8.59;31.07;18.49;16.48;6.57;19.55;18.48;34.66;15.25;8.15;30.35;8.75;10.18;16.05;3.47;10.87;26.37;11.05;8.09;12.82;12.84;4.67;43.05;10.42;23.17;16.02;12.14;12.29;11.54 1993-08-06;7.84;8.53;30.82;18.86;16.46;6.67;19.32;18.53;36.69;15.43;8.14;29.8;8.81;10.18;16.05;3.56;10.78;27.2;10.99;8.2;12.79;12.84;4.58;43.05;10.56;23.17;16.12;12.2;12.23;11.62 1993-08-09;7.78;8.69;31.07;18.98;16.56;6.88;19.55;18.56;37.48;15.4;8.14;30.42;9.05;10.23;16.1;3.59;10.72;27.15;10.99;8.03;13.04;12.79;4.56;42.9;10.54;23.17;16.12;12.36;12.11;11.82 1993-08-10;7.94;8.59;31.26;18.8;16.85;6.88;19.38;18.71;37.95;15.46;8.11;30.27;8.9;10.07;16.05;3.54;10.75;26.99;10.86;7.98;13.04;12.53;4.44;43;10.31;22.62;16.32;12.39;11.87;11.74 1993-08-11;7.93;8.5;31.19;18.86;17.19;6.8;19.83;18.96;38.34;15.34;8.09;29.96;8.99;10.23;16.16;3.65;10.5;27.09;10.83;7.84;13.13;12.37;4.52;43.66;10.4;22.68;16.37;12.63;12.17;11.66 1993-08-12;7.89;8.53;30.82;18.8;16.98;6.79;19.26;18.76;37.56;15.4;8.04;29.64;9.07;10.2;16.16;3.66;10.37;27.09;10.79;8.01;12.95;12.06;4.62;43.3;10.4;22.5;16.62;12.52;12.11;11.9 1993-08-13;7.84;8.5;30.76;18.62;16.98;6.77;19.38;19.36;37.87;15.46;7.98;28.67;9.25;10.2;16.08;3.71;10.34;27.09;10.86;8.12;13.26;12.01;4.7;43.71;10.4;22.26;16.67;12.68;12.11;11.9 1993-08-16;8.08;8.56;29.96;18.49;16.82;6.73;19.04;19.76;38.26;15.43;8.01;29.46;9.27;10.26;16.03;4;10.19;27.22;10.66;8.2;13.54;12.32;4.86;43.38;10.45;22.62;16.67;12.67;11.99;12.37 1993-08-17;8.12;8.37;30.02;18.62;16.77;6.68;19.26;19.86;37.71;15.19;7.95;29.14;9.12;9.85;16.17;4.04;10.68;27.22;10.47;8.48;13.44;12.9;4.83;43.84;10.87;23.11;16.57;12.7;11.99;12.34 1993-08-18;8.15;8.63;29.41;18.92;16.95;6.65;19.38;19.81;37.79;15.28;7.96;27.81;9.07;9.32;16.03;4.07;10.62;27.37;10.47;8.81;13.57;13.57;4.83;43.79;11.27;24.03;16.62;12.67;12.11;12.3 1993-08-19;8.14;8.56;28.73;19.28;16.95;6.83;19.83;19.76;37.71;15.37;7.92;28.52;9.18;8.97;16.22;3.98;10.68;27.32;10.33;8.89;13.6;13.84;4.64;44.14;11.38;23.97;16.42;12.53;12.29;12.22 1993-08-20;8.14;8.43;28.91;19.16;16.85;6.7;19.72;19.76;37.56;15.43;8.08;27.97;9.05;9.16;16.19;3.96;10.72;28;10.3;9.03;13.63;13.68;4.77;43.69;11.3;24.03;16.62;12.51;12.47;12.53 1993-08-23;8.16;8.43;28.6;19.1;16.82;6.77;19.77;19.51;38.1;15.4;8.01;28.28;9.16;9.02;16;3.99;11.03;27.74;10.33;8.89;13.47;13.57;4.81;43.59;11.15;23.48;16.47;12.43;12.35;12.26 1993-08-24;8.29;8.43;29.28;18.98;17.19;6.85;20;19.66;38.34;15.52;8.08;29.3;9.24;9.05;16.11;3.95;10.9;28.2;10.56;8.81;13.6;13.47;4.74;43.48;11.49;23.72;16.96;12.45;12.47;12.3 1993-08-25;8.37;8.63;29.78;19.04;17.21;6.91;19.55;19.61;38.81;15.7;8.09;29.3;9.24;9.13;16.44;3.89;10.93;28.15;10.56;8.75;13.57;13.26;4.64;43.84;10.99;23.78;16.86;12.53;12.29;12.37 1993-08-26;8.41;8.5;29.96;18.92;17.19;7.04;19.43;19.56;38.81;15.79;8.09;29.85;9.1;8.94;16.33;3.94;10.93;27.79;10.63;8.89;13.47;13.63;4.51;43.94;10.79;23.42;17.56;12.48;12.29;12.45 1993-08-27;8.29;8.37;30.95;18.86;17.13;6.91;19.43;19.41;38.73;15.58;8.03;29.53;8.99;9.05;16.25;3.96;10.96;27.22;10.63;8.89;13.35;13.73;4.49;44.4;10.87;23.36;17.56;12.43;12.35;12.73 1993-08-30;8.3;8.37;30.82;18.92;17.05;6.99;19.55;19.41;38.49;15.52;8.07;29.46;9.02;9.16;16.3;3.98;11.09;27.27;10.56;8.92;13.47;13.31;4.54;44.3;10.9;23.36;17.96;12.37;12.29;12.57 1993-08-31;8.22;8.34;31.01;19.22;17.16;7.17;19.66;19.56;38.49;15.58;8.05;29.38;9.13;9.41;16.47;3.99;11.37;27.01;10.63;8.97;13.35;13.31;4.7;44.45;10.96;23.66;18.06;12.26;12.24;12.41 1993-09-01;8.22;8.4;31.13;19.22;17.11;7.25;19.32;19.31;37.78;15.52;8.04;29.22;8.99;9.27;16.33;3.95;11.4;26.6;10.47;8.89;13.44;13.31;4.8;44.09;10.96;23.97;18.06;12.43;12.24;12.34 1993-09-02;7.99;8.5;31.01;19.22;16.85;7.11;19.32;19.36;37.7;15.34;7.99;28.59;9.02;9.16;16.17;3.92;11.43;26.02;10.47;9;13.41;13.96;4.79;43.74;10.9;23.78;18.06;12.37;11.77;12.3 1993-09-03;8.14;8.59;30.89;19.22;16.69;7.17;19.55;19.41;37.86;15.61;7.97;28.2;8.96;8.97;16.14;3.9;11.37;26.18;10.6;8.78;13.5;13.85;4.73;43.59;10.87;23.97;17.86;12.08;11.65;12.41 1993-09-07;7.99;8.5;30.45;19.34;16.51;7.07;19.49;19.06;37.78;15.49;7.95;28.05;8.76;9.02;16.19;3.85;11.31;26.13;10.73;8.67;13.5;13.59;4.67;43.33;10.87;23.78;17.81;12.16;11.53;12.3 1993-09-08;7.84;8.47;30.45;19.16;16.51;6.87;19.55;19.46;37.23;15.61;7.89;28.05;8.42;8.99;15.89;3.92;11.03;26.13;10.73;8.45;13.44;13.38;4.66;43.28;10.85;24.09;17.91;12;11.47;12.34 1993-09-09;7.89;8.59;30.08;19.34;16.74;7.07;19.62;19.16;37.7;15.46;7.85;28.83;8.53;9.02;15.64;4.03;11.03;25.82;11.28;8.53;13.29;13.48;4.77;43.13;10.91;23.54;17.76;12.13;11.53;12.14 1993-09-10;7.84;8.69;29.9;19.59;16.64;7.27;20.02;19.26;38.18;15.64;7.92;29.3;8.71;9.19;16.08;4.07;10.87;25.87;11.51;8.53;13.47;13.43;4.88;43.18;10.91;23.48;18.5;12.43;11.65;12.65 1993-09-13;7.81;8.72;29.84;19.59;16.74;7.37;20.25;19.91;38.81;15.58;7.93;29.77;8.53;8.86;16.03;4.03;10.9;25.82;11.25;8.5;13.66;13.22;4.77;43.64;10.88;23.42;18.4;12.37;11.59;12.89 1993-09-14;7.79;8.59;29.71;19.4;16.64;7.51;20.08;19.56;38.49;15.61;8.03;28.67;8.47;7.98;15.95;3.93;10.81;25.82;11.35;8.67;13.54;13.54;4.7;43.53;10.71;23.36;18.11;12.26;11.47;12.85 1993-09-15;7.82;8.72;29.59;19.46;16.59;7.61;19.97;19.76;39.04;15.76;8.04;29.61;8.47;7.81;15.92;4.03;10.84;26.08;11.35;8.59;13.75;13.48;4.78;43.99;10.82;23.36;17.96;12.48;11.47;12.37 1993-09-16;7.94;8.69;29.04;19.34;16.61;7.59;19.68;19.56;38.97;15.61;8.05;29.38;8.35;8.22;16.14;3.98;10.81;25.92;11.32;8.53;13.41;13.38;4.75;43.99;10.94;23.54;17.76;12.43;11.41;12.41 1993-09-17;7.82;8.72;29.22;19.34;16.66;7.63;19.8;19.66;37.78;15.49;8.09;28.67;8.36;8.28;16.17;3.99;10.78;26.08;11.35;8.61;13.35;13.22;4.75;43.69;10.77;23.48;17.46;12.37;11.35;12.45 1993-09-20;7.52;8.88;29.04;19.4;16.48;7.63;19.45;19.26;37.78;15.43;7.97;28.75;8.01;8.06;16.3;4.05;10.5;25.45;11.45;8.34;13.16;12.85;4.73;42.98;10.57;23.17;17.26;12.29;11.29;12.22 1993-09-21;7.32;8.72;28.85;19.34;16.09;7.43;19.34;19.11;37.31;15.52;7.9;28.12;8.25;7.98;15.89;4.06;10.47;24.99;11.28;8.56;12.91;13.27;4.75;42.47;10.65;22.99;17.01;12.08;11.17;12.14 1993-09-22;7.45;8.82;28.97;19.1;16.22;7.66;19.45;18.91;37.15;15.46;7.91;28.59;8.41;8.09;16.08;4.18;10.4;24.94;11.38;8.64;13.04;13.27;4.83;42.32;10.57;22.5;17.21;12.08;11.53;12.14 1993-09-23;7.37;8.95;29.34;19.04;16.06;7.82;19.45;19.01;36.36;15.37;7.89;28.91;8.48;8.17;16.08;4.25;10.4;24.63;11.54;8.72;13.13;13.43;4.92;42.07;10.6;22.68;17.16;11.97;11.89;12.18 1993-09-24;7.44;9.17;29.28;18.86;16.3;7.84;19.4;18.91;36.68;15.61;7.77;28.91;8.44;8.33;15.75;4.27;10.37;24.63;11.58;8.61;13.1;13.33;5;41.86;10.54;23.11;16.57;11.94;11.71;12.14 1993-09-27;7.53;9.24;29.65;19.04;16.51;7.92;19.57;19.16;36.99;15.61;7.91;28.36;8.61;8.47;15.64;4.38;10.37;24.52;11.74;8.72;13.26;13.17;5.14;41.96;10.37;23.48;17.06;11.86;11.89;12.22 1993-09-28;7.42;9.36;29.34;18.92;16.56;8;19.45;18.86;37.07;15.64;7.85;28.2;8.47;8.64;15.7;4.52;10.37;24.63;11.81;8.64;13.29;13.01;5.25;42.07;10.51;23.17;17.21;11.86;11.65;12.1 1993-09-29;7.32;9.24;29.22;18.86;16.48;7.94;19.28;18.96;37.15;15.87;7.81;27.5;8.36;8.55;15.95;4.55;10.34;24.83;11.74;8.7;13.04;12.9;5.19;41.71;10.45;23.05;17.01;12.08;11.47;12.02 1993-09-30;7.34;9.2;29.04;18.62;16.48;7.72;19.23;18.71;37.47;15.61;7.85;26.17;8.42;8.47;16.06;4.4;10.44;24.99;11.86;8.67;12.88;12.96;5.16;41.71;10.45;23.23;17.06;11.97;11.71;11.94 1993-10-01;7.52;9.08;29.1;18.8;16.74;7.76;19.11;18.71;37.47;15.79;7.85;26.64;8.48;8.61;16.06;4.54;10.9;25.09;11.89;8.61;13.04;13.06;5.12;41.56;10.48;23.11;17.36;12.1;11.77;11.98 1993-10-04;7.53;9.17;28.91;18.74;16.9;7.72;19.17;18.56;37.07;15.64;7.89;26.87;8.51;8.66;16.28;4.52;10.99;25.14;11.93;8.5;12.88;12.85;5.16;41.2;10.45;23.36;17.31;12.13;11.77;12.02 1993-10-05;7.4;9.3;28.54;18.25;16.85;7.76;19.06;18.81;36.52;15.67;7.83;26.95;8.33;8.55;16.36;4.35;10.87;25.3;11.89;8.7;12.98;12.96;5.2;42.07;10.57;24.15;17.26;12.35;12.36;11.94 1993-10-06;7.44;9.27;28.54;18.43;16.9;7.7;18.83;18.76;36.44;15.61;7.82;26.95;8.28;8.66;16.33;4.31;10.93;25.04;11.96;8.67;13.13;12.75;5.3;41.86;10.65;24.27;17.06;12.35;12.6;12.24 1993-10-07;7.49;9.11;28.48;18.31;16.9;7.55;18.71;18.45;36.28;15.61;7.83;27.5;8.35;8.58;16.08;4.27;10.93;24.63;11.96;8.72;12.88;12.75;5.26;42.07;10.74;24.34;16.61;12.16;12.72;12.43 1993-10-08;7.41;9.14;28.48;18.13;16.92;7.51;18.77;18.51;36.44;15.58;7.86;27.34;8.36;8.44;15.89;4.37;10.99;24.52;11.83;8.67;12.95;12.75;5.28;42.07;10.99;24.21;16.61;12.32;12.66;12.51 1993-10-11;7.32;9.14;28.42;18.13;16.9;7.53;19.11;18.66;37.39;15.49;7.91;27.5;8.59;8.33;15.81;4.07;10.96;24.31;11.93;8.78;12.98;13.06;5.25;42.32;11.19;24.34;16.21;12.29;12.6;12.55 1993-10-12;7.38;9.3;28.48;18.13;16.77;7.8;19.17;18.76;37.31;15.52;7.82;27.42;8.62;8.39;15.78;4.04;10.87;24.37;11.99;8.81;13.01;13.01;5.27;42.07;11.11;24.64;16.41;12.18;12.24;12.59 1993-10-13;7.37;9.3;28.48;18.13;16.9;7.76;19.17;18.51;37.15;15.37;7.87;27.34;8.42;8.33;15.67;3.95;10.72;24.11;12.16;8.86;13.13;13.06;5.2;42.12;11.73;24.46;16.06;12.13;12.12;14.02 1993-10-14;7.29;9.3;29.96;18.49;16.79;7.86;20.08;18.56;36.84;15.43;7.91;28.05;8.42;8.36;15.75;4.03;10.59;23.54;11.89;8.97;13.5;13.22;5.13;42.27;11.93;25.56;17.21;12.43;12.48;13.9 1993-10-15;7.3;9.01;29.71;18.31;16.85;7.59;20.02;18.45;37.39;15.55;8.07;28.12;8.64;8.72;15.78;4.03;11.06;23.59;11.47;9.08;13.41;13.06;5.05;42.42;12.08;25.92;17.11;12.45;12.78;13.86 1993-10-18;7.44;8.66;29.16;18.43;16.92;7.51;19.85;18.51;37.47;15.43;8.03;29.06;8.99;8.66;16.25;3.92;10.93;24;11.07;9.17;13.44;13.59;5.19;43.53;12.28;25.74;17.11;12.37;12.72;13.74 1993-10-19;7.52;8.66;29.47;18.62;17.24;7.35;19.85;18.71;37.23;15.46;8.04;28.59;8.71;8.47;15.92;3.87;10.78;24.31;10.77;9.11;13.5;13.59;5.02;43.28;12.02;25.31;17.11;12.67;12.78;13.42 1993-10-20;7.44;8.91;29.59;18.74;17.37;7.29;20.02;18.91;36.6;15.49;8.05;28.59;8.79;8.55;15.67;3.9;10.84;24.99;10.91;9.28;13.44;13.64;5.06;43.13;11.82;25.8;17.21;12.75;13.02;13.31 1993-10-21;7.41;8.91;28.97;18.62;17.95;7.21;19.85;18.51;36.05;15.4;7.98;28.36;8.99;8.61;15.42;4.01;11.18;25.2;11.07;9.39;13.5;13.54;4.97;42.67;12.02;25.56;16.86;12.67;12.84;13.19 1993-10-22;7.55;8.88;28.48;18.56;18.78;7.21;19.45;18.25;36.36;15.4;7.86;28.83;8.84;8.47;15.78;3.99;11.06;25.51;11;9.19;13.54;13.64;5.02;42.52;12.08;25.01;16.41;13.32;12.48;13.15 1993-10-25;7.74;8.78;28.6;18.13;18.76;7.13;19.51;18.56;37.23;15.64;7.84;28.05;9.1;8.66;16.06;3.95;11.15;25.77;11.04;9.25;14.03;13.48;5.03;42.88;12.19;25.44;16.86;13.86;12.66;13.27 1993-10-26;7.62;8.43;28.6;17.77;19.02;7.01;19.51;18.91;36.52;15.67;7.9;28.44;9.13;8.55;16.03;3.96;11.49;26.18;10.77;9.14;14;13.54;4.97;42.62;11.93;25.5;16.71;13.53;12.42;13.31 1993-10-27;7.49;8.43;28.54;18.07;18.84;6.95;19.57;18.71;39.28;15.64;7.98;29.38;9.32;8.55;15.62;4.01;11.43;25.77;10.77;9.17;14.09;13.43;4.99;41.96;11.79;25.93;16.96;13.42;12.3;13.27 1993-10-28;7.4;8.14;28.48;18.25;19.1;7.09;19.57;18.91;40.23;15.7;7.94;30.71;9.13;8.64;15.7;3.95;11.37;25.61;10.77;9.19;14.16;13.54;4.94;42.17;11.96;26.66;17.36;13.45;12.48;13.39 1993-10-29;7.44;8.33;28.36;18.19;19.12;7.13;19.74;19.16;39.67;15.58;7.95;29.85;9.07;8.72;15.78;3.93;11.43;24.68;10.58;9.28;14.31;13.54;5.01;42.07;12.25;26.54;17.71;13.37;12.54;13.62 1993-11-01;7.45;8.2;28.6;18.31;19.28;7.05;19.62;19.21;38.97;15.52;7.99;30.24;9.25;8.86;16;3.93;11.86;25.61;10.91;9.41;14.16;13.48;5.05;42.37;12.36;26.29;17.61;13.32;12.42;13.82 1993-11-02;7.48;8.2;28.36;18.25;19.31;6.85;19.4;19.41;39.04;15.49;7.96;30.71;9.38;8.94;16.14;3.9;12.64;25.97;10.71;9.41;14.09;13.38;5.02;42.62;12.25;26.11;17.26;13.61;12.84;13.62 1993-11-03;7.36;7.88;28.05;18.31;19.02;6.48;19.11;19.26;39.2;15.4;7.9;30.87;9.18;8.97;15.64;3.78;12.61;25.51;10.41;9.41;13.72;13.85;4.91;42.27;12.25;25.56;17.06;13.61;13.13;13.42 1993-11-04;7.43;7.88;27.43;18.13;18.73;6.5;18.89;19.51;38.57;15.4;7.68;30.32;8.93;8.77;15.78;3.67;12.36;25.35;9.98;9.33;13.47;13.59;4.78;41.86;11.99;25.37;16.86;13.45;13.19;13.46 1993-11-05;7.48;7.98;27.68;18.07;18.81;6.56;18.89;19.66;38.57;15.31;7.71;30.05;9.12;8.77;15.64;3.78;12.39;25.61;10.25;9.39;13.85;13.54;4.92;42.27;12.65;26.11;16.96;13.32;12.96;13.19 1993-11-08;7.5;7.91;27.56;17.83;19.1;6.81;18.89;19.54;39.12;15.25;7.68;30.6;9.33;8.94;15.59;3.73;12.49;25.77;10.15;9.5;13.85;13.48;4.91;42.52;12.47;26.6;16.71;13.37;13.43;13.11 1993-11-09;7.52;8.24;27.56;17.4;18.81;6.87;18.71;19.13;39.36;15.22;7.74;30.6;9.47;8.91;15.64;3.79;12.21;25.51;10.18;9.5;13.66;13.43;4.89;43.03;12.7;26.72;16.41;13.64;13.61;13.07 1993-11-10;7.67;8.07;27.31;17.22;18.99;6.85;18.49;19.08;39.6;15.31;7.75;32.17;9.78;9.21;15.84;3.95;12.39;25.97;10.21;9.64;13.72;13.7;5.09;43.13;12.62;27.51;16.41;13.61;13.91;13.03 1993-11-11;7.62;7.98;27.99;17.28;18.89;6.85;18.26;18.88;40.07;15.19;7.69;31.94;9.72;9.27;16.06;3.96;12.92;26.7;10.08;9.55;13.75;13.7;5.1;43.03;12.93;27.21;16.46;13.83;13.79;12.79 1993-11-12;7.66;8.04;28.3;17.65;18.65;6.75;18.54;19.23;39.67;15.1;7.69;32.17;9.59;9.43;16.14;3.9;12.83;27.32;10.15;9.61;13.97;13.8;5.12;42.67;13.44;27.51;16.36;13.83;13.91;12.71 1993-11-15;7.62;8.2;27.99;17.95;18.78;6.69;18.83;19.54;39.75;14.95;7.72;32.41;9.55;9.74;16.12;3.73;12.67;27.24;9.98;9.66;13.72;13.8;5.03;43.11;13.19;27.51;16.41;13.87;13.91;12.67 1993-11-16;7.62;8.27;28.05;18.25;18.55;6.63;19.17;19.64;39.75;14.95;7.91;33.2;9.55;9.32;16.12;3.76;13.11;27.55;10.08;9.8;14.16;14.27;5.14;43.78;13.02;27.88;16.61;14.28;14.26;12.67 1993-11-17;7.57;8.01;27.99;19.77;18.39;6.58;19.28;19.43;38.81;15.19;7.92;33.83;9.08;9.49;16.01;3.66;12.89;27.24;9.95;9.72;14.09;14.33;5.05;43.93;12.7;27.09;16.96;14.25;14.2;12.43 1993-11-18;7.54;7.95;27.62;18.98;17.95;6.42;19.11;19.84;38.33;15.37;7.99;34.38;9.12;9.38;15.95;3.6;13.11;26.77;9.85;9.86;14.09;14.59;5.02;44.14;12.53;26.96;16.86;14.03;14.2;12.47 1993-11-19;7.73;7.95;27.74;18.68;17.87;6.46;19.4;19.89;38.49;15.31;8.05;34.14;9.12;9.46;15.76;3.54;12.89;27.18;9.72;9.86;14.03;14.8;5.01;45;12.7;27.27;16.41;13.65;14.14;12.36 1993-11-22;7.9;7.69;27.56;18.8;17.45;6.32;19.17;19.89;39.28;15.31;8.05;33.2;8.81;9.13;15.71;3.57;12.92;27.13;9.52;9.91;13.82;14.17;4.81;44.55;12.65;27.33;16.31;13.57;14.09;12.08 1993-11-23;7.94;7.82;27.56;18.92;17.48;6.54;19.23;19.74;39.28;15.22;8.07;33.2;8.81;9.19;15.79;3.66;13.2;27.24;9.75;10;14.03;14.43;4.84;44.55;12.5;27.03;16.01;13.44;13.85;12.32 1993-11-24;7.83;7.95;27.31;18.68;17.9;6.42;19.19;19.59;39.28;15.07;8.01;33.83;9.08;9.3;15.98;3.73;13.7;27.39;9.79;9.91;14.5;14.54;4.92;44.14;12.65;27.09;16.26;13.36;14.03;12.36 1993-11-26;7.83;8.01;27.56;18.8;17.9;6.46;19.3;19.54;39.04;14.71;8.07;33.91;9.15;9.43;15.98;3.75;13.85;27.65;9.88;9.77;14.44;14.54;4.94;44.09;12.85;27.21;16.66;13.38;14.22;12.32 1993-11-29;7.69;8.17;27.06;18.98;17.95;6.48;19.3;19.49;39.04;14.74;8.02;34.22;8.95;9.3;15.87;3.72;13.51;27.76;10.08;9.8;14.53;14.27;4.97;44.24;12.67;28.13;16.81;13.41;14.04;12.47 1993-11-30;7.62;8.11;26.94;18.74;17.82;6.46;19.19;19.38;38.72;14.95;8.06;33.2;9.08;9.13;15.73;3.82;13.39;27.86;10.15;9.66;14.56;14.43;5;44.55;12.76;27.76;17.01;13.44;13.62;12.63 1993-12-01;7.73;8.3;26.76;18.37;17.95;6.6;19.3;19.38;39.36;14.77;8.08;33.51;9.18;9.21;15.98;3.9;13.2;28.17;10.28;9.75;14.5;14.33;5.09;44.55;12.53;27.7;16.66;13.36;13.57;12.91 1993-12-02;7.74;8.33;26.88;18.37;18;6.58;19.42;19.38;39.52;14.83;8.19;33.67;9.35;9.41;16.15;3.92;13.36;27.91;10.38;9.8;14.37;14.29;5.18;44.29;12.59;27.7;17.01;13.49;13.27;13.11 1993-12-03;7.65;8.17;26.88;18.49;17.87;6.69;19.59;19.38;39.6;14.92;8.2;34.61;9.44;9.38;16.4;3.95;13.29;28.02;10.41;9.91;14.37;14.45;5.36;44.14;12.62;27.88;17.31;13.46;13.27;13.07 1993-12-06;7.57;8.07;27.19;18.86;17.95;6.93;19.88;19.49;40;14.95;8.22;34.46;9.61;9.38;16.65;3.7;13.36;28.17;10.48;10.05;14.62;14.55;5.3;44.14;12.65;27.88;17.36;13.41;13.33;12.99 1993-12-07;7.62;8.17;27.25;19.89;17.56;6.81;20.1;19.18;39.04;14.92;8.17;34.3;9.47;9.38;16.62;3.69;13.36;28.33;10.67;10;14.53;14.5;5.34;43.98;12.79;28.31;17.41;13.46;13.15;13.15 1993-12-08;7.98;8.24;27.31;19.22;17.79;6.73;19.99;19.28;39.76;14.83;8.22;34.77;9.41;9.32;16.73;3.7;13.39;28.17;10.64;10.05;14.37;14.34;5.22;44.24;12.76;28.19;17.26;13.65;13.09;13.19 1993-12-09;7.87;8.17;27.06;19.34;17.97;6.79;19.93;18.98;40.16;14.83;8.27;35.24;9.38;9.24;16.78;3.61;13.32;27.81;10.64;9.8;14.25;14.07;5.07;44.19;12.74;27.94;17.01;13.63;13.21;13.39 1993-12-10;7.96;8.14;27;19.4;17.95;6.65;19.88;19.18;40.39;14.98;8.33;35.32;9.22;9.1;16.76;3.5;13.73;27.97;10.41;9.64;14.13;14.02;5.12;44.14;12.65;27.64;17.01;13.52;13.03;13.31 1993-12-13;8.1;8.11;27;19.95;17.87;6.65;19.99;19.64;40.71;14.98;8.27;35.32;9.33;9.05;16.56;3.57;14.26;28.38;10.35;9.53;14.25;13.97;5.09;45.31;12.79;27.88;16.86;13.46;12.91;13.46 1993-12-14;7.96;8.07;26.94;19.95;17.71;6.48;19.76;19.94;39.92;15.01;8.39;34.53;9.38;8.91;16.62;3.57;13.95;28.02;10.28;9.44;14.41;13.86;5;45.11;12.65;27.82;16.81;13.44;12.73;13.31 1993-12-15;7.77;7.85;27.13;20.74;17.9;6.32;19.48;19.99;35.3;15.04;8.47;34.38;9.47;8.8;16.62;3.65;14.13;27.91;10.21;9.58;14.31;13.97;4.98;45.67;12.56;27.27;16.76;13.41;12.91;13.35 1993-12-16;7.73;7.78;27.13;21.22;18.03;6.32;19.82;20.14;34.51;15.13;8.48;34.46;9.5;8.77;16.65;3.65;14.29;27.65;10.25;9.53;14.37;14.07;5;46.18;12.59;26.9;17.06;13.44;13.03;13.46 1993-12-17;7.69;7.85;26.94;21.53;18.05;6.42;19.48;20.04;35.15;15.25;8.61;34.46;9.59;8.8;17.09;3.61;14.85;28.33;10.44;9.55;14.37;14.29;5.03;45.87;12.68;27.03;17.46;13.41;13.09;13.74 1993-12-20;7.66;7.98;26.94;21.65;18.31;6.38;19.59;20.09;35.54;15.19;8.54;34.14;9.65;8.86;17.14;3.64;14.5;28.23;10.67;9.44;14.34;14.39;5.12;45.77;12.59;27.15;17.46;13.38;12.79;13.62 1993-12-21;7.52;8.14;26.94;21.28;18.18;6.28;19.88;20.04;35.7;15.04;8.63;34.53;9.65;8.61;17.2;3.7;14.57;28.28;10.61;9.44;14.25;14.45;5.16;44.95;12.71;27.39;17.51;13.36;12.67;13.7 1993-12-22;7.54;8.04;26.76;21.16;18.26;6.4;20.1;20.09;35.38;15.01;8.63;35.01;9.59;8.64;17.39;3.84;14.72;27.91;10.71;9.5;14.28;14.5;5.07;45.11;12.82;27.88;17.66;13.41;12.55;14.1 1993-12-23;7.51;8.11;26.82;21.22;18.37;6.4;19.88;19.89;35.7;15.01;8.69;34.77;9.47;8.77;17.5;3.86;14.57;27.86;10.71;9.64;14.13;14.55;5.05;44.49;12.82;27.94;17.61;13.49;12.38;14.18 1993-12-27;7.55;8.24;26.88;21.47;18.81;6.46;20.22;20.2;35.7;15.31;8.75;35.4;9.5;8.72;17.67;3.9;14.69;28.49;10.91;9.83;14.03;14.98;5.03;44.6;12.88;28.49;17.61;13.46;12.26;14.06 1993-12-28;7.67;8.07;26.63;21.16;18.89;6.38;20.39;20.14;35.7;15.25;8.72;35.71;9.52;8.83;17.67;3.98;14.5;28.33;10.77;9.89;14.19;14.98;5.17;44.24;12.85;28.68;17.86;13.68;12.43;13.94 1993-12-29;7.63;8.04;26.26;20.92;18.92;6.28;20.56;19.99;35.78;15.16;8.72;35.24;9.67;8.83;17.7;3.92;14.44;28.33;10.64;9.91;14.47;14.92;5.09;44.44;13;28.74;17.46;13.38;12.32;13.9 1993-12-30;7.63;8.11;25.95;20.92;18.84;6.14;20.5;19.79;35.7;15.16;8.67;35.01;9.67;8.75;17.7;3.92;14.16;28.49;10.71;9.97;14.31;14.76;5.08;44.49;12.88;28.25;17.11;13.41;12.02;13.86 1993-12-31;7.63;7.98;25.89;20.98;18.6;6.28;20.39;19.59;35.78;15.04;8.59;34.53;9.73;8.69;17.48;3.85;14.04;28.28;10.68;9.94;14.16;14.61;5.04;44.44;12.82;27.88;16.61;13.46;11.9;13.5 1994-01-03;7.77;7.72;25.95;21.16;18.68;6.52;20.33;20.09;35.62;15.19;8.52;34.85;9.58;8.53;17.2;3.81;14.32;28.38;10.74;10.02;13.97;14.98;5.01;43.68;13.28;28.13;16.61;13.03;12.14;13.66 1994-01-04;7.76;7.88;25.65;20.86;19.02;6.54;20.16;20.7;36.9;15.31;8.49;35.71;9.65;8.64;16.87;3.96;14.66;29.06;10.78;10;13.94;15.3;5.03;43.32;13.37;27.7;16.41;13.19;12.26;14.16 1994-01-05;7.95;7.78;25.95;20.74;19.02;6.5;19.65;21.06;36.7;15.4;8.44;35.79;9.76;8.8;16.92;3.99;14.78;30.21;10.68;9.97;13.78;15.83;5.14;43.22;13.43;27.45;15.7;13.46;12.14;14.24 1994-01-06;7.91;7.62;26.51;20.98;19.12;6.44;19.25;21.26;37.31;15.31;8.51;35.95;10.05;8.39;17.14;3.98;14.54;29.84;10.51;9.77;13.78;15.56;5.29;43.83;13.46;27.82;15.55;13.44;11.72;14.4 1994-01-07;7.95;7.59;26.94;20.8;18.89;6.63;19.48;20.8;37.21;15.19;8.55;36.42;10.22;8.5;17.2;4.1;14.63;30.31;10.81;9.89;14.19;15.77;5.33;44.19;13.49;27.76;15.85;13.65;11.6;14.75 1994-01-10;8.16;7.68;27.13;20.74;18.92;6.52;19.82;21.26;37.61;15.4;8.59;37.29;10.29;8.61;17.25;4.17;14.72;30.73;10.98;10.08;14.47;15.93;5.36;44.14;13.6;28.8;16.21;13.9;11.84;15.15 1994-01-11;7.88;8.01;27.06;20.68;18.94;6.46;19.53;21.11;37;15.37;8.65;37.45;10.41;8.5;17.31;4.15;14.57;30.42;10.91;9.86;14.41;15.77;5.33;44.85;13.46;28.62;16.01;13.84;12.14;14.95 1994-01-12;8.02;7.98;26.69;20.8;18.94;6.46;19.76;21.06;36.7;15.46;8.68;37.29;10.45;8.66;17.17;4.25;14.44;30.16;10.94;9.83;14.41;15.56;5.34;44.95;13.4;28.62;15.85;14.03;12.14;14.79 1994-01-13;8.06;8.14;26.69;21.16;18.97;6.44;19.48;20.75;36.7;15.64;8.62;37.92;10.53;8.33;17.03;4.23;14.6;29.84;11.04;9.69;14.16;15.56;5.34;45.16;13.31;27.88;15.85;13.93;12.14;14.59 1994-01-14;8.03;8.37;26.88;21.53;18.95;6.44;19.42;21.26;36.6;15.43;8.75;38.55;10.78;8.31;17.2;4.26;14.57;30.05;11.04;9.69;14.22;15.51;5.35;44.9;13.28;28.31;15.75;13.9;12.2;15.11 1994-01-17;8.17;8.17;27.06;21.59;19.37;6.38;19.02;21.46;37;15.49;8.78;38.23;10.75;8.31;17.14;4.12;14.29;30.26;11.04;9.77;14.13;15.51;5.3;44.65;13.05;28.25;15.45;14.03;12.02;14.79 1994-01-18;8.13;8.01;27.13;21.47;19.42;6.38;18.73;21.67;35.4;15.46;8.88;39.1;10.62;8.14;17.2;4.18;14.19;31.04;10.78;9.66;14.28;15.56;5.29;44.7;13.23;28.25;15.85;14.03;11.9;14.87 1994-01-19;8.24;7.85;27.5;21.41;19.6;6.4;18.96;21.77;34.59;15.61;8.91;38.31;10.41;8.33;17.34;3.89;13.91;30.99;10.28;9.5;14.62;15.24;5.2;45.52;13.28;28.49;16.01;14.22;12.08;14.95 1994-01-20;8.18;8.01;27.74;21.59;19.68;6.34;18.9;21.97;34.19;15.82;8.89;37.84;10.24;8.2;17.53;3.96;13.73;30.78;10.11;9.22;14.62;15.19;5.39;45.41;13.31;28.98;16.31;14.2;12.08;15.03 1994-01-21;8.13;8.04;27.62;21.89;20.65;6.34;18.85;22.23;34.19;15.76;8.85;38.31;10.44;8.22;17.48;4.05;13.73;31.04;10.01;9.28;14.53;14.92;5.39;45.92;13.23;29.04;16.16;14.14;12.02;15.07 1994-01-24;8.32;8.21;27.37;21.59;20.99;6.38;18.5;21.97;33.99;15.76;8.83;37.84;10.33;8.06;17.48;4.07;14.57;31.25;10.04;8.94;14.53;14.76;5.33;45.41;13.28;28.49;15.7;13.9;11.84;14.87 1994-01-25;8.34;8.53;27.25;20.86;20.65;6.4;18.62;22.07;34.19;15.79;8.77;37.29;10.22;8.2;17.23;4.05;14.47;31.1;9.91;9.05;14.65;15.19;5.32;45.06;13.34;28.19;15.4;13.95;11.78;14.91 1994-01-26;8.42;8.37;27.62;20.74;20.78;6.5;18.73;21.97;34.59;15.76;8.72;36.89;10.15;8.31;17.06;3.96;14.01;30.89;10.08;9.28;14.75;15.24;5.27;45.36;13.66;28.68;15.91;14.09;12.08;14.95 1994-01-27;8.42;8.34;27.99;20.68;21.25;6.65;19.08;22.38;34.59;15.64;8.87;37.68;10.21;8.47;17.25;3.99;14.19;31.25;10.24;9.39;14.9;15.19;5.27;43.83;13.83;28.68;16.56;14.03;12.38;14.79 1994-01-28;8.45;8.5;27.93;20.68;21.69;6.71;18.85;22.48;34.99;15.67;8.84;37.29;10.47;8.66;17.34;4.05;14.35;31.25;10.41;9.41;15.09;15.3;5.3;43.93;13.8;29.23;16.56;14.12;12.61;14.95 1994-01-31;8.75;8.5;27.99;20.98;21.8;6.81;18.68;22.78;35.5;15.85;8.83;38.55;10.5;8.58;17.39;4.06;14.04;31.36;10.51;9.39;15.09;15.51;5.32;43.83;13.89;29.1;16.91;14.63;12.61;14.99 1994-02-01;8.78;8.5;27.74;20.74;22.11;6.83;18.96;22.94;35.6;15.79;8.76;38.39;10.36;8.58;17.64;4.02;14.04;31.77;10.28;9.33;14.99;15.4;5.32;43.27;13.77;28.43;16.31;14.47;12.85;14.95 1994-02-02;8.77;8.53;27.93;21.1;21.9;6.93;18.96;22.73;36.1;15.99;8.94;38.7;10.56;8.64;17.53;4.06;14.01;32.14;10.41;9.44;14.84;15.46;5.25;43.52;13.72;28.74;16.46;14.47;13.21;14.91 1994-02-03;8.66;8.4;27.5;20.8;22.06;6.79;19.08;22.58;35.6;15.96;8.99;39.65;10.35;8.53;17.25;3.93;13.85;32.19;10.08;9.39;14.87;15.51;5.28;43.63;13.86;28.86;16.16;14.5;13.39;14.87 1994-02-04;8.42;8.04;27.06;20.62;21.46;6.28;18.62;21.77;34.99;15.61;8.72;38.78;9.98;8.22;16.65;3.84;12.92;31.62;9.84;9.3;14.72;14.92;5.08;42.86;13.8;28.31;15.75;13.95;13.03;14.28 1994-02-07;8.64;7.98;26.88;20.62;22.03;6.42;18.62;22.28;34.99;15.58;8.87;39.65;10.16;8.58;16.78;3.85;13.48;31.98;9.91;9.22;14.81;14.92;5.05;42.86;13.8;28.49;15.85;14.03;12.85;14.79 1994-02-08;8.78;8.01;26.88;20.98;22.61;6.34;18.39;22.28;34.99;15.58;8.79;40.75;10.22;8.58;17.12;3.95;13.32;31.72;9.81;9.44;14.68;14.66;4.92;43.27;13.54;27.88;15.7;14.22;12.73;14.48 1994-02-09;8.9;7.91;26.63;20.98;22.79;6.44;18.5;22.51;34.59;15.73;8.87;40.43;10.44;8.75;17.67;3.97;13.2;31.83;9.94;9.28;14.99;14.82;4.98;43.01;13.63;28.98;15.45;14.22;12.85;14.36 1994-02-10;8.77;7.91;26.63;21.1;22.22;6.46;18.62;22.1;34.49;15.7;8.72;39.33;10.47;8.72;17.45;3.92;13.14;31.83;9.84;9.22;15.12;14.82;4.96;42.76;13.31;28.07;15.05;14.09;12.79;14.48 1994-02-11;8.64;8.14;26.88;21.16;22.01;6.42;18.96;22.2;34.89;15.85;8.79;38.59;10.42;8.66;17.56;3.96;13.23;31.93;9.74;9.33;15.12;14.82;4.92;42.86;13.26;28.74;15.3;14.2;12.91;14.55 1994-02-14;8.67;8.07;26.82;21.65;22.19;6.38;18.73;22.25;34.49;15.79;8.86;38.99;10.38;8.66;17.32;3.97;13.42;31.79;9.71;9.39;15.03;14.34;4.95;43.27;13.54;28.62;15.3;14.63;12.97;14.71 1994-02-15;8.64;7.98;27;21.53;22.51;6.32;18.68;22.51;34.59;15.87;8.93;38.91;10.53;8.75;17.71;4.04;13.54;31.69;9.74;9.42;15.34;14.34;4.98;44.34;13.69;28.8;15.3;14.85;12.91;14.83 1994-02-16;8.81;7.88;26.94;22.56;22.48;6.32;18.9;22.46;34.39;15.9;8.91;38.51;10.98;8.77;17.73;4.17;13.57;31.69;9.78;9.31;15.18;14.07;4.92;44.75;13.63;29.1;15.3;15.42;13.03;14.87 1994-02-17;8.71;7.81;26.76;23.16;22.77;6.26;19.08;22.3;34.29;15.9;8.94;37.88;11.06;8.66;17.76;4.13;13.11;31.27;9.74;9.19;15.34;14.07;4.91;44.14;13.4;28.49;15.15;15.34;13.21;14.83 1994-02-18;8.63;7.75;26.39;23.04;22.64;6.12;18.96;22.46;34.19;15.76;8.85;37.72;10.96;8.58;17.57;4.15;13.08;31.32;9.71;9.25;15.03;13.97;5;43.42;13.34;28.07;15.4;15.12;13.21;14.4 1994-02-22;8.52;7.88;26.39;23.04;23.16;6.16;19.42;22.41;33.79;15.87;8.85;37.72;11.1;8.83;17.57;4.27;13.32;31.27;9.88;9.19;15.12;13.86;4.97;44.4;13.43;28.86;15.5;15.04;13.45;14.55 1994-02-23;8.41;7.91;26.14;22.74;23.16;6.16;19.48;22.35;33.3;15.85;8.8;37.8;11.29;9.32;17.4;4.27;13.29;31.37;9.98;9.14;15;13.81;5.06;44.04;13.57;28.55;15.15;14.75;13.8;14.79 1994-02-24;8.43;7.65;25.83;22.74;22.74;6;19.19;21.79;33.71;15.55;8.63;37.25;11.33;9.13;17.1;4.21;13.14;30.74;9.94;9.03;14.84;13.54;4.99;43.78;13.43;27.88;15.65;14.62;13.39;15.03 1994-02-25;8.43;7.65;26.02;22.98;22.56;6.06;19.19;21.89;34.42;15.61;8.61;36.78;11.21;9.08;17.1;4.24;13.14;30.85;10.08;9.05;14.96;13.7;5.06;43.57;13.37;27.82;15.91;14.54;13.51;15.19 1994-02-28;8.32;7.62;25.89;22.68;22.69;6;19.48;21.79;34.92;15.46;8.63;36.78;11.16;9.16;16.96;4.27;13.14;30.48;9.91;8.94;15.06;13.76;5.16;43.42;12.91;28.13;15.8;14.86;13.51;15.23 1994-03-01;8.24;7.52;25.77;22.44;22.79;5.76;19.36;21.48;34.92;15.46;8.65;36.7;11.07;9.05;16.87;4.15;13.32;30.06;9.91;9;15.15;13.6;5.2;42.64;12.79;27.88;15.75;14.78;13.33;15.11 1994-03-02;8.46;7.49;25.52;22.68;23.45;5.7;19.25;21.28;35.94;15.7;8.66;38.2;11.04;9.02;16.76;4.14;13.17;29.96;9.84;8.97;15.34;13.72;5.17;42.75;12.82;28.31;16.06;14.43;13.15;14.83 1994-03-03;8.28;7.46;25.28;22.44;23.6;5.7;19.02;21.18;35.74;15.76;8.6;38.2;11.02;8.99;16.87;4.23;13.08;30.38;9.58;8.86;15.24;13.5;5.06;42.54;12.65;27.82;16.01;14.45;13.21;14.52 1994-03-04;8.31;7.42;25.34;22.86;23.47;5.76;19.02;21.54;36.24;15.55;8.59;39.14;10.96;9.24;17.18;4.33;13.08;30.17;9.68;8.86;15.37;13.29;5.06;42.54;12.65;27.82;15.96;14.78;13.33;14.63 1994-03-07;8.35;7.49;25.46;23.16;23.89;5.78;19.02;21.69;36.24;15.55;8.66;38.83;10.84;9.19;17.43;4.43;12.98;30.38;9.68;8.83;15.4;13.72;5.08;43.01;13.11;27.94;15.8;15;13.51;14.71 1994-03-08;8.27;7.55;25.09;22.8;23.97;5.66;18.73;21.64;36.55;15.58;8.6;39.14;10.84;9.41;17.12;4.4;13.6;31.16;9.68;8.86;15.21;13.61;5.06;43.21;12.91;28;15.8;14.95;13.62;14.71 1994-03-09;8.28;7.36;25.21;22.68;24;5.8;18.77;21.94;36.45;15.61;8.63;39.54;10.96;9.32;17.18;4.45;13.76;30.01;9.55;8.94;15.18;13.88;5.05;43.57;12.92;27.88;15.8;14.92;13.86;15.15 1994-03-10;8.09;7.39;25.21;22.74;24.08;5.74;18.71;22.51;36.04;15.46;8.56;39.3;11.09;9.21;17.04;4.36;13.91;29.17;9.55;8.83;15.03;13.66;5.05;43.06;12.81;27.58;16.16;14.81;13.51;14.87 1994-03-11;8.19;7.46;25.09;23.1;24.39;5.82;18.77;22.81;36.24;15.55;8.62;39.7;11.13;9.27;17.29;4.27;13.88;29.33;9.68;8.83;15.27;13.77;5.11;42.54;12.9;28;16.41;15.25;13.45;14.91 1994-03-14;8.13;7.52;25.28;23.22;24.49;5.84;19.11;23.02;36.55;15.55;8.62;39.62;11.1;9.41;17.18;4.35;14.29;29.27;10.08;8.86;15.34;13.72;5.24;42.39;13.1;27.76;16.41;15.25;13.33;14.55 1994-03-15;8.14;7.65;25.83;22.68;24.55;6.04;18.88;22.87;36.55;15.43;8.59;38.83;11.09;9.43;17.26;4.43;14.26;29.01;10.14;8.89;15.03;13.56;5.3;42.44;13.07;27.39;16.26;14.86;13.23;14.59 1994-03-16;8.16;7.94;26.02;22.38;24.34;6.04;18.88;23.33;36.65;15.46;8.5;38.99;11.13;9.46;16.98;4.47;14.47;28.64;10.38;8.8;14.87;13.39;5.3;42.23;13.1;27.58;16.46;14.86;13.11;14.52 1994-03-17;8.35;7.85;26.39;22.19;25.02;6.02;19.05;23.99;36.55;15.64;8.44;38.12;11.07;9.38;17.1;4.49;14.38;29.01;10.31;8.78;14.84;13.5;5.28;41.98;12.81;27.33;16.46;14.95;12.99;14.52 1994-03-18;8.53;7.85;26.39;22.8;24.94;5.82;19.22;24.04;36.65;15.7;8.56;37.8;10.96;9.27;17.1;4.48;14.19;29.48;10.21;8.8;15.12;13.61;5.3;42.44;12.84;27.7;16.36;14.92;12.75;14.91 1994-03-21;8.53;7.81;26.45;22.31;24.78;5.82;19.28;23.68;36.75;15.61;8.52;37.64;10.81;9.46;17.15;4.49;14.57;28.8;10.14;8.8;14.96;13.72;5.2;41.77;12.6;27.39;16.16;14.92;12.75;14.63 1994-03-22;8.67;7.78;26.39;22.31;24.86;5.96;19.34;23.53;36.75;15.64;8.46;37.64;10.58;9.54;17.21;4.48;14.47;29.01;10.21;8.72;15.15;13.07;5.3;41.61;12.17;27.39;16.41;14.81;13.17;14.83 1994-03-23;8.71;7.98;26.32;22.44;25.28;6.22;19.22;23.73;36.65;15.58;8.51;38.2;10.61;9.76;17.37;4.45;14.23;29.54;10.18;8.58;15.06;12.91;5.39;41.72;12.34;26.9;16.26;14.86;13.05;14.67 1994-03-24;8.66;7.75;26.14;22.5;24.47;6.08;19.22;23.22;36.55;15.61;8.49;36.85;10.38;9.52;17.26;4.37;14.01;29.17;10.11;8.61;14.72;12.97;5.45;41.2;12.2;26.29;16.16;14.86;13.05;14.36 1994-03-25;8.43;7.72;25.95;22.19;24.42;6;19.17;23.02;36.35;15.61;8.37;35.91;10.36;9.54;16.98;4.34;13.42;28.7;9.91;8.61;14.5;12.91;5.47;41.2;12.02;26.29;16.26;14.54;12.99;14.28 1994-03-28;8.38;7.65;26.02;22.25;23.87;5.86;19.34;23.27;36.55;15.49;8.48;36.22;10.3;9.38;16.48;4.27;13.32;28.91;9.88;8.66;14.59;13.02;5.4;41.2;11.96;26.54;16.51;14.45;12.93;13.96 1994-03-29;8.25;7.49;25.52;22.13;23.21;5.64;19.22;22.3;36.35;15.49;8.38;35.36;9.89;8.97;16.21;4.12;13.08;28.75;9.74;8.47;14.34;12.91;5.16;40.53;11.67;26.17;16.51;14.18;12.69;13.68 1994-03-30;7.94;7.29;25.52;22.01;22.92;5.57;18.82;21.79;36.24;15.13;8.09;34.25;9.85;8.97;15.21;4.12;13.29;28.75;9.54;8.27;13.85;12.64;5.23;40.79;11.85;25.99;15.85;13.66;12.39;13.4 1994-03-31;7.92;7.23;25.28;21.59;23.53;5.7;18.65;21.69;36.04;14.98;8.19;34.01;10.12;8.97;16.21;4.2;13.57;28.49;9.78;8.41;14.13;12.75;5.3;40.79;11.82;26.17;16.31;13.58;12.33;13.33 1994-04-04;7.98;7.16;25.15;21.47;23.71;5.62;18.48;21.54;35.74;14.53;8.03;34.72;9.98;8.86;16.15;4.18;13.17;27.7;9.65;8.22;14.19;12.48;5.28;40.38;11.52;25.68;15.76;13.61;12.1;13.21 1994-04-05;7.96;7.52;25.65;22.01;24.34;5.72;18.59;22.15;35.63;14.56;8.1;36.14;10.13;9.35;16.43;4.27;13.26;28.12;9.78;8.27;14.47;12.91;5.48;40.89;11.44;26.66;16.11;14.32;12.51;13.6 1994-04-06;8.01;7.82;25.28;22.07;25.12;5.66;18.82;22.15;35.43;14.56;8;37.09;10.04;9.3;16.48;4.33;13.2;28.17;9.78;8.19;14.34;12.7;5.56;40.79;11.41;26.23;16.01;14.07;12.33;13.44 1994-04-07;8.01;7.89;25.09;21.95;24.81;5.68;18.94;22.61;35.23;14.59;8.05;37.96;10.32;9.43;16.04;4.39;13.2;27.75;10.22;8.27;14.25;12.75;5.61;41.15;11.79;26.35;16.22;14.15;12.69;13.44 1994-04-08;7.89;7.89;24.72;21.71;24.57;5.68;18.88;23.12;34.31;14.53;7.97;36.46;10.21;9.38;16.04;4.31;13.04;27.54;10.12;8.33;14.22;12.86;5.44;42.18;11.47;26.54;15.96;14.15;12.27;13.25 1994-04-11;7.92;7.98;24.66;21.89;24.26;5.86;18.54;23.33;34.82;14.68;8.06;36.62;10.22;9.46;16.32;4.3;13.17;27.65;10.42;8.64;14.13;12.7;5.44;42.54;11.23;26.48;16.16;14.02;12.27;13.43 1994-04-12;7.92;7.85;24.84;22.19;24.02;5.88;18.25;23.33;34.82;14.68;8.13;36.22;10.07;9.24;16.21;4.09;13.14;27.54;10.35;8.8;13.97;12.7;5.3;42.03;11.2;26.35;16.11;13.99;12.27;13.43 1994-04-13;7.69;7.85;24.72;21.89;23.76;5.8;18.59;23.02;35.03;14.71;8.1;35.99;9.93;9.19;15.76;3.96;13.01;27.39;10.15;8.86;14.22;12.59;5.3;41.51;11.35;26.29;16.37;14.04;12.1;13.27 1994-04-14;7.68;7.85;24.66;21.95;23.47;5.74;18.08;23.27;34.52;14.98;7.99;36.62;9.72;9.16;15.87;3.72;13.39;27.23;10.22;8.69;14.16;12.43;5.26;40.79;11.58;26.84;16.62;14.15;11.86;13.15 1994-04-15;7.49;7.92;24.66;21.95;23.42;5.74;18.08;23.33;34.52;15.01;7.93;36.93;9.62;9.19;15.93;3.71;13.17;27.02;10.25;8.75;14;12.16;5.3;40.17;11.67;26.35;16.88;14.4;11.74;12.99 1994-04-18;7.34;7.89;24.47;21.71;23.16;5.62;18.08;23.27;34.42;14.83;7.77;35.91;9.58;8.91;15.32;3.64;13.26;27.18;10.08;8.66;14.03;12.32;5.19;39.55;11.7;26.05;17.24;14.1;11.62;12.71 1994-04-19;7.19;7.95;24.97;22.01;22.72;5.62;18.19;23.17;34.11;15.04;7.82;34.88;9.41;8.83;15.15;3.57;13.26;26.39;9.95;9;14.13;12.16;5.51;39.35;12.11;26.72;17.39;13.91;11.44;13.23 1994-04-20;7.33;7.85;25.71;21.41;21.7;5.59;18.31;22.92;33.3;15.01;7.82;34.49;9.36;8.72;15.21;3.57;12.98;25.92;9.78;9.03;14.13;12.59;5.59;39.97;12.31;27.27;17.54;13.55;11.44;12.99 1994-04-21;7.38;7.82;26.26;21.47;22.35;5.45;18.59;22.46;33.6;14.89;7.89;34.96;9.72;9.08;15.49;3.75;14.5;26.02;9.88;9.11;14.62;13.23;5.72;39.97;12.22;28;18.05;13.96;12.22;13.39 1994-04-22;7.49;7.79;25.83;21.22;22.61;5.7;18.36;22.35;33.1;15.04;7.86;35.12;9.48;9.1;15.6;3.75;14.6;25.6;9.68;8.97;14.72;13.29;5.73;38.94;12.37;27.82;17.44;13.85;12.1;13.55 1994-04-25;7.59;7.89;25.83;21.71;23.3;5.59;18.65;23.79;33.81;15.16;7.93;36.14;9.85;9.19;15.76;3.91;14.72;26.28;9.48;8.94;14.81;13.23;5.86;39.35;12.2;27.88;17.9;13.91;12.1;13.47 1994-04-26;7.6;7.85;25.77;21.77;23.19;5.64;18.59;23.68;33.91;14.98;7.86;35.83;9.75;9.21;15.54;3.93;14.54;26.81;9.54;8.97;14.81;13.29;5.93;40.17;12.66;27.7;17.39;13.91;12.1;13.83 1994-04-28;7.51;7.75;25.34;21.59;22.82;5.55;18.94;23.53;33.3;14.74;7.92;35.83;9.7;9.05;15.37;3.84;14.19;26.97;9.41;9.28;14.78;12.91;5.76;40.38;12.52;27.58;17.03;13.85;12.27;13.47 1994-04-29;7.52;7.79;25.28;21.83;23.03;5.62;19.17;23.38;33.71;14.98;7.8;35.83;9.89;9.24;15.32;3.79;14.29;27.39;9.34;9.22;14.9;12.7;5.78;40.38;12.72;27.82;16.93;13.94;12.04;13.51 1994-05-02;7.84;7.92;25.95;21.71;23.17;5.55;19.22;23.94;36.35;14.65;7.85;36.14;10.02;9.3;15.37;3.76;14.41;27.33;9.54;9.36;14.84;13.34;5.97;40.79;12.6;27.64;16.73;13.66;12.04;13.43 1994-05-03;7.73;7.79;26.08;21.71;23.56;5.62;19.05;24.2;37.46;14.59;7.89;36.22;9.93;9.21;15.43;3.69;14.5;27.33;9.58;9.28;14.81;13.13;5.84;40.79;12.49;27.64;16.62;14.07;11.92;13.63 1994-05-04;7.69;7.69;26.02;21.59;23.51;5.7;19.05;23.73;37.06;14.45;8.02;35.83;9.99;9.41;15.6;3.64;14.35;27.18;9.58;9.31;14.78;12.91;5.95;40.89;12.31;27.09;16.73;14.04;11.92;13.47 1994-05-05;7.66;7.72;26.08;21.83;23.58;5.62;18.88;24.04;37.16;14.47;8.01;35.12;9.99;9.41;15.43;3.67;14.19;27.12;9.48;9.22;14.62;12.86;5.9;41.1;12.14;26.9;16.62;14.18;12.04;13.47 1994-05-06;7.61;7.85;25.65;21.65;22.67;5.53;18.48;23.89;36.95;14.95;7.92;34.69;9.47;9.19;15.21;3.71;14.04;26.39;9.31;9.08;14.37;12.91;5.78;40.89;12.14;26.66;16.32;13.85;11.8;13.23 1994-05-09;7.57;7.72;25.52;21.59;22.14;5.37;18.13;23.92;36.55;14.62;7.77;34.14;9.47;8.97;15.04;3.64;14.16;26.44;9.21;9.08;14.16;12.81;5.77;40.89;11.67;26.17;16.01;13.96;11.68;12.95 1994-05-10;7.54;7.69;26.08;21.71;22.38;5.41;18.25;24.07;36.24;14.8;7.78;35.17;9.67;9.05;14.76;3.7;14.41;26.81;9.44;9.28;14.31;13.13;5.88;41.51;11.5;26.72;16.22;14.07;11.68;13.11 1994-05-11;7.52;7.72;25.89;21.34;22.46;5.29;18.36;24.12;36.24;14.62;7.64;34.37;9.73;8.8;15.21;3.7;14.23;26.7;9.24;9.51;14.34;12.81;5.84;40.69;11.09;26.05;15.76;13.99;11.44;13.31 1994-05-12;7.5;7.62;25.95;21.34;22.33;5.23;18.48;24.33;36.75;14.77;7.68;34.53;9.72;8.8;15.87;3.64;14.23;26.55;9.24;9.43;14.44;12.97;5.91;40.79;11.79;26.6;15.91;14.07;11.5;13.23 1994-05-13;7.64;7.52;26.08;21.22;22.61;5.29;18.13;24.64;36.65;14.77;7.81;33.9;9.84;8.83;15.82;3.63;14.29;26.76;9.28;9.54;14.44;12.97;6.03;40.48;12.17;26.6;16.11;13.99;11.44;13.23 1994-05-16;7.61;7.46;26.63;21.22;23.09;5.27;18.25;24.89;36.65;14.65;7.76;33.58;9.64;8.97;15.67;3.57;14.54;26.99;9.34;9.59;14.37;13.13;5.94;41.06;12.05;27.03;16.16;14.06;10.84;13.27 1994-05-17;7.84;7.79;26.57;21.22;23.32;5.49;18.59;24.59;36.55;14.74;7.8;34.45;9.44;9.38;15.84;3.62;15.22;27.78;9.61;9.71;14.9;13.29;5.91;41.99;12.02;27.82;16.88;14.14;11.26;13.51 1994-05-18;7.97;7.89;27.25;21.16;23.22;5.62;18.65;24.84;36.55;14.71;7.84;34.3;9.76;9.76;15.78;3.66;15.1;28.1;10.05;9.71;14.96;13.13;6.07;42.3;12.37;27.64;16.78;14.2;11.5;13.71 1994-05-19;7.93;7.82;27.93;21.47;23.17;5.62;18.88;25.26;37.06;14.83;7.91;35.01;9.96;9.85;15.73;3.74;15.25;28.89;9.95;9.74;15.12;13.07;6.15;42.82;11.96;27.64;16.93;14.2;11.32;14.06 1994-05-20;7.94;7.89;27.93;21.47;23.09;5.72;18.77;25.41;36.95;14.8;7.8;35.09;10.07;9.82;15.56;3.71;15.44;29.05;9.71;9.71;15.09;12.97;6.11;42.72;12.55;27.27;16.57;14.09;11.08;13.71 1994-05-23;7.86;7.75;27.62;21.28;23.17;5.49;18.54;25.36;38.17;14.71;7.7;34.53;10.05;9.85;15.39;3.7;15.34;28.99;9.68;9.82;14.96;12.97;6.32;42.51;12.9;26.9;16.47;14.03;10.96;13.63 1994-05-24;7.75;7.79;27.5;21.47;22.69;5.51;18.42;25.36;38.17;14.62;7.78;34.69;10.09;10.04;15.61;3.82;15.69;29.31;9.91;9.79;14.81;13.23;6.39;42.61;12.55;27.03;16.42;14.09;11.14;13.63 1994-05-25;7.84;7.82;27.56;21.59;22.64;5.51;18.48;25.36;38.3;14.65;7.78;34.77;10.01;10.2;15.5;3.81;15.81;29.57;9.98;9.88;14.81;13.18;6.56;43.03;12.55;27.15;16.57;14.28;11.2;14.02 1994-05-26;7.79;7.79;27.43;22.8;22.54;5.35;18.71;25.31;38.6;14.62;7.95;34.37;9.79;10.12;15.67;3.76;15.9;29.15;9.95;9.9;14.87;13.13;6.5;42.61;11.82;27.45;16.98;14.42;11.26;13.83 1994-05-27;7.82;7.79;27;22.5;22.54;5.41;18.65;25.46;38.09;14.59;8.03;34.37;9.73;10.04;15.5;3.82;15.81;29.2;10.22;9.99;15.15;13.07;6.55;42.61;11.67;27.58;16.88;14.5;11.32;14.06 1994-05-31;7.86;8.27;26.94;22.5;22.41;5.31;18.48;25.56;38.4;14.56;8.15;34.06;9.67;9.93;15.67;3.89;15.65;29.26;10.32;9.93;15.4;13.07;6.72;42.41;11.5;27.58;16.78;14.61;11.2;13.79 1994-06-01;7.83;8.31;27.25;22.68;22.12;5.35;18.82;25.36;37.99;14.47;8.21;34.14;9.55;10.12;15.5;4.02;15.78;30;10.69;9.88;15.21;13.02;6.62;41.78;11.32;27.09;16.83;14.75;10.9;13.87 1994-06-02;7.83;8.2;27.19;23.22;22.35;5.23;19.11;25.26;38.19;14.5;8.19;33.9;9.72;10.12;15.78;4.01;15.41;29.79;10.59;9.82;15.06;13.09;6.53;42.09;11.38;27.27;16.83;14.56;10.84;13.95 1994-06-03;7.86;8.27;27.56;23.41;22.54;5.31;19.28;25.51;38.3;14.62;8.09;32.95;9.61;10.01;15.78;3.92;15.16;29.79;10.72;9.82;15.24;13.41;6.61;43.03;11.55;27.82;17.24;14.45;11.38;14.18 1994-06-06;7.9;8.31;27.37;23.65;22.69;5.33;19.34;25.41;37.99;14.56;7.99;32.31;9.62;9.96;15.73;3.84;15.56;29.63;10.86;9.59;15.31;13.36;6.81;42.61;11.87;28.25;17.54;14.47;11.32;13.98 1994-06-07;7.77;8.42;27.56;23.71;22.22;5.31;19.4;25.1;38.4;14.68;7.99;31.92;9.52;9.82;15.73;3.82;15.56;29.2;10.65;9.76;15.59;13.41;6.7;42.09;11.82;28.62;17.44;14.45;11.46;14.06 1994-06-08;7.86;8.5;27.37;23.65;21.88;5.35;19.22;25.15;37.99;14.62;7.89;32;9.33;9.71;15.78;3.71;15.31;29.42;10.65;9.74;15.37;13.3;6.5;42.51;11.76;28.13;17.54;14.5;11.76;13.87 1994-06-09;7.93;8.61;27.8;23.16;21.7;5.45;18.74;24.95;38.3;14.71;7.93;32.16;9.33;9.82;15.84;3.67;15.41;29.26;10.62;9.85;14.93;13.74;6.53;42.82;11.89;27.82;17.59;14.47;12.18;13.98 1994-06-10;8.12;8.65;27.31;23.41;22.04;5.41;18.56;25;37.99;14.8;7.82;32.55;9.48;9.76;15.73;3.73;15.56;29.63;10.75;9.74;14.93;13.52;6.57;43.13;11.89;27.58;17.64;14.61;11.7;13.98 1994-06-13;8.37;8.5;27.31;23.53;22.22;5.41;18.16;25.46;38.19;14.21;7.91;33.03;9.61;9.82;16.01;3.7;15.84;30.21;10.99;9.79;14.93;13.52;6.61;43.24;11.83;27.45;17.49;14.61;11.76;14.02 1994-06-14;8.44;8.54;27.56;23.65;22.93;5.74;18.39;25.2;37.78;14.03;7.86;33.98;9.67;9.46;16.79;3.81;16.15;30.37;10.86;9.82;14.93;13.63;6.7;43.24;11.98;27.39;17.49;14.86;11.88;14.18 1994-06-15;8.29;8.39;27.62;23.83;22.85;5.86;18.39;25;37.89;13.58;7.78;34.22;9.62;9.71;16.4;3.79;15.84;30.47;10.86;9.74;14.81;13.57;6.78;43.34;11.98;26.84;17.49;14.64;11.76;14.18 1994-06-16;8.33;8.39;27.99;24.19;22.88;5.76;18.8;25.26;38.4;14.03;7.86;34.14;9.65;9.65;16.34;3.76;15.62;30.42;10.86;9.82;14.96;13.47;6.7;43.55;11.95;27.09;17.64;14.83;11.88;14.34 1994-06-17;8.3;8.42;27.87;23.47;22.8;5.62;18.45;24.89;38.4;14;7.82;34.14;9.61;9.54;16.28;3.73;15.5;29.89;10.72;9.79;14.84;13.3;6.62;42.41;11.92;27.21;17.54;14.67;11.52;14.18 1994-06-20;8.18;8.24;27.5;23.16;22.3;5.49;18.56;24.53;38.19;13.97;7.76;33.74;9.75;9.46;15.84;3.66;15.31;29.73;10.59;9.79;14.75;13.36;6.69;42.51;12.01;27.09;17.49;14.58;11.7;14.18 1994-06-21;8.28;8.01;27.31;23.29;21.41;5.41;18.51;24.59;37.99;13.82;7.56;32.95;9.56;9.41;16.17;3.61;15.16;29.52;10.42;9.85;14.72;13.41;6.58;41.99;12.25;27.33;17.49;14.39;11.4;13.67 1994-06-22;8.29;8.01;27.37;23.41;21.51;5.39;18.8;24.84;38.3;13.88;7.5;33.19;9.59;9.49;16.17;3.71;15.41;29.42;10.52;9.74;14.87;13.2;6.44;42.2;12.39;27.27;17.39;14.5;11.58;13.51 1994-06-23;8.32;8.01;27.25;23.22;21.38;5.29;18.68;24.64;38.91;13.85;7.58;32.16;9.41;9.32;16.12;3.63;15.13;29.15;10.45;9.71;14.78;13.2;6.27;42.3;12.1;26.96;17.54;14.36;11.58;13.55 1994-06-24;8.07;7.79;26.51;22.5;21.2;5.23;18.51;24.12;39.11;13.64;7.58;32.08;9.36;9.08;15.89;3.63;14.88;28.57;10.32;9.57;14.65;13.03;6.19;41.47;12.07;26.9;17.24;14.06;11.22;13.35 1994-06-27;8.16;7.86;26.82;22.68;22.04;5.23;18.68;24.48;39.01;13.61;7.76;33.11;9.61;9.27;15.89;3.71;15.28;28.83;10.52;9.59;14.84;13.09;6.48;41.78;12.31;26.9;17.13;14.06;11.46;13.71 1994-06-28;8.03;7.75;26.69;22.74;21.83;5.17;18.62;24.38;39.22;13.49;7.74;32.31;9.58;9.35;15.89;3.75;15.19;28.57;10.49;9.71;14.65;13.03;6.41;41.99;12.31;26.9;17.13;14.17;11.58;13.71 1994-06-29;8.09;7.71;26.88;22.92;21.41;5.39;18.85;24.38;39.63;13.46;7.8;31.92;9.33;9.41;15.84;3.69;15;28.31;10.42;9.76;14.65;13.03;6.42;42.09;12.28;26.72;17.59;14.25;11.76;13.55 1994-06-30;8.14;7.71;26.82;22.44;20.96;5.21;18.74;24.02;39.42;13.52;7.64;31.84;9.27;9.27;15.45;3.64;14.6;27.99;10.45;9.62;14.34;12.87;6.45;41.26;12.19;26.11;17.75;14.14;11.58;13.23 1994-07-01;8.4;7.86;26.76;22.5;21.09;5.23;19.2;23.81;39.32;13.61;7.6;32.08;9.3;9.43;15.61;3.67;14.16;28.62;10.55;9.62;14.72;12.92;6.28;41.47;12.28;26.48;17.7;14.25;11.76;13.51 1994-07-05;8.44;7.7;26.63;22.86;21.33;5.09;19.14;23.86;39.42;13.55;7.7;31.52;9.1;9.49;15.84;3.59;13.98;28.31;10.42;9.59;14.65;12.98;6.14;41.47;12.39;26.48;17.6;14.23;11.58;13.65 1994-07-06;8.57;7.89;26.57;22.74;21.91;5.17;19.14;24.02;39.93;13.52;7.74;31.36;8.87;9.57;15.73;3.53;14.16;29.05;10.35;9.51;14.65;12.98;6.04;41.37;12.42;26.66;17.8;14.34;11.4;13.45 1994-07-07;8.37;7.78;26.51;23.1;21.88;5.15;19.2;24.17;39.83;13.67;7.76;32.79;8.96;9.57;15.84;3.6;14.1;29.1;10.45;9.54;14.72;12.92;6.3;41.78;12.54;26.72;17.86;14.25;11.82;13.49 1994-07-08;8.78;7.74;26.51;23.04;22.17;5.17;19.31;24.43;40.04;13.79;7.76;32.55;9.12;9.65;15.73;3.68;14.07;29.42;10.38;9.59;14.72;12.76;6.19;41.37;12.54;27.03;18.06;14.17;11.64;13.49 1994-07-11;8.72;7.89;26.45;22.98;22.51;5.07;19.37;24.17;39.32;13.94;7.74;32.31;9.19;9.54;15.45;3.74;13.82;29.47;10.42;9.65;14.16;12.6;6.05;41.37;12.75;26.9;17.96;14.17;11.52;13.41 1994-07-12;8.82;8.01;26.39;22.74;22.9;5.01;19.37;24.12;39.42;13.91;7.68;32.87;9.28;9.52;15.39;3.74;13.88;29.63;10.38;9.57;14.22;12.6;6;41.58;12.57;26.6;17.65;14.25;11.82;13.37 1994-07-13;8.8;7.97;26.32;22.86;22.85;5.03;19.31;24.07;39.63;13.85;7.68;33.03;9.21;9.49;15.61;3.84;14.1;30.16;10.38;9.51;14.09;12.65;6.19;42.09;12.48;26.6;17.55;14.25;11.94;13.29 1994-07-14;8.83;8.08;26.88;22.98;22.78;5.07;19.43;24.28;40.04;13.79;7.8;33.11;9.42;9.57;15.89;3.82;14.47;30.52;10.62;9.65;14.47;12.82;6.09;42.93;12.72;26.72;18.01;14.56;11.94;13.29 1994-07-15;8.94;8.04;26.82;22.68;22.78;5.05;19.55;24.79;40.34;13.82;7.84;32.87;9.36;9.46;16.23;3.7;14.13;30.79;10.49;9.82;14.59;12.76;6.08;42.72;12.87;26.78;18.01;14.72;12.06;13.29 1994-07-18;9.18;8.01;26.57;22.74;22.81;5.19;19.55;24.84;40.34;13.88;7.84;32.79;9.42;9.49;15.89;3.64;14.13;30.63;10.52;9.79;14.41;12.87;6.31;42.61;12.93;26.6;18.11;14.69;12.36;13.37 1994-07-19;9.12;8.16;26.26;22.62;22.94;5.19;19.6;25;39.42;13.94;8.01;32.47;9.27;9.46;15.84;3.54;13.82;30.37;10.42;9.79;14.22;12.82;6.27;42.2;12.87;26.17;18.11;14.89;12.3;13.25 1994-07-20;8.97;8.16;26.2;22.38;22.62;5.31;19.49;25.05;39.22;13.94;7.99;32.39;9.19;9.38;16.17;3.51;13.88;30.37;10.22;10.04;14.09;12.71;6.05;42.61;12.81;26.23;17.86;14.61;12.18;13.01 1994-07-21;9;8.04;26.51;22.31;22.36;5.39;19.6;24.84;39.11;13.91;7.95;32;9.33;9.27;15.95;3.64;15.5;30.63;10.28;10.41;14.03;12.76;5.97;42.2;12.84;26.29;17.8;13.76;12.3;13.17 1994-07-22;8.83;7.86;26.76;22.31;22.41;5.43;19.66;24.79;40.24;13.79;8.13;31.84;9.27;8.97;16.17;3.6;15.25;30.84;10.28;10.18;13.04;12.82;6.32;42.51;12.78;26.35;17.65;13.76;12.12;13.29 1994-07-25;8.79;7.93;26.73;22.31;22.52;5.33;19.95;24.53;40.55;13.88;8.17;31.6;9.16;8.97;16.56;3.59;15.47;30.79;10.38;10.49;13.23;12.98;6.4;42.3;12.96;26.48;17.55;13.79;11.94;13.13 1994-07-26;8.97;7.97;26.82;21.89;22.7;5.27;19.83;24.84;39.22;13.88;8.05;32.08;9.32;9.02;16.34;3.56;15.5;30.68;10.38;10.46;13.41;12.87;6.3;42.3;12.93;26.41;17.6;13.59;12;13.25 1994-07-27;8.66;7.89;26.94;22.01;22.41;5.37;20.01;24.69;39.52;13.94;7.99;31.6;9.28;8.88;16.62;3.53;15.53;30;10.18;10.63;13.23;12.82;6.19;42.72;12.96;26.41;17.39;13.62;11.88;13.41 1994-07-28;8.55;7.93;26.88;21.83;22.55;5.31;20.35;24.79;39.42;14.06;8.11;31.84;9.3;8.83;16.73;3.6;15.47;30.05;10.22;10.55;13.29;12.87;6.19;43.65;12.96;26.96;17.24;13.35;11.82;13.41 1994-07-29;8.71;8.01;26.94;21.65;22.78;5.35;20.47;24.48;39.63;14.18;8.25;32.55;9.56;8.99;17.06;3.68;15.37;30.79;10.42;10.55;13.47;12.82;6.44;44.17;13.02;27.27;17.29;13.26;11.94;13.49 1994-08-01;8.84;8.12;26.94;21.89;23.1;5.51;20.47;24.53;39.32;14.33;8.23;33.5;9.65;8.91;17.29;3.71;15.62;31.21;10.52;10.55;13.66;12.82;6.67;44.8;12.96;27.15;17.24;13.81;12.06;13.57 1994-08-02;8.92;8.23;26.88;22.13;22.99;5.57;20.35;24.48;38.71;14.12;8.19;33.58;9.79;8.97;17.06;3.7;15.47;31.79;10.55;10.58;13.35;13.09;6.6;44.69;12.96;27.09;17.34;13.87;11.94;13.61 1994-08-03;8.93;8.35;26.76;22.01;22.83;5.49;20.24;24.48;39.32;14.12;8.13;33.5;9.82;9.1;16.84;3.67;15.65;32.16;10.55;10.77;12.98;12.92;6.67;44.9;12.99;26.9;17.39;13.76;11.94;13.53 1994-08-04;8.86;8.42;26.82;22.01;22.62;5.37;20.24;24.53;39.63;14.15;7.95;32.16;9.92;8.86;16.73;3.56;15.69;31.69;10.32;10.89;12.98;12.98;6.59;44.8;12.96;26.41;17.44;13.62;11.64;13.45 1994-08-05;8.79;8.38;26.69;21.83;22.02;5.39;20.24;24.79;39.01;14.09;8.03;31.84;9.89;8.86;16.51;3.61;15.5;31.42;10.28;10.75;13.1;12.92;6.56;44.9;13.04;26.29;17.34;13.54;11.7;13.49 1994-08-08;8.79;8.2;26.76;21.83;21.78;5.47;20.24;24.74;39.11;14.27;8.11;31.92;9.79;8.8;16.34;3.61;15.72;31.9;10.32;10.69;13.23;13.2;6.62;45.42;13.04;26.41;17.6;13.48;11.64;13.57 1994-08-09;8.82;8.23;26.51;21.89;21.89;5.43;20.24;24.62;39.42;13.97;8.01;31.84;9.82;8.86;16.51;3.68;16.03;31.9;10.28;10.75;13.16;13.36;6.69;45.63;13.1;26.17;17.7;13.43;11.52;13.65 1994-08-10;8.81;8.16;26.51;21.77;21.97;5.41;20.29;24.57;39.52;14.06;7.91;31.76;10.13;9.1;16.4;3.71;15.93;31.69;10.28;10.95;13.29;13.95;6.77;46.25;13.07;26.84;17.7;13.7;11.52;13.85 1994-08-11;8.74;8.16;26.45;21.71;21.65;5.39;20.12;24.47;39.32;13.85;7.8;31.68;10.07;9.05;16.06;3.75;16.06;31.32;10.32;10.78;13.35;13.84;6.91;45.84;13.04;26.96;17.7;13.59;11.52;13.93 1994-08-12;8.72;8.38;26.45;21.77;22.1;5.49;20.53;24.47;40.14;14.36;7.89;31.89;10.01;9.1;16.01;3.74;15.84;30.95;10.42;10.98;13.29;13.95;6.91;46.15;13.1;27.39;17.7;13.62;11.46;13.89 1994-08-15;8.61;8.35;26.32;22.19;22.34;5.55;20.41;24.62;39.73;14.27;7.99;31.73;9.75;9.24;15.91;3.78;16;30.59;10.42;11.18;13.04;14.33;6.8;45.89;13.1;27.33;17.6;13.82;11.34;13.81 1994-08-16;8.65;8.27;26.45;22.38;22.89;5.59;21.04;24.78;39.83;14.15;7.95;32.44;10.79;9.76;16.02;3.83;16.06;31.07;10.62;11.18;12.91;14.66;6.86;45.78;13.04;27.52;17.65;13.84;11.58;13.61 1994-08-17;8.64;8.35;26.2;22.38;23.07;5.62;21.27;24.73;39.63;14.21;7.84;32.44;10.73;9.65;15.91;3.96;16.12;30.54;10.55;11.12;13.16;14.71;6.98;45.47;12.99;27.52;17.44;13.79;11.64;13.81 1994-08-18;8.63;8.23;26.02;21.89;22.68;5.59;21.97;24.47;39.42;14.15;7.72;31.73;10.76;9.68;15.69;3.94;16.46;30.33;10.49;10.87;13.23;14.6;6.94;44.95;13.07;27.52;17.19;13.59;11.52;13.53 1994-08-19;8.6;8.27;26.2;21.83;22.68;5.62;21.56;24.31;39.11;14.18;7.84;31.25;10.82;9.82;15.63;3.94;16.93;30.44;10.52;11.06;13.23;14.76;6.86;45.26;13.13;27.45;17.24;13.65;11.52;13.45 1994-08-22;8.64;8.35;26.14;21.41;22.55;5.53;21.45;24.36;39.52;14.12;7.82;30.77;10.79;9.79;15.52;3.96;16.83;30.17;10.59;11.09;13.1;14.6;6.83;46.1;13.07;27.76;17.19;13.48;11.46;13.37 1994-08-23;8.65;8.42;26.32;21.34;23.47;5.72;21.45;24.36;39.83;14.06;7.99;30.93;10.81;9.9;16.02;3.99;16.8;30.33;10.69;10.98;13.16;14.55;6.94;46.1;13.4;27.94;17.24;13.62;11.52;13.53 1994-08-24;8.89;8.54;26.82;21.47;24.04;5.84;21.33;24.94;41.27;14.27;8.07;32.37;10.86;10.01;16.36;3.99;16.74;31.82;10.76;11.12;13.29;14.44;6.97;47.25;13.55;28.13;17.19;13.68;11.76;13.77 1994-08-25;8.92;8.46;26.82;21.47;23.54;5.84;21.33;24.57;40.45;14.09;8.13;32.05;10.82;9.9;16.53;4.05;17.24;31.18;10.69;11.06;13.29;14.28;7.02;47.36;13.46;28.31;17.08;13.82;11.52;13.61 1994-08-26;9.07;8.42;27;21.89;24.31;5.92;21.51;25.09;40.78;14.24;8.32;32.92;10.99;10.07;16.58;4.1;17.39;31.44;10.76;11.18;13.41;14.6;7.11;46.83;13.87;29.23;17.19;13.98;11.82;13.57 1994-08-29;9.16;8.57;27.31;21.89;24.31;5.94;21.33;25.35;41.91;14.24;8.23;32.68;11.09;9.98;16.86;4.11;17.24;31.71;10.72;11.18;13.85;14.71;7.13;46.2;13.81;29.17;17.24;14.06;11.7;13.49 1994-08-30;9.32;8.61;27.25;21.89;24.28;5.96;21.27;25.4;41.6;14.21;8.19;33.08;11.16;9.98;16.98;4.17;17.24;32.56;10.66;11.09;13.91;14.66;7.3;46.2;13.84;29.53;16.93;14.2;11.78;13.29 1994-08-31;9.39;8.5;26.94;22.07;24.25;5.98;21.22;25.14;41.09;14.18;8.15;31.97;11.09;9.96;16.75;4.09;17.02;32.77;10.52;11.32;14.03;14.76;7.27;46.2;14.44;29.78;17.03;14.12;11.78;13.13 1994-09-01;9.28;8.61;26.82;22.19;24.04;5.96;21.22;25.04;41.29;14.18;8.23;32.05;10.98;9.71;16.92;3.99;16.87;32.45;10.42;11.4;13.97;14.87;7.02;45.89;14.49;29.66;16.88;13.95;11.78;13.09 1994-09-02;9.24;8.76;26.88;22.25;23.81;5.94;21.33;24.78;41.4;14.18;8.19;31.89;10.86;9.74;16.81;3.99;16.71;32.13;10.42;11.32;13.91;14.78;7;45.57;14.38;29.41;16.98;13.9;11.72;13.09 1994-09-06;9.31;9.18;26.94;22.19;23.54;5.92;21.16;24.94;42.32;14.21;8.09;33.24;10.79;9.71;16.81;4.06;16.77;31.87;10.38;11.29;13.91;14.84;7;45.78;14.44;29.35;16.93;13.76;11.84;13.21 1994-09-07;9.23;9.03;26.88;22.5;23.18;5.94;21.33;24.47;42.02;14.3;8.03;33;10.81;9.68;16.7;4.13;16.77;31.82;10.32;11.15;13.66;14.84;7.11;45.78;14.38;29.23;17.14;13.59;11.66;13.45 1994-09-08;9.31;9.14;26.94;22.38;23.23;5.9;21.27;24.62;42.32;14.3;8.05;32.68;11.1;9.85;16.7;4.16;16.87;32.03;10.35;11.26;13.66;14.84;7.24;47.25;14.49;29.04;17.03;13.65;12.02;13.61 1994-09-09;9.27;9.22;26.57;22.19;23.28;5.78;21.02;24.42;42.63;14.15;8.05;32.05;11.06;9.68;16.14;4.09;16.71;31.66;10.11;11.26;13.6;14.68;7.11;46.73;14.36;28.62;16.93;13.65;11.9;13.45 1994-09-12;9.24;9.29;26.26;21.95;22.49;5.66;21.02;24.42;42.53;14.03;8.05;31.97;10.93;9.6;15.91;4.01;16.87;30.97;9.94;11.15;13.47;14.68;7.02;46.73;14.3;28.43;16.78;13.82;12.02;13.33 1994-09-13;9.39;9.25;26.57;21.95;22.55;5.7;21.31;24.42;42.84;14.06;8.11;31.73;11.07;9.54;16.02;4.06;17.21;31.66;9.98;11.21;13.6;14.68;7.2;46.83;14.24;28.62;16.98;14.04;12.44;13.49 1994-09-14;9.44;9.56;26.76;22.01;23.18;5.7;21.83;24.42;42.22;14;8.23;31.97;11.13;9.63;16.19;4.06;17.33;31.92;10.01;11.06;13.66;14.73;7.2;46.2;14.3;28.49;17.08;14.23;12.14;13.17 1994-09-15;9.55;9.52;27.19;22.19;24.28;5.74;22.46;24.57;43.67;14.18;8.42;32.84;11.26;9.71;16.42;4.17;17.33;32.35;10.05;11.26;13.78;14.95;7.28;47.15;14.42;29.78;17.24;14.4;12.08;13.09 1994-09-16;9.67;9.29;27.06;22.13;23.7;5.66;22.12;24.57;44.39;14.36;8.36;32.13;11.22;9.68;16.3;4.16;17.64;32.56;10.05;11.26;13.6;14.89;7.11;47.25;14.3;29.47;17.08;14.2;11.9;13.21 1994-09-19;9.59;9.44;27.37;21.89;23.81;5.47;22.7;24.73;44.08;14.18;8.27;31.97;11.1;9.79;16.02;4.18;17.49;33.25;9.84;11.26;13.47;15.11;7.11;47.56;14.39;29.66;17.08;14.18;11.6;13.25 1994-09-20;9.53;9.03;27.19;21.47;23.28;5.33;22.46;24;43.56;13.97;8.11;31.65;10.93;9.6;15.63;4.1;17.46;32.93;9.84;11.15;13.04;15;7;46.52;14.15;29.23;16.88;14.01;11.24;12.94 1994-09-21;9.51;9.14;26.94;21.34;22.76;5.25;22.52;23.9;42.74;13.88;8.11;30.93;10.87;9.38;15.41;4.06;17.27;32.83;9.91;11.15;13.23;15.11;7.16;47.25;14.3;29.04;16.83;13.87;11.42;12.97 1994-09-22;9.44;9.25;26.63;21.04;22.81;5.31;22.58;23.69;43.05;13.79;8.05;30.7;10.81;9.46;15.24;4.01;17.3;32.72;9.88;11.06;13.29;15;7.12;46.62;14.06;29.17;16.78;13.82;11.42;12.82 1994-09-23;9.46;9.33;26.63;20.8;22.76;5.19;22.58;23.84;43.46;13.79;7.99;29.66;10.69;9.38;15.13;3.93;17.18;33.25;9.81;11.15;13.35;15.11;7;46.2;14.03;28.8;16.88;13.98;11.3;12.58 1994-09-26;9.55;9.22;26.82;21.04;22.49;5.25;23.04;23.9;43.46;13.85;8.07;29.74;10.61;9.35;15.52;3.89;17.15;32.98;9.64;11.09;13.29;15.22;6.95;45.99;14.33;29.17;17.08;13.98;11.3;12.82 1994-09-27;9.74;9.25;26.94;21.28;22.28;5.19;22.87;24;43.25;13.7;7.99;30.22;10.81;9.24;15.3;3.89;17.15;33.57;9.64;11.57;13.35;15.71;7.06;45.99;14.33;29.23;17.39;14.09;11.3;12.62 1994-09-28;9.79;9.29;26.94;21.28;22.97;5.39;22.75;24.36;43.46;13.82;7.99;30.3;10.75;9.21;15.8;3.82;17.02;33.78;9.67;11.69;13.47;15.55;7.12;46.2;14.45;29.11;17.91;13.98;11.3;12.7 1994-09-29;9.59;9.22;26.57;21.22;22.76;5.27;22.64;24.16;43.05;13.79;7.99;29.74;10.78;9.21;15.97;3.83;17.27;33.57;9.64;11.54;13.29;15.38;7.06;46.1;14.39;29.04;17.55;13.95;11.24;12.7 1994-09-30;9.48;9.18;26.63;20.98;22.76;5.31;22.52;24.1;42.74;13.7;7.89;29.82;10.76;9.24;15.3;3.82;17.3;33.36;9.62;11.69;13.1;15.55;7.02;46.31;14.66;29.17;17.5;13.9;11.18;12.34 1994-10-03;9.6;9.13;26.32;21.16;22.86;5.27;22.81;23.9;42.32;13.76;7.8;29.42;10.67;9.35;15.24;3.75;17.11;33.62;9.52;11.6;13.04;15.93;6.98;45.78;14.6;29.04;17.14;13.84;11.12;12.7 1994-10-04;9.45;9.21;25.95;21.1;22.76;5.09;22.41;23.79;42.12;13.55;7.7;28.71;10.41;9.13;15.18;3.61;16.99;33.09;9.42;11.32;13.1;15.88;6.88;45.16;14.39;28.86;16.62;13.82;10.88;12.42 1994-10-05;9.25;9.13;25.77;21.28;22.39;5.07;22.52;23.79;41.91;13.55;7.76;29.03;10.64;9.13;15.13;3.65;17.18;32.93;9.38;11.38;13.1;15.71;6.94;44.95;14.3;28.8;16.42;13.76;11.12;12.26 1994-10-06;9.31;9.09;25.46;21.34;22.18;5.07;22.58;23.69;42.32;13.61;7.7;27.99;10.5;9.08;15.24;3.66;17.08;32.45;9.38;11.4;13.16;15.6;6.81;44.74;14.27;29.29;16.78;13.68;10.94;12.26 1994-10-07;9.44;9.09;25.65;21.34;22.49;5.09;22.52;23.84;42.63;13.97;7.66;27.91;10.87;9.05;15.02;3.7;17.67;32.13;9.66;11.49;13.1;15.77;6.8;44.74;14.36;29.29;17.09;13.79;11;12.08 1994-10-10;9.31;9.25;25.95;21.22;22.39;5.19;22.7;24;42.32;13.97;7.68;28.95;11.24;9.43;15.18;3.76;17.77;33.09;9.86;11.46;13.23;15.71;6.84;45.05;14.39;29.29;16.99;13.79;11.18;12.44 1994-10-11;9.32;9.28;26.57;21.53;23.39;5.31;23.33;24.26;42.74;14.06;7.93;29.98;11.32;9.65;15.58;3.76;17.8;32.93;9.86;11.77;13.35;15.93;6.98;45.68;14.66;30.51;17.09;13.93;11.36;12.64 1994-10-12;9.42;9.21;26.45;21.41;23.18;5.23;23.1;24.1;42.63;13.97;8.21;30.14;11.3;9.68;15.52;3.71;18.17;32.61;10.14;11.86;13.29;16.15;7.03;45.78;14.48;30.08;16.78;14.2;11.3;12.4 1994-10-13;9.32;9.36;26.51;21.34;23.28;5.39;23.51;24.31;42.53;14.21;8.19;30.06;11.26;9.74;15.63;3.66;17.95;33.04;10.14;11.91;13.47;15.98;7.16;46.2;14.51;30.51;17.09;14.15;11.6;12.32 1994-10-14;9.73;9.36;26.57;21.59;23.33;5.31;23.45;24.62;40.88;14.3;8.25;30.14;11.24;9.74;15.97;3.64;18.17;33.25;10.27;11.83;13.47;15.82;6.99;46.52;14.51;30.69;17.2;14.2;11.54;12.36 1994-10-17;9.67;9.32;26.51;21.41;23.39;5.25;23.33;24.68;39.74;14.27;8.25;29.66;11.21;9.71;15.91;3.62;18.2;33.83;10.34;12;13.78;15.77;6.89;47.25;14.81;30.88;17.14;14.23;11.36;12.4 1994-10-18;9.67;9.28;26.39;21.04;23.56;5.33;23.51;24.73;40.98;14.24;8.17;29.58;11.18;9.57;15.86;3.62;18.51;33.94;10.34;12;13.72;15.49;7.08;46.83;14.75;31.12;17.09;14.12;11.36;12.24 1994-10-19;9.88;9.32;26.57;21.34;23.66;5.47;23.45;24.73;41.29;14.18;8.23;29.82;11.41;9.74;15.86;3.73;18.73;33.68;10.27;12.31;13.85;15.49;7.2;47.15;14.87;31.55;17.2;14.09;11.42;12.36 1994-10-20;10.09;9.21;26.76;21.41;23.45;5.35;23.16;24.78;40.88;14.27;8.03;27.43;11.43;9.57;15.86;3.77;18.64;33.52;10.1;12.39;13.66;15.71;7.45;46.83;14.87;30.63;17.09;13.93;11.24;12.24 1994-10-21;9.93;9.21;26.88;21.16;23.77;5.35;23.28;24.62;40.98;14.27;7.76;26.24;11.5;9.63;15.58;3.76;18.54;33.52;10;12.33;13.91;15.49;7.42;46.83;14.66;30.51;16.99;13.82;11.3;12.32 1994-10-24;9.65;8.98;26.63;21.16;24.56;5.31;22.87;24.57;39.43;14.18;7.84;26.08;11.52;9.63;15.52;3.7;18.14;32.67;9.72;12.19;13.91;15.22;7.36;46.41;14.78;30.08;16.62;13.65;11.18;12.36 1994-10-25;9.52;9.09;26.57;20.92;24.29;5.37;23.28;24.52;39.64;14.39;7.82;26.32;11.47;9.57;15.52;3.66;18.36;31.98;9.86;12.25;13.85;15.06;7.46;45.36;14.9;30.39;16.62;13.59;11.12;12.36 1994-10-26;9.51;9.02;26.51;20.98;24.08;5.47;23.16;24.31;39.23;14.59;7.84;25.92;11.61;9.68;15.46;3.73;18.48;31.6;9.97;12.28;13.85;15.06;7.62;45.16;15.32;30.45;16.68;13.37;11.12;12.72 1994-10-27;9.51;9.36;26.2;21.1;24.24;5.45;23.45;24.68;40.36;14.8;7.89;25.53;11.81;9.82;15.41;3.76;18.42;32.03;10.17;12.28;14.03;15.49;7.7;45.16;15.44;30.69;16.88;13.48;11.24;12.48 1994-10-28;9.52;9.44;27.06;21.22;25.03;5.57;23.39;25.04;40.16;14.92;8.09;25.69;12.04;10.04;15.52;3.87;18.92;32.56;10.27;12.45;14.16;15.71;7.77;45.99;15.35;31.43;17.14;13.93;11.42;12.76 1994-10-31;9.58;9.4;27.13;21.28;25.19;5.62;23.33;24.78;39.74;14.98;8.01;25.13;12.06;10.01;15.52;3.86;18.51;31.66;10.45;12.33;14.34;15.55;7.88;46.41;14.69;30.76;17.4;13.98;11.24;12.6 1994-11-01;9.47;9.36;26.88;21.28;24.29;5.66;23.45;24.05;40.16;14.71;7.95;24.65;11.99;9.87;15.46;3.82;18.36;31.18;10.17;12.59;14.41;15.6;7.84;45.57;14.51;30.94;17.3;13.93;11.3;12.44 1994-11-02;9.31;9.47;26.63;21.28;24.66;5.55;23.28;23.17;39.23;14.77;7.91;24.33;12.03;10.09;15.18;3.89;18.45;31.02;10.03;12.53;14.53;15.33;7.88;45.26;14.39;30.76;17.25;13.84;11.42;12.4 1994-11-03;9.38;9.47;26.88;21.34;24.5;5.55;23.1;22.91;39.43;14.92;7.95;24.89;11.9;10.04;15.07;3.85;18.26;31.18;10.21;12.31;14.59;15.38;7.83;45.26;14.45;30.63;17.35;13.73;11.24;12.76 1994-11-04;9.41;9.28;26.51;21.16;24.19;5.35;23.16;22.91;38.81;14.65;7.86;24.97;11.64;10.01;14.96;3.75;17.67;30.44;10;11.88;14.34;15.33;7.69;44.53;14.36;30.21;16.88;13.57;11.36;12.56 1994-11-07;9.34;9.28;26.57;21.28;24.24;5.49;23.28;22.96;38.4;14.56;7.91;24.57;11.9;10.07;15.02;3.74;17.86;30.59;9.9;12;14.53;15.38;7.73;44.53;14.27;30.45;17.04;13.51;11.42;12.68 1994-11-08;9.42;9.28;26.94;21.28;24.14;5.51;23.45;23.21;38.3;14.47;8.05;24.81;12.07;10.26;15.07;3.78;18.14;30.86;9.93;12.37;14.65;15.6;7.95;44.32;14.45;30.82;16.99;13.59;11.42;13.08 1994-11-09;9.17;9.32;26.94;21.47;24.61;5.45;23.45;23.37;38.92;14.36;7.99;24.73;12.23;10.26;15.13;3.81;18.39;30.86;9.86;12.43;14.34;16.04;7.97;44.63;14.54;30.51;16.99;13.59;11.48;13.48 1994-11-10;9.1;9.36;26.94;21.34;24.56;5.39;23.39;23.21;38.2;14.18;7.99;24.86;12.09;10.31;15.13;3.8;17.89;31.02;9.9;12.4;14.28;16.2;7.96;44.84;14.75;30.45;16.83;13.34;11.54;13.68 1994-11-11;9.1;9.55;26.94;21.04;24.08;5.35;23.39;23.05;37.78;14.15;7.99;24.86;12.03;10.23;14.96;3.77;17.98;30.91;9.86;12.26;14.09;16.04;7.78;44.53;14.78;30.33;16.78;13.21;11.3;13.4 1994-11-14;9.35;9.51;26.63;21.1;24.24;5.37;23.8;22.95;39.33;14.24;7.99;24.78;12.09;10.45;15.09;3.87;18.11;30.83;10;12.43;14.53;16.26;8.06;44.63;15.02;31.06;17.35;13.21;11.24;13.72 1994-11-15;9.42;9.55;26.14;21.22;23.71;5.45;23.85;23.05;39.12;14.27;7.99;24.94;12.16;10.51;15.54;3.83;18.17;30.45;10.03;12.32;14.59;15.98;8.07;44.11;15.26;30.51;17.46;13.12;11.24;13.8 1994-11-16;9.41;9.51;25.46;21.89;23.82;5.39;24.2;23;40.78;14.45;8.07;25.34;12.13;10.51;15.37;3.8;18.08;30.34;10;12.32;14.78;16.15;8.08;44.32;15.11;31.25;17.51;13.34;11.18;14 1994-11-17;9.31;9.44;25.89;21.95;23.77;5.27;24.09;23.37;39.85;14.5;7.99;24.62;12.32;10.37;15.2;3.86;18.17;30.02;9.83;12.29;14.84;16.15;8.03;44.42;15.11;31;17.4;13.43;10.82;13.64 1994-11-18;9.41;9.32;25.71;21.71;23.45;5.21;24.32;23.16;40.16;14.45;7.99;24.14;12.33;10.31;14.81;3.98;18.2;30.72;9.72;12.49;14.65;16.48;8.02;44.58;15.05;31.37;17.4;13.21;10.88;13.52 1994-11-21;9.35;8.94;25.34;21.77;23.13;5.15;24.61;22.95;39.02;14.39;7.76;23.82;12.29;10.18;14.53;4.11;18.11;30.34;9.69;12.26;14.47;16.15;7.94;44.48;14.75;30.94;17.77;12.84;11.12;13.52 1994-11-22;9.06;8.6;24.97;21.83;21.76;5.01;24.2;22.06;37.16;14.42;7.62;23.42;11.83;9.93;13.97;4.03;17.33;29.12;9.42;11.98;14.41;15.6;7.75;42.79;14.36;30.69;17.51;12.53;11.24;13.72 1994-11-23;8.76;8.9;24.66;21.65;22.19;5.13;23.97;21.85;38.3;14.42;7.58;24.14;11.78;10.01;13.91;4.05;17.39;29.22;9.97;12.03;14.16;15.66;7.69;43;14.48;30.33;17.4;12.39;11.24;13.72 1994-11-25;9.03;8.9;24.54;21.65;22.5;5.19;24.12;22.01;38.42;14.47;7.58;24.38;11.98;10.04;14.47;3.97;17.58;29.76;9.9;12.01;14.09;15.98;7.78;42.89;14.45;30.57;17.46;12.65;11.3;13.72 1994-11-28;9.13;9.02;24.41;21.59;22.77;5.21;24.24;22.37;37.59;14.47;7.74;24.54;12.07;10.29;14.7;4.06;17.55;30.13;9.79;12.12;14.28;16.2;7.92;43.42;14.57;30.82;17.2;12.93;11.36;14.2 1994-11-29;9.1;9.17;24.23;21.47;22.45;5.21;24.18;22.48;37.69;14.42;7.64;24.54;12.26;10.31;14.59;4.07;17.55;30.18;10.1;12.12;14.28;16.26;8.02;43.31;14.48;30.82;17.25;12.87;11.32;14.08 1994-11-30;9.17;9.02;24.23;21.77;22.82;5.29;23.77;22.58;37.9;14.39;7.54;24.38;12.04;10.18;14.7;3.92;17.58;30.56;10;12.12;14.09;16.26;7.86;43.31;14.33;30.57;17.2;13.09;11.14;13.88 1994-12-01;9.09;9.06;24.11;21.83;22.24;5.23;23.48;22.16;38.32;14.15;7.48;24.06;11.72;10.15;14.75;3.89;17.27;29.97;10.07;12.15;13.97;16.2;7.82;42.89;14.15;30.02;17.14;13.26;10.78;13.76 1994-12-02;9.21;9.09;23.86;22.01;22.5;5.37;23.94;22.79;38.63;14.39;7.72;24.7;11.98;10.26;14.87;3.91;17.74;30.29;10.27;12.2;14.09;16.61;7.91;43.63;14.3;30.45;17.14;13.37;10.78;13.88 1994-12-05;9.28;9.02;23.49;22.56;22.71;5.41;23.94;22.58;38.63;14.24;7.68;24.94;12.03;10.12;14.87;3.99;17.74;30.61;10.45;12.18;14.09;16.55;7.91;43.95;14.15;30.08;17.14;13.32;10.78;13.88 1994-12-06;9.31;9.09;23.8;22.98;22.29;5.37;23.77;22.79;38.11;14.33;7.62;25.26;12.01;10.01;14.87;4.01;17.8;30.83;10.58;12.18;14.16;16.55;7.92;43.95;13.94;30.02;17.09;13.48;10.72;13.84 1994-12-07;9.23;9.02;23.3;23.29;21.92;5.27;23.65;22.53;37.9;14.47;7.76;24.78;11.81;10.01;14.64;4.03;17.7;30.99;10.38;12.15;14.22;16.55;7.88;43.74;13.91;29.9;17.04;13.34;10.72;13.92 1994-12-08;8.89;8.79;23.98;22.8;21.82;5.15;23.54;22.27;37.07;14.5;7.56;24.06;11.41;9.79;14.47;3.9;17.42;30.4;10.17;11.95;14.09;16.17;7.81;43.1;13.76;29.78;16.94;13.29;10.24;13.76 1994-12-09;8.86;8.75;24.23;22.74;21.45;5.05;23.25;22.58;38.01;14.68;7.68;23.82;11.72;9.79;14.36;3.9;17.77;30.77;10.17;12.03;13.97;16.39;7.89;43.53;13.72;30.33;16.94;13.01;10.3;13.6 1994-12-12;9.02;8.94;24.11;22.98;21.76;5.11;23.19;22.58;38.11;14.77;7.76;23.74;11.76;9.85;14.36;3.75;17.55;31.2;10.27;12.09;14.16;16.61;7.89;44.58;13.75;30.33;16.94;13.15;10.66;13.56 1994-12-13;8.92;8.87;24.29;23.04;21.61;5.09;23.31;22.58;38.22;14.53;7.84;23.98;11.56;9.87;14.42;3.76;17.33;30.88;10.41;12.12;14.09;16.61;7.84;43.95;14.05;30.51;17.3;13.04;10.72;13.96 1994-12-14;8.98;8.9;25.15;22.98;22.08;5.13;23.65;22.84;37.9;14.53;7.99;24.22;11.76;10.12;14.7;3.75;17.46;30.99;10.45;12.35;14.22;16.61;7.91;44.05;14.12;30.69;17.46;13.29;10.84;14 1994-12-15;9.17;8.87;25.15;23.22;22.5;5.15;23.71;23.11;38.01;14.45;8.03;24.14;11.79;10.29;14.87;3.64;17.52;31.95;10.27;12.43;14.34;16.61;7.94;43.95;14.15;30.21;17.56;13.65;10.84;14 1994-12-16;9.38;8.94;25.46;23.22;22.45;5.15;24;23.47;38.63;14.71;8.23;24.22;11.81;10.2;15.2;3.7;17.42;32.43;10.21;12.54;14.41;16.83;7.92;43.53;14.27;30.45;17.35;13.93;11.02;14.16 1994-12-19;9.21;8.9;25.34;23.1;21.97;5.29;23.89;23.11;38.32;14.65;8.19;24.3;11.72;10.15;15.32;3.59;17.8;32.59;10.24;12.57;14.34;16.83;7.83;43.31;14.02;30.51;17.2;13.82;10.84;14.28 1994-12-20;9.07;8.87;25.03;23.35;22.08;5.23;24.24;23;38.11;14.59;8.15;24.3;11.99;9.87;15.04;3.81;17.58;32.16;10.21;12.4;14.34;16.99;7.48;43.42;13.9;30.14;17.3;13.71;10.6;14.24 1994-12-21;9.31;8.9;24.91;23.29;22.55;5.33;24.53;23.37;38.63;14.65;8.17;24.22;11.95;10.23;15.43;3.89;18.29;32.7;10.1;12.35;14.28;17.21;7.69;44.16;13.9;30.45;17.3;13.74;10.78;14.32 1994-12-22;9.38;8.98;25.4;22.98;22.87;5.09;23.77;23.37;39.15;14.68;8.27;25.02;12.12;10.2;15.82;3.92;18.26;32.27;10.07;12.4;14.41;17.1;7.58;43.84;13.72;30.51;16.99;13.82;10.6;14.68 1994-12-23;9.45;8.94;25.15;22.98;22.92;5.25;24;23.32;39.57;14.65;8.15;26.38;12.33;10.23;15.77;3.91;18.26;32.75;10.07;12.54;14.34;17.27;7.61;44.27;13.81;30.45;17.2;13.93;10.54;14.79 1994-12-27;9.57;8.94;25.4;22.98;23.29;5.43;24.29;23.47;39.67;14.71;8.4;26.78;12.36;10.29;15.94;3.94;18.45;32.54;10;12.6;14.47;17.32;7.59;44.9;13.84;30.88;17.3;14.18;10.18;14.79 1994-12-28;9.58;8.98;25.4;22.86;22.87;5.35;24.29;23.42;39.36;14.71;8.38;26.38;12.35;10.23;15.54;3.89;18.14;31.89;10.07;12.52;14.65;17.16;7.62;44.9;14.09;30.63;17.14;14.04;10.3;14.87 1994-12-29;9.58;8.94;25.28;22.86;22.98;5.33;24.35;23.16;39.15;14.62;8.46;26.94;12.58;10.2;15.37;4;18.48;31.89;10.03;12.49;14.72;16.99;7.73;44.58;13.9;30.57;17.04;14.16;10.42;14.56 1994-12-30;9.73;9.05;24.78;22.8;23.24;5.23;23.94;23.52;39.78;14.47;8.36;26.94;12.3;10.12;15.32;3.97;18.26;32.21;9.98;12.43;14.53;16.77;7.64;45.11;13.99;30.33;16.78;14.07;10.18;14.68 1995-01-03;9.61;8.97;24.66;22.68;23.19;5.33;24.06;23.47;40.3;14.45;8.36;26.7;12.12;9.98;15.32;3.96;18.33;32.11;10.09;12.37;14.47;16.83;7.52;45.64;14.02;30.51;16.88;14.07;10;14.9 1995-01-04;9.64;9.01;24.78;22.62;23.13;5.39;23.54;23.42;40.51;14.5;8.36;27.66;12.21;9.93;15.26;3.96;18.48;32.21;10.26;12.49;14.41;16.77;7.58;45.11;14.33;30.27;16.79;14.13;10.36;14.78 1995-01-05;9.57;9.05;24.48;22.68;23.45;5.41;23.42;23.37;40.61;14.53;8.38;27.5;12.15;9.87;15.43;3.99;18.39;32.21;10.37;12.43;14.47;16.61;7.45;45.11;13.99;29.84;17.05;14.04;10.48;14.74 1995-01-06;9.85;9.09;23.8;23.1;23.87;5.57;23.42;23.11;39.99;14.53;8.34;27.66;12.36;9.85;15.49;4.04;18.67;32.91;10.4;12.35;14.28;16.5;7.58;44.9;13.99;29.9;17.05;14.21;10.54;14.7 1995-01-09;9.94;9.05;23.86;23.1;24.35;5.55;23.07;23.21;39.67;14.42;8.25;27.5;12.5;9.98;15.37;4.1;18.76;33.23;10.47;12.2;14.47;16.17;7.53;44.9;13.93;29.78;17;14.27;10.48;14.66 1995-01-10;9.9;9.13;23.98;22.98;24.61;5.64;22.84;23.37;39.78;14.47;8.32;26.86;12.69;10.09;15.65;4.14;19.04;32.8;10.37;12.46;14.47;16.06;7.62;44.9;13.96;30.14;17.05;14.35;10.3;14.54 1995-01-11;9.87;9.2;23.86;22.92;24.4;5.59;22.9;23.47;39.78;14.39;8.44;26.86;12.73;10.09;15.77;4.12;18.88;33.07;10.37;12.46;14.47;16.5;7.67;44.79;13.81;30.08;16.89;14.3;10.54;14.7 1995-01-12;9.93;9.13;23.55;23.83;23.92;5.55;23.13;23.11;39.88;14.39;8.42;26.86;12.69;10.07;15.82;4.17;18.88;33.44;10.33;12.35;14.34;16.22;7.66;43.95;13.72;30.39;16.95;14.24;10.3;14.82 1995-01-13;10.01;9.2;24.17;23.95;24.19;5.66;23.13;23.52;40.09;14.5;8.52;27.1;12.8;10.26;15.99;4.24;18.98;33.87;10.68;12.32;14.53;16.66;7.84;43.95;14.09;30.57;16.95;14.3;10.54;14.9 1995-01-16;9.94;9.28;24.41;23.65;24.19;5.84;23.54;23.73;40.61;14.47;8.62;26.7;12.96;10.34;16.22;4.24;19.26;33.92;10.82;12.43;14.65;16.83;8.02;45.01;14.09;30.82;17.26;14.44;10.36;15.22 1995-01-17;9.79;9.32;24.41;24.07;24.67;5.72;23.65;23.94;40.51;14.62;8.52;26.46;12.95;10.34;16.27;4.17;19.26;33.82;10.68;12.49;14.47;16.94;8.08;44.9;14.02;30.94;17.21;14.32;10.3;15.22 1995-01-18;9.93;9.36;24.17;23.89;24.82;5.78;23.48;24.15;40.3;14.8;8.56;25.58;13.1;10.34;16.27;4.31;19.2;33.55;10.54;12.46;14.41;16.94;8.13;44.9;14.02;30.27;17.05;14.41;10.18;15.1 1995-01-19;9.82;9.28;24.17;23.41;23.18;5.64;23.65;24.1;39.99;14.8;8.36;25.74;13.15;10.37;16.27;4.39;19.01;33.18;10.37;12.37;14.28;16.77;7.94;44.37;13.78;30.14;17.21;14.3;10.12;14.9 1995-01-20;9.68;9.24;24.04;23.1;22.28;5.57;23.65;23.84;41.34;14.95;8.36;25.26;12.93;10.29;16.27;4.28;18.73;32.8;10.19;12.37;14.47;16.61;7.7;44.69;13.87;30.02;17.1;14.35;10.18;15.1 1995-01-23;9.69;9.2;23.86;22.98;22.34;5.53;23.65;23.63;40.3;15.19;8.23;25.26;12.83;10.31;16.22;4.38;18.45;32.32;10.4;12.69;14.59;16.66;7.85;44.58;14.27;30.33;17.42;14.35;10.3;14.98 1995-01-24;9.52;9.2;23.98;23.16;22.5;5.66;23.42;23.89;41.24;14.89;8.25;24.78;12.98;10.31;16.56;4.45;18.39;32.21;10.5;12.52;14.78;16.61;7.75;44.05;14.18;30.27;17.31;14.32;10.36;15.26 1995-01-25;9.64;9.2;24.54;22.62;22.71;5.76;23.54;23.94;41.13;14.95;8.32;25.02;12.69;10.4;16.44;4.41;17.98;32.59;10.61;12.43;14.78;16.77;7.72;43.84;14.21;30.7;17.57;14.41;10.42;14.94 1995-01-26;9.49;9.16;24.6;22.25;22.76;5.8;24.06;23.47;40.71;15.04;8.36;24.14;12.55;10.42;16.22;4.38;17.98;32.27;10.54;12.69;15.27;16.99;7.48;44.48;14.39;30.82;17.73;14.63;10.48;15.1 1995-01-27;9.1;9.28;24.6;22.19;22.34;5.86;24.35;22.84;40.71;14.89;8.27;23.98;12.66;10.51;16.05;4.41;18.01;31.31;10.78;12.97;16.02;17.05;7.48;43.74;14.75;31.67;18.15;14.55;10.78;16.06 1995-01-30;8.76;9.43;24.6;21.77;21.86;5.92;24.47;22.27;41.13;14.89;8.38;23.9;12.44;10.4;16.11;4.35;17.83;30.29;10.64;13.08;16.27;17.21;7.38;43.95;14.54;32.16;17.68;14.21;10.9;16.34 1995-01-31;8.88;9.66;24.6;21.59;21.75;5.96;24.41;22.32;40.82;14.89;8.44;24.86;12.38;10.29;16.11;4.31;17.92;30.4;10.85;13.2;16.21;17.71;7.42;44.27;14.54;31.86;17.89;14.38;10.96;16.26 1995-02-01;9.08;9.7;24.41;22.25;21.81;5.98;24.29;22.37;39.67;14.8;8.38;25.42;12.61;10.53;15.94;4.39;18.29;30.93;10.75;12.89;15.9;17.49;7.39;43.1;14.66;31.25;17.84;14.27;11.26;16.3 1995-02-02;9.11;9.74;24.78;22.44;22.12;6.02;24.35;22.42;40.19;14.71;8.4;25.1;12.5;10.53;16.11;4.49;18.48;31.36;10.82;12.91;16.39;17.49;7.38;43.31;14.72;31.49;17.63;14.38;11.38;16.26 1995-02-03;9.48;9.89;25.21;22.62;22.44;6.38;24.7;22.58;40.61;14.95;8.54;25.1;12.46;10.59;16.78;4.57;18.54;31.73;11.03;13.03;16.33;17.49;7.52;43.42;14.79;31.8;18.05;14.52;11.5;16.62 1995-02-06;9.04;9.85;25.58;22.86;22.76;6.36;24.76;22.74;41.34;14.8;8.52;25.18;12.6;10.81;17.06;4.58;18.48;31.63;11.06;13.11;16.45;17.82;7.61;44.16;14.91;32.53;17.99;14.58;11.56;16.78 1995-02-07;9.04;9.93;25.34;23.16;22.65;6.32;24.93;23;41.34;14.83;8.52;25.18;12.63;10.95;16.95;4.54;18.45;31.73;10.99;13.14;16.58;17.6;7.62;44.05;14.94;32.47;17.99;14.55;11.5;16.66 1995-02-08;8.81;9.85;25.21;23.22;22.55;6.34;24.76;22.95;42.28;14.89;8.52;24.78;12.72;10.86;17.12;4.76;18.45;31.79;11.1;13.12;16.33;17.65;7.73;44.05;14.94;32.1;18.41;14.49;11.56;17.02 1995-02-09;9.03;9.82;25.52;23.1;22.28;6.32;24.41;23.15;41.86;14.71;8.56;25.02;13.07;10.84;16.61;4.82;18.64;32;11.03;12.95;16.39;17.76;7.73;44.37;14.75;32.04;18.05;14.52;11.44;16.78 1995-02-10;9.07;9.74;25.77;22.68;22.5;6.28;24.7;23.09;42.17;14.74;8.54;25.63;12.92;10.78;16.61;4.81;18.64;32;11.1;13.04;16.64;17.76;7.75;44.69;14.91;31.98;18.1;14.58;11.32;16.86 1995-02-13;9.1;9.85;25.65;22.44;22.6;6.28;24.35;23.25;41.86;14.89;8.62;25.87;12.98;10.73;17.06;4.8;18.61;32.91;11.13;13.04;16.83;17.65;7.75;44.9;14.94;32.22;18.05;14.72;11.38;16.82 1995-02-14;9.14;10.28;25.52;22.25;22.71;6.28;24.24;23.2;42.17;14.98;8.62;26.03;13;10.67;17.26;4.88;18.79;32.8;11.17;13.01;16.83;17.65;7.73;44.79;15.09;31.92;17.84;14.77;11.44;16.74 1995-02-15;9.24;10.28;25.83;22.56;22.55;6.36;24.58;23.52;41.34;15.1;8.79;26.67;12.98;10.7;17.6;4.96;18.79;33.28;11.23;12.89;16.64;17.87;7.59;45.43;14.85;31.92;17.99;15.02;11.44;17.14 1995-02-16;9.38;10.08;25.34;22.44;22.55;6.28;25.11;23.68;42.48;15.25;8.87;26.67;14.27;10.73;17.26;4.97;18.76;32.96;11.06;12.89;16.45;17.82;7.61;45.43;15.03;31.98;17.63;14.94;11.5;17.06 1995-02-17;9.12;10.35;24.91;22.31;22.18;6.24;24.82;23.31;41.65;15.1;8.79;26.35;14.09;10.7;17.15;4.9;18.64;32.55;11.1;12.69;16.21;18.2;7.55;44.76;14.66;32.16;17.31;14.69;11.32;17 1995-02-21;9.34;10.2;24.78;22.56;22.02;6.28;24.93;23.52;42.17;15.25;8.83;26.35;14.06;10.26;17.32;4.91;18.45;32.93;11.13;12.75;16.45;18.31;7.47;45.08;14.09;32.41;17.16;14.83;11.38;16.74 1995-02-22;9.15;10.16;25.15;22.44;22.39;6.26;24.99;23.25;42.48;15.28;9.03;26.83;14.23;10.31;17.21;4.95;18.45;33.2;11.1;12.95;16.39;18.37;7.69;45.62;14.18;32.16;17.21;14.86;11.38;16.94 1995-02-23;9.28;10.28;25.4;22.8;22.44;6.32;25.11;23.36;42.72;15.19;9.07;27.48;14.2;10.2;17.43;4.85;18.45;33.52;11.13;13.01;16.64;18.75;7.7;45.83;14.48;32.53;17.31;14.91;11.38;17.06 1995-02-24;9.15;10.28;25.52;22.56;21.91;6.42;25.46;23.46;42.82;15.1;8.97;27.32;14.24;10.2;17.32;4.88;18.61;33.3;11.1;13.04;16.64;18.64;7.66;46.47;14.79;32.65;17.21;14.91;11.38;17.14 1995-02-27;8.93;10.43;25.34;22.44;21.65;6.32;25.34;23.36;42.61;15.16;8.79;27.16;14.12;10.01;17.26;4.87;18.39;33.04;10.99;12.98;16.45;18.48;7.72;46.47;14.72;32.47;17.16;14.88;11.2;17.02 1995-02-28;8.81;10.31;25.46;22.38;21.86;6.28;25.57;23.73;42.82;15.22;8.97;27.4;14.17;9.87;17.15;4.96;18.7;32.82;11.17;12.95;16.52;18.64;7.88;46.68;14.79;32.53;17.47;14.97;11.38;17.06 1995-03-01;8.59;10.28;25.21;22.38;21.28;6.18;25.69;23.89;43.45;15.15;8.87;26.03;14.41;9.93;17.49;4.9;18.73;32.34;11.13;12.92;16.45;18.64;7.91;46.79;14.82;32.1;17.42;15.02;11.68;17.26 1995-03-02;8.7;10.28;25.15;22.38;20.64;6.14;25.51;23.57;43.03;15.1;8.7;25.63;14.26;9.96;17.32;4.91;19.2;31.42;11.06;13.26;16.58;18.59;7.97;46.15;14.85;32.35;17.36;15;11.92;17.26 1995-03-03;8.87;10.24;25.28;22.44;20.75;6.08;25.63;23.41;43.14;15.07;8.68;25.63;14.37;10.01;17.09;5.09;19.85;31.59;11.03;13.18;16.39;18.45;7.95;46.36;15.09;32.35;17.21;14.88;11.98;17.18 1995-03-06;8.62;10.16;25.21;22.25;20.64;6.02;25.98;23.31;42.61;15.25;8.64;25.15;14.6;9.87;17.15;5.11;19.94;31.26;10.89;13.24;16.33;18.83;8.04;45.93;15.39;32.53;17.1;15.08;11.68;17.89 1995-03-07;8.42;10.05;25.15;22.07;20.54;5.94;25.75;23.31;42.72;15.25;8.62;25.39;14.72;9.79;16.92;5;19.82;30.78;10.61;13.24;16.33;18.72;8.17;45.93;15.3;31.98;16.74;14.88;11.74;17.5 1995-03-08;8.59;10.08;25.21;22.07;20.48;6;25.8;23.31;42.51;15.43;8.73;25.87;14.57;9.65;17.09;4.96;19.82;30.83;10.5;13.26;16.33;18.67;8.56;45.83;15.36;31.92;16.79;14.86;11.74;17.5 1995-03-09;8.5;9.82;25.09;22.38;20.8;5.96;25.67;23.2;43.03;15.37;8.73;26.51;14.72;9.63;17.09;4.99;20.03;30.94;10.47;13.26;16.39;18.56;8.48;47.21;15.57;32.28;16.89;14.8;11.62;17.46 1995-03-10;8.64;10.01;25.71;22.74;21.12;6.1;26.49;23.41;43.56;15.49;8.97;26.75;14.64;9.71;17.21;5;20.16;31.37;10.85;13.46;16.83;18.56;8.57;47.85;15.63;32.9;17.26;14.91;11.86;17.93 1995-03-13;8.62;10.12;24.97;22.68;20.64;6.18;26.55;23.57;44.08;15.46;8.95;27.08;14.83;9.85;17.6;5.06;20.38;31.21;10.82;13.75;17.08;18.61;8.62;47.64;15.6;32.9;17.36;14.97;11.86;17.42 1995-03-14;8.45;10.16;25.71;23.71;20.75;6.26;26.55;23.83;43.98;15.43;9.01;26.75;14.77;9.68;17.49;5.12;20.25;31.16;10.85;13.75;17.45;18.83;8.97;49.13;15.72;33.57;17.57;14.94;11.92;17.54 1995-03-15;8.62;9.97;25.71;23.29;21.07;6.2;26.67;23.99;43.77;15.37;8.81;26.83;14.86;9.82;17.21;5.09;20.31;31.16;10.96;14.01;17.14;19;8.81;48.28;15.81;33.69;17.47;14.91;11.82;17.34 1995-03-16;8.64;10.12;26.08;23.89;21.6;6.34;27.31;24.05;43.98;15.55;8.99;26.92;14.74;9.98;17.21;5.06;20.75;30.51;10.96;14.06;17.2;19.17;8.77;48.39;15.63;33.51;17.68;14.94;11.88;17.5 1995-03-17;8.5;9.97;26.02;24.07;21.81;6.26;27.19;24.42;43.77;15.55;8.89;26.43;14.81;10.07;17.38;5.03;20.53;30.89;10.96;14.26;17.45;19.5;8.74;48.71;15.72;33.94;17.89;14.94;11.7;17.69 1995-03-20;8.7;10.24;26.08;23.89;21.65;6.26;26.96;24.84;43.45;15.52;8.87;26.19;14.95;10.01;17.21;5.18;20.75;30.83;10.96;14.15;17.39;19.77;8.89;49.24;16.43;34;18.15;14.69;11.82;17.57 1995-03-21;8.56;10.05;25.83;23.89;21.33;6.14;27.31;24.52;43.66;15.37;8.91;26.19;15.11;9.82;17.43;5.18;20.44;30.94;10.82;14.09;17.51;19.77;8.8;49.13;16.49;33.94;17.52;14.66;11.64;17.69 1995-03-22;9.04;10.16;25.95;23.59;21.01;6.24;27.54;24.42;42.82;15.64;8.95;26.35;15.09;9.87;17.43;5.25;20.28;31.42;10.71;14.03;17.39;19.61;8.87;48.39;16.43;33.94;17.73;14.86;11.64;17.73 1995-03-23;9.04;10.08;25.58;23.83;20.96;6.18;27.07;24.84;43.56;15.61;8.93;26.67;15.17;9.43;17.32;5.31;20.72;31.48;10.78;13.95;17.39;19.5;9.09;48.49;16.4;33.75;17.73;14.97;11.58;17.57 1995-03-24;9.24;10.43;25.95;24.13;21.6;6.3;26.96;25.26;44.29;15.7;9.01;27.4;15.15;9.46;17.43;5.35;20.78;31.64;10.75;14.12;17.63;19.33;9.23;49.88;16.52;34.24;17.89;15.22;11.82;17.73 1995-03-27;9.12;10.81;25.83;25.04;22.07;6.34;26.78;25.1;44.5;15.82;8.95;27.96;15.06;9.57;17.32;5.44;21.12;31.59;10.71;14.12;17.2;19.11;9.12;49.77;16.65;33.75;18.2;15.31;11.76;17.73 1995-03-28;9.18;10.66;25.89;25.04;21.97;6.28;26.61;25.42;45.13;15.73;8.99;27.72;15.27;9.65;17.21;5.5;21;32.07;10.75;14.09;17.45;19.28;9.2;49.13;16.68;33.57;18.15;15.28;11.94;17.65 1995-03-29;9.12;10.58;25.65;25.47;22.81;6.24;26.9;25.31;44.81;15.82;9.01;28.6;14.98;9.68;17.55;5.41;20.62;32.07;10.71;13.69;17.39;19.17;9.03;49.45;16.52;33.02;18.31;15.56;12.24;17.54 1995-03-30;9.69;10.77;25.83;25.77;23.87;6.24;26.49;25.79;44.81;15.76;8.97;28.84;14.72;9.76;17.6;5.31;20.47;32.28;10.71;13.69;17.2;18.61;9.02;49.88;16.28;32.84;17.89;15.56;12.24;17.5 1995-03-31;9.38;10.7;25.52;26.07;23.5;6.24;26.32;25.58;44.71;15.87;8.85;28.28;14.83;9.74;17.77;5.28;20.41;32.23;10.63;13.58;16.95;18.89;8.89;49.56;16.12;32.41;17.63;15.59;12.3;17.1 1995-04-03;9.32;10.69;25.52;25.65;23.71;6.16;26.96;25.79;43.87;15.79;8.95;28.68;14.95;9.68;17.77;5.5;20.59;32.18;10.73;13.58;16.89;19.28;8.75;49.03;16.37;32.28;17.47;15.67;12.48;17.46 1995-04-04;9.44;10.92;25.77;25.95;23.77;6.3;27.25;26.05;44.6;16.02;8.99;27.96;14.98;9.6;17.94;5.38;20.62;32.61;10.87;13.66;17.32;19.22;8.73;49.67;16.55;33.08;17.91;15.64;12.42;17.61 1995-04-05;9.63;10.84;25.59;25.83;23.61;6.24;27.19;26.74;44.08;16.2;8.99;27.8;14.75;9.54;17.49;5.39;20.87;32.55;11.05;13.61;17.2;19.11;8.83;49.03;16.52;33.14;17.86;15.56;12.48;17.46 1995-04-06;9.46;10.92;25.71;25.89;23.71;6.34;27.31;27.38;43.98;15.9;9.05;27.64;14.67;9.41;18.06;5.32;20.84;32.44;11.54;13.52;17.39;19.11;8.75;49.56;16.65;33.57;18.02;15.64;12.18;17.38 1995-04-07;9.46;10.88;25.46;25.89;23.66;6.38;27.42;26.37;43.35;15.93;8.99;28.04;14.78;9.43;18.11;5.42;20.87;32.55;11.44;13.46;17.39;19;8.7;49.45;16.61;33.63;18.33;15.59;12.06;17.56 1995-04-10;9.66;10.88;25.59;26.14;23.71;6.42;27.31;26.42;43.66;15.93;9.01;28.44;15.09;9.63;17.77;5.5;21.37;32.71;11.4;13.69;17.14;19;8.87;48.92;16.77;33.63;18.28;15.25;12.18;17.48 1995-04-11;9.75;10.84;25.4;26.14;23.34;6.4;27.02;26.21;43.77;15.9;8.97;28.36;15.11;9.24;17.83;5.67;21.56;32.55;11.29;13.72;16.95;19.05;9.02;48.71;16.74;32.96;18.17;15.28;12.06;17.6 1995-04-12;9.63;10.81;25.34;27.11;23.66;6.38;27.25;26.16;43.66;15.93;8.97;28.44;15.06;9.35;17.77;5.7;21.65;32.39;11.26;13.72;17.14;19;8.95;49.13;16.68;33.2;18.33;15.53;11.94;17.6 1995-04-13;10.11;10.81;25.28;26.74;23.5;6.36;27.13;25.84;44.5;15.99;9.01;28.2;15.21;9.52;18.11;5.91;21.46;32.34;11.29;14.06;17.39;19.11;9.06;49.35;16.71;33.26;18.33;15.79;12.18;17.48 1995-04-17;9.83;10.65;24.78;26.8;23.87;6.46;26.67;26.32;44.29;16.02;8.83;28.2;15.52;9.52;18.34;5.84;21.84;31.42;11.44;13.81;17.32;19.22;9.67;49.45;16.65;32.59;18.39;15.98;12.18;17.44 1995-04-18;9.72;10.57;24.66;25.95;23.98;6.48;27.25;26;43.98;16.2;8.85;27.64;15.77;9.3;17.83;5.86;21.93;30.94;11.79;14.29;17.14;19.05;9.59;49.56;16.46;33.2;18.17;15.76;12.12;17.44 1995-04-19;9.92;10.77;24.6;26.07;24.4;6.42;27.02;25.9;47.86;16.32;8.97;28.28;15.52;9.19;17.6;5.8;21.65;31.75;11.61;14.32;17.51;18.67;9.52;50.09;16.55;33.2;18.39;15.79;12;17.28 1995-04-20;9.97;10.88;24.23;26.62;23.87;6.28;26.72;26.48;47.65;16.62;8.85;28.2;15.77;9.16;18;5.78;22.11;31.59;11.65;14.38;17.26;18.56;9.41;49.98;16.49;33.57;18.33;16.04;11.88;17.44 1995-04-21;10.11;10.81;24.23;27.04;23.71;6.36;27.13;26.95;48.28;16.5;9.01;28.04;15.77;9.21;17.77;5.77;22.77;31.8;11.54;14.43;17.51;19;9.38;51.48;16.58;33.81;18.28;16.41;11.76;17.52 1995-04-24;10.31;10.81;24.23;27.59;23.71;6.63;27.25;27.06;48.91;16.59;9.09;28.36;16.14;9.16;18.11;6;23.23;32.18;11.75;14.6;17.76;19.22;9.72;51.58;16.71;34.24;18.6;16.69;11.7;17.84 1995-04-25;10.2;10.73;24.72;27.23;23.98;6.56;27.19;27.59;48.7;16.68;9.13;28.68;16.17;8.97;17.89;6.11;23.26;32.34;11.82;14.55;17.57;18.94;10;50.41;16.86;33.26;18.65;16.57;11.4;17.84 1995-04-26;9.97;10.77;24.97;27.23;23.98;6.63;27.13;27.8;48.7;16.62;9.16;28.12;16.08;8.99;17.89;6.19;23.67;32.12;11.79;14.63;17.51;19;9.95;50.73;16.71;33.51;18.6;16.72;11.4;17.88 1995-04-27;9.83;10.73;25.03;27.11;24.14;6.71;27.07;28.27;47.86;16.59;9.24;27.96;16.2;9.3;18.11;6.26;24.07;32.34;11.72;14.46;17.45;18.89;9.83;51.16;16.68;33.39;18.65;16.72;11.46;18.12 1995-04-28;10.14;10.73;25.03;26.68;24.88;6.69;27.13;27.85;48.28;16.56;9.18;29;16.29;9.19;17.94;6.36;23.51;33.09;11.75;14.83;17.39;19;10.22;50.84;16.71;34.18;18.7;16.49;11.4;17.72 1995-05-01;10.05;10.65;24.85;26.62;24.46;6.67;26.9;27.96;47.75;16.89;9.24;29.08;15.83;9.13;17.83;6.47;22.89;33.36;11.68;14.8;17.51;19.11;10.27;50.3;17.05;33.94;19.02;16.69;11.04;17.28 1995-05-02;10.16;10.65;25.03;26.98;24.35;6.63;27.07;28.33;48.28;16.89;9.22;28.68;15.86;9.1;17.94;6.47;23.08;33.79;11.72;14.83;17.45;19.05;9.95;50.3;17.23;34.18;19.02;16.8;11.1;17.24 1995-05-03;10.36;10.81;25.15;27.17;24.46;6.77;27.37;28.06;50.8;16.86;9.28;28.68;16.63;9.43;18.06;6.68;23.42;33.73;11.89;15;18.01;19.5;10.11;51.05;17.91;34.73;19.08;16.86;11.28;17.36 1995-05-04;9.97;10.73;25.28;26.92;23.98;6.81;27.54;27.69;50.69;16.92;9.36;27.8;16.51;9.21;18.57;6.83;23.3;33.9;12.17;15.09;17.94;19.61;10.19;51.26;17.42;34.79;19.29;16.8;11.4;17.28 1995-05-05;9.45;10.84;25.09;26.62;23.71;6.89;27.77;27.9;51.22;16.92;9.4;27.51;16.41;9.08;18.79;6.75;23.14;32.82;12.17;14.95;18.07;19.72;10;51.16;17.63;34.43;19.08;16.63;11.52;17.24 1995-05-08;9.88;10.77;25.52;26.5;24.14;6.89;28.36;28.64;51.01;16.95;9.59;28.15;16.51;9.16;18.74;6.94;23.3;33.79;12.38;15.17;18.07;19.61;9.98;50.73;17.57;35.04;19.29;16.46;11.46;17.4 1995-05-09;9.77;10.96;25.59;27.04;24.62;7.01;28.47;28.81;51.43;16.65;9.61;28.32;16.51;9.21;18.68;6.92;23.26;33.52;12.49;15.17;18.25;19.55;9.98;50.73;17.66;34.85;19.39;16.88;11.28;17.36 1995-05-10;9.85;10.88;25.4;26.44;24.99;7.11;28.65;29.02;50.17;16.74;9.69;29.77;16.78;9.21;18.79;6.76;23.33;33.36;12.49;15.28;18.38;19.05;9.91;52.54;17.69;34.73;19.23;16.8;11.28;16.96 1995-05-11;10.11;11;25.46;26.38;25.09;6.95;28.42;29.4;51.43;16.65;9.56;29.29;16.81;9.41;18.45;6.79;23.42;33.9;12.53;15.48;18.38;19.11;10.17;52.65;17.63;34.61;18.97;17.22;11.7;17.28 1995-05-12;10.59;10.88;25.46;26.5;26.74;6.83;27.54;29.5;51.01;16.65;9.67;30.18;16.85;9.74;18.74;6.76;23.45;35.13;12.67;14.85;18.32;18.78;10.09;52.54;17.32;33.94;19.13;16.97;12.12;17.4 1995-05-15;10.79;10.92;25.09;26.62;26.48;7.09;27.02;29.4;50.69;16.8;9.44;31.07;17.49;9.57;18.94;6.74;23.61;34.93;12.63;14.59;18.38;18.67;10.16;52.73;17.48;33.94;19.45;17.03;12.3;17.64 1995-05-16;10.68;11.04;25.28;26.98;26.48;7.03;26.78;29.5;50.8;16.98;9.32;30.74;17.12;9.08;19;6.77;23.51;34.88;12.81;14.56;18.25;18.72;10.61;52.84;17.39;33.81;18.97;17.17;12.06;17.68 1995-05-17;10.56;10.96;25.28;27.65;26.69;6.91;27.07;28.97;50.9;16.98;9.42;30.34;17.31;8.97;18.54;6.89;23.57;34.93;12.67;14.73;18.38;18.5;10.75;51.77;17.29;33.75;18.44;16.88;11.94;17.64 1995-05-18;10.39;10.84;24.6;26.98;25.89;6.73;26.72;28.55;50.27;16.83;9.26;29.53;16.91;8.86;17.86;6.89;23.14;34.18;12.67;14.22;17.94;18.28;10.58;49.72;16.86;33.26;18.28;16.69;11.76;17.2 1995-05-19;10.68;10.69;24.78;26.74;25.41;6.81;27.25;28.76;50.38;16.68;9.26;30.02;16.6;8.8;17.8;6.92;23.2;34.02;12.53;14.36;17.7;18.61;10.67;49.62;17.08;33.26;18.07;16.54;11.88;17.28 1995-05-22;10.87;10.81;24.97;27.29;26.58;6.77;27.42;28.86;50.69;16.65;9.36;30.1;17.03;9.24;18.09;7.09;23.67;34.88;12.84;14.59;18.01;18.83;10.91;50.48;17.14;33.63;18.7;16.91;11.82;17.52 1995-05-23;11.04;10.92;24.6;27.59;25.63;6.85;27.95;29.18;51.01;16.92;9.44;30.58;17.43;9.21;18.6;7.24;24.16;35.1;13.23;14.85;18.25;18.94;11.06;50.91;17.45;33.81;18.39;17.03;11.88;17.64 1995-05-24;10.93;10.96;24.6;27.89;25.63;6.83;27.83;29.13;51.43;17.04;9.36;30.02;17.28;9.19;18.77;7.23;23.89;34.61;12.95;14.91;18.01;19.72;10.94;50.8;17.6;33.75;18.44;17.37;11.52;17.76 1995-05-25;10.65;10.84;24.66;27.53;25.15;6.71;28.01;28.81;51.34;17.01;9.26;29.61;17.06;9.05;18.48;7.31;24.04;33.85;13.16;14.88;18.13;20.16;11.16;50.26;17.72;34.36;18.81;17.11;11.58;17.64 1995-05-26;10.62;10.81;24.29;27.41;24.4;6.77;27.83;28.6;50.81;16.62;9.24;29.53;16.48;8.94;18.48;7.2;23.61;33.75;13.02;14.71;18.01;20;10.94;49.83;17.23;34.06;18.49;16.97;11.4;17.72 1995-05-30;10.59;10.77;24.66;28.26;24.83;6.73;28.07;28.07;50.07;16.74;9.28;29.93;15.92;8.99;18.43;6.87;23.02;33.53;12.84;14.71;18.32;20.05;10.38;49.83;17.45;34.06;18.6;17.11;11.46;17.68 1995-05-31;10.56;10.96;25.03;28.56;25.63;6.81;28.77;28.92;51.03;17.01;9.5;31.07;16.26;9.16;18.37;6.98;23.11;33.96;12.98;15.16;18.81;20.83;10.59;51.55;17.97;35.16;19.08;17.22;11.94;17.76 1995-06-01;10.5;11.15;25.03;28.44;25.73;7.03;28.47;28.76;51.98;16.98;9.5;30.91;16.72;9.1;18.37;7.13;23.42;34.12;13.19;15.25;18.63;20.94;10.52;50.58;17.97;34.73;19.02;17.59;11.88;17.88 1995-06-02;10.22;11.15;25.09;28.62;25.2;7.19;28.42;28.12;51.87;16.83;9.3;30.66;17.09;9.24;18.37;7.24;23.33;33.8;13.44;15.11;18.44;21.13;10.39;50.26;18.22;34.36;18.92;17.11;11.94;17.88 1995-06-05;10.48;11;25.03;29.89;25.47;7.17;28.18;28.6;52.4;16.92;9.48;31.07;17;9.24;18.48;7.2;22.67;33.91;13.23;15.11;18.25;21.96;10.59;50.37;18.12;34.3;19.29;17.59;11.94;17.92 1995-06-06;10.33;10.92;24.78;29.47;25.57;7.11;28.12;29.02;52.19;16.86;9.44;30.99;16.81;9.1;18.65;6.99;22.7;34.07;13.23;15.22;18.07;22.19;10.39;50.37;18.16;34.61;19.29;17.82;12.12;18.4 1995-06-07;10.33;10.73;24.6;29.65;25.84;6.89;28.24;28.92;51.98;16.92;9.4;30.66;16.88;8.99;18.43;7.03;22.33;34.23;13.12;15.19;18.01;21.69;10.5;50.48;18;34.55;19.13;17.59;12.18;18.32 1995-06-08;10.33;10.65;24.91;30.2;26.37;6.79;28.36;28.71;51.34;16.95;9.32;30.34;17.18;9.05;18.31;7.08;22.21;34.5;12.67;15.22;18.01;21.57;10.52;50.58;17.63;34.61;19.18;17.54;12.09;18.24 1995-06-09;10.16;10.69;24.91;30.26;26.16;6.71;28.01;28.28;50.6;16.83;9.11;30.02;17.09;9.05;18.09;7.01;22.15;34.23;12.38;15.16;18.19;21.18;10.61;50.37;17.32;34.36;19.23;17.51;12.03;18.36 1995-06-12;10.11;10.73;25.03;30.26;25.89;6.77;28.12;28.55;51.24;16.77;9.3;30.02;16.97;9.21;18.14;6.94;22.43;34.02;12.6;15.19;18.19;21.46;10.47;50.91;17.51;34.73;19.29;17.62;12.27;18.88 1995-06-13;10.05;10.92;25.15;31.47;26.69;6.89;28.34;28.23;51.66;16.8;9.42;30.26;17.18;9.35;18.37;6.9;22.8;34.93;13.02;15.48;18.38;21.57;10.48;51.44;17.5;34.98;19.5;17.57;12.57;19.04 1995-06-14;10.11;10.84;25.4;31.05;26.9;6.79;28.52;27.85;51.98;16.83;9.46;30.18;17.4;9.52;18.26;6.99;23.11;34.77;13.09;15.65;18.5;21.46;10.48;51.34;17.68;35.16;19.5;17.65;12.75;18.64 1995-06-15;10.14;10.88;25.4;30.99;26.74;6.79;28.75;28.17;51.76;17.01;9.46;30.02;17.89;9.32;18.03;7.16;23.11;34.29;12.95;15.54;18.75;21.57;10.61;51.01;18.15;35.46;19.34;17.59;12.63;18.52 1995-06-16;10.16;10.81;25.65;31.23;26.64;6.79;29.22;28.39;52.08;17.19;9.4;29.85;18.6;8.94;18.2;7.22;23.02;34.34;12.77;15.77;18.69;21.74;10.88;50.69;18.4;35.77;19.76;17.65;12.75;18.32 1995-06-19;10.5;10.88;26.02;31.53;27.65;6.97;29.4;29.13;53.14;17.07;9.48;30.26;18.79;8.66;18.26;7.68;23.3;34.18;13.19;15.88;18.88;21.63;11.23;51.77;18.59;36.2;20.03;17.96;12.93;18.68 1995-06-20;10.42;10.81;26.08;31.17;27.27;6.85;29.63;28.76;52.82;16.71;9.38;31.23;18.82;8.61;18.94;8.08;24.29;34.12;13.41;15.68;18.57;21.41;11.42;50.91;18.65;35.83;19.76;17.96;12.81;18.64 1995-06-21;10.62;11.11;25.95;31.29;26.69;6.99;29.98;28.33;52.5;16.5;9.36;31.31;18.48;8.55;18.71;7.92;24.13;34.29;13.48;15.97;18.88;21.91;11.31;50.58;18.62;36.02;19.66;17.76;12.93;18.8 1995-06-22;10.76;11.31;26.32;31.29;26.58;7.21;30.39;29.18;53.03;16.44;9.38;31.07;18.91;8.69;19;8.13;24.23;35.74;13.62;16.31;19.12;22.24;11.48;50.69;18.99;35.83;20.03;17.88;12.93;19.04 1995-06-23;10.76;11.27;26.08;31.71;26.69;7.19;30.63;29.13;53.14;16.62;9.36;30.66;18.57;8.8;18.94;8.16;24.51;35.85;13.44;16.31;18.88;22.19;11.39;50.48;18.87;34.85;19.98;17.85;12.93;19.04 1995-06-26;10.79;11;25.89;30.86;26.48;6.97;30.8;28.76;52.08;16.71;9.32;30.58;18.29;8.77;18.77;8.08;24.41;35.64;13.37;15.94;18.81;21.96;11.22;50.48;18.62;35.1;19.55;17.79;12.39;18.24 1995-06-27;10.76;10.92;26.08;30.62;26.8;6.87;30.34;28.81;52.29;16.83;9.3;30.99;18.45;8.66;18.94;7.79;23.7;34.99;13.26;15.51;18.88;21.69;10.86;50.37;18.59;35.4;19.87;17.82;12.51;17.96 1995-06-28;10.9;10.88;26.14;30.93;26.53;6.89;30.22;28.86;51.45;17.19;9.3;30.99;18.26;8.8;19.28;7.85;23.89;35.37;13.58;15.65;19.06;22.13;10.98;49.94;18.62;35.53;20.03;17.76;12.93;18 1995-06-29;11.02;10.96;26.14;31.29;26.48;7.05;29.98;29.34;50.81;17.16;9.18;31.07;18.2;8.86;19.39;7.93;24.1;35.96;13.37;15.68;19.25;22.19;11.17;49.08;18.46;35.34;19.82;17.85;12.75;17.84 1995-06-30;11.38;10.88;26.14;30.38;27.33;7.07;29.87;29.29;51.24;16.83;9.24;30.34;18.35;8.97;20.25;7.87;23.85;37.04;13.3;15.48;19.43;21.91;11.3;49.3;18.56;35.16;20.19;17.74;12.87;17.76 1995-07-03;11.58;10.84;26.45;29.89;27.38;7.17;30.22;29.34;52.72;16.89;9.35;30.99;18.48;9.01;19.96;7.87;24.26;37.47;13.37;15.52;19.37;22.13;11.37;49.51;18.59;35.28;20.13;17.78;12.75;17.72 1995-07-05;11.98;11.03;26.57;30.62;28.07;7.21;29.93;29.5;52.61;16.86;9.46;31.55;18.75;9.1;20.19;7.93;24.04;38.12;13.41;15.25;19.25;22.02;11.34;50.26;18.71;34.91;19.66;17.93;12.75;17.6 1995-07-06;12.38;11.15;27;31.41;29.08;7.25;30.22;29.93;52.19;17.22;9.67;32.2;19.46;9.32;20.42;8.14;24.57;38.17;13.76;15.45;19.19;21.74;11.59;50.8;18.96;34.24;20.15;17.93;12.99;17.83 1995-07-07;12.72;11.3;26.82;31.35;30.2;7.45;29.63;30.84;52.08;17.07;9.83;33.01;19.68;9.52;21.1;8.49;24.72;38.5;14.05;14.88;18.69;21.24;11.95;51.34;19.12;33.75;20.05;18.22;12.87;17.75 1995-07-10;12.38;11.15;26.51;31.17;29.88;7.47;29.87;30.57;52.4;16.89;9.79;33.49;19.92;9.35;20.87;8.74;25;39.2;14.54;14.96;18.88;21.85;12.36;50.48;19.06;33.81;19.62;18.27;12.63;17.51 1995-07-11;12.21;11.19;26.45;31.11;29.88;7.41;29.98;30.25;52.93;17.01;9.67;32.69;19.56;9.32;20.7;8.56;24.79;37.42;14.22;15.22;18.81;22.08;12.06;51.01;19.09;34.18;19.57;18.47;12.51;17.35 1995-07-12;12.69;11.3;27;31.17;30.46;7.47;30.51;30.25;53.67;17.13;9.69;32.77;20.05;9.46;21.16;8.98;25.25;38.39;14.33;15.14;18.94;22.08;12.48;51.12;19.24;34.24;20.1;18.61;12.75;17.19 1995-07-13;12.89;11.26;26.76;31.77;30.78;7.39;30.28;29.72;53.98;17.13;9.59;32.77;20.6;9.63;20.76;9.15;25.78;38.39;14.44;15.25;18.94;22.69;12.52;50.8;18.84;34.06;19.94;18.39;12.45;17.55 1995-07-14;13;11.38;26.57;31.41;30.84;7.33;29.93;29.45;53.46;17.07;9.52;33.09;20.36;9.49;20.47;9.39;25.81;38.01;14.08;15.34;18.81;22.58;12.95;50.69;18.65;34;19.83;18.33;12.51;17.55 1995-07-17;12.89;11.3;26.88;31.47;31.42;7.61;29.98;29.93;52.5;17.22;9.75;32.85;20.32;9.52;20.87;9.5;26.65;38.07;13.69;15.42;18.75;22.52;13.62;51.34;18.96;34;19.78;18.42;12.87;17.47 1995-07-18;12.69;11.22;26.82;30.93;30.5;7.59;30.22;29.77;49.76;17.1;9.67;32.04;19.86;9.38;20.36;9.11;26.59;36.93;14.15;15.74;18.63;22.63;12.73;50.58;18.84;34;19.67;18.39;12.87;17.19 1995-07-19;12.49;10.91;26.45;30.44;29.54;7.31;30.51;29.45;48.7;17.24;9.52;31.47;19.19;9.24;20.25;8.11;25.16;36.45;14.26;15.82;18.57;22.52;11.81;50.26;18.71;33.63;20.05;18.05;12.93;17.15 1995-07-20;12.46;11.03;26.57;30.44;28.85;7.23;30.1;29.61;49.12;17.42;9.73;32.12;19.15;9.38;20.47;8.02;25.87;36.55;14.72;15.74;18.81;22.19;12.02;50.69;18.74;32.77;20.8;18.02;13.11;17.31 1995-07-21;12.49;11.11;26.45;30.56;28.85;7.23;30.51;29.88;49.23;17.45;9.81;32.28;19.09;9.41;20.64;7.83;25.75;36.07;14.33;15.85;19.19;22.3;11.5;50.58;18.65;32.71;20.48;17.99;13.23;17.51 1995-07-24;12.29;11.22;26.26;31.05;29.49;7.31;30.57;30.36;49.76;17.33;9.77;32.04;19.31;9.38;20.64;8.36;26.71;36.28;14.72;16;19.19;22.24;11.7;50.48;18.62;32.9;20.74;17.99;12.99;17.63 1995-07-25;12.61;11.77;25.89;32.02;29.86;7.35;30.75;30.2;50.6;17.24;9.77;33.01;19.62;9.68;20.76;8.58;26.93;36.23;14.83;16.05;19.43;22.24;12.05;51.12;18.43;33.26;20.85;18.5;12.99;17.87 1995-07-26;12.55;11.73;25.65;31.71;29.86;7.49;31.16;29.18;49.97;17.36;9.71;32.36;19.86;9.79;20.93;8.47;27.08;36.07;14.79;16.17;19.43;22.3;12;48.11;18.74;34.12;20.64;18.76;12.93;18.23 1995-07-27;12.75;11.89;25.77;32.74;30.02;7.51;31.16;28.81;49.86;17.33;9.71;32.2;20.02;9.87;20.99;8.55;27.52;36.77;14.83;16.4;19.5;22.69;12.06;48.76;18.15;34.3;20.37;19.15;13.05;18.35 1995-07-28;12.92;11.73;26.45;33.05;29.59;7.59;30.92;28.92;49.12;17.13;9.63;31.96;19.74;9.76;20.93;8.35;27.49;36.23;14.79;16.45;19.25;22.97;11.58;48.76;18.15;34.12;20.42;19.1;12.81;18.39 1995-07-31;12.95;11.96;26.02;32.5;30.07;7.66;30.75;28.55;48.7;17.27;9.67;31.55;19.19;9.68;21.27;8.08;27.05;36.5;14.69;16.45;19.19;23.02;11.31;48.65;17.87;33.69;20.58;19.07;12.81;18.8 1995-08-01;12.72;11.96;25.83;32.56;29.11;7.59;31.16;28.12;48.49;17.01;9.61;31.31;18.66;9.68;21.04;7.86;27.24;36.39;14.51;16.31;19.25;23.19;11.19;48.97;17.99;33.63;20.26;18.98;12.51;19.72 1995-08-02;12.71;11.96;25.96;32.14;28.74;7.68;30.86;28.39;48.38;16.98;9.4;31.47;17.86;9.74;21.04;7.65;26.71;36.61;14.9;16.17;18.94;23.08;11.12;49.08;18.24;34;20.96;19.04;12.45;19.44 1995-08-03;13;12.27;25.71;32.5;29.06;7.59;30.8;28.33;49.76;17.01;9.4;31.39;18.29;9.71;21.1;7.72;27.08;36.88;15.01;16.02;18.88;22.74;11.39;48.87;18.31;33.45;21.38;18.96;12.27;19.04 1995-08-04;12.91;12.27;25.52;32.26;28.69;7.61;30.98;28.23;50.5;16.83;9.44;31.23;17.95;9.6;20.7;7.71;26.99;36.82;15.04;16.2;18.81;22.91;11.73;47.9;18.46;34.06;21.22;18.93;12.33;18.59 1995-08-07;13.14;12.27;25.46;32.2;28.31;7.76;30.8;28.28;50.81;16.8;9.63;31.31;17.95;9.6;20.53;7.9;27.05;37.31;15.01;16.23;18.94;22.69;11.7;48.22;18.59;33.94;20.85;19.04;12.21;18.23 1995-08-08;13.11;12.08;25.4;31.96;28.26;7.78;30.92;28.12;51.13;16.77;9.67;31.07;18.26;9.57;20.76;8.05;27.24;36.82;15.36;16.2;19.37;22.41;11.69;47.79;18.68;33.75;21.01;19.04;12.27;18.59 1995-08-09;12.94;11.96;25.59;31.71;27.78;7.72;31.27;27.96;50.71;16.89;9.61;31.07;18.51;9.32;20.7;8.22;27.3;36.61;15.29;16.14;19.12;22.8;12.06;47.36;18.34;33.45;21.01;18.96;12.03;18.51 1995-08-10;12.83;12.08;25.65;31.29;27.19;7.61;31.27;27.69;50.39;16.68;9.5;30.74;18.63;9.38;20.7;7.99;27.12;35.58;15.15;16.11;19.12;22.52;11.77;47.36;18.34;33.57;21.01;18.96;11.97;18.55 1995-08-11;12.94;12;25.4;31.11;27.08;7.59;30.92;27.76;49.76;16.53;9.46;30.5;18.75;9.35;20.25;8.22;27.15;35.15;14.97;15.81;19;22.35;12.06;47.68;17.96;33.63;20.9;18.84;11.91;18.11 1995-08-14;12.91;12.2;25.52;31.35;28.21;7.63;31.1;27.81;50.92;16.65;9.61;31.31;19.43;9.52;20.76;8.25;27.52;35.26;15.08;16.01;19.31;22.69;12.34;47.79;18.06;33.69;20.8;18.96;11.85;18.92 1995-08-15;12.71;12.27;25.65;30.99;28.1;7.63;30.69;27.76;50.81;16.59;9.61;31.34;19.19;9.32;20.82;8.14;27.83;34.99;15.08;15.9;18.75;22.3;12.3;47.58;18.21;33.45;20.8;18.96;11.91;19.16 1995-08-16;13.28;12.31;25.71;30.68;29.06;7.59;30.22;27.76;49.76;16.5;9.54;31.51;20.32;9.43;20.96;8.3;27.92;35.75;15.36;15.67;18.44;22.08;12.34;47.79;18.28;32.9;20.64;18.73;12.15;18.96 1995-08-17;13.43;12.35;25.59;30.38;29.38;7.47;30.16;27.76;49.86;16.35;9.44;30.85;20.66;9.41;20.73;8.16;28.23;35.53;15.15;15.55;18.38;21.91;12.39;47.9;18.09;32.77;20.58;18.64;12.15;18.96 1995-08-18;13.26;12.43;25.71;30.68;28.95;7.61;29.52;27.86;48.81;16.41;9.38;30.61;20.57;9.41;20.56;8.07;27.67;35.8;15.26;15.52;18.32;21.85;12.14;47.68;18.03;32.84;20.74;18.7;12.15;19 1995-08-21;13.37;12.39;26.39;31.47;28.9;7.59;29.57;28.08;49.12;16.38;9.42;30.2;19.71;9.27;20.56;7.49;26.53;35.86;15.22;15.58;18.32;21.96;11.81;47.68;18.37;32.77;20.8;18.73;12.21;18.92 1995-08-22;13.63;12.43;26.63;31.47;28.53;7.72;29.63;27.81;49.02;16.35;9.42;29.96;19.86;9.21;20.33;7.74;26.74;35.86;15.22;15.67;18.38;22.08;12.41;47.58;18.53;32.9;20.9;19.01;12.15;18.84 1995-08-23;13.45;12.39;26.45;30.86;27.94;7.74;29.46;27.92;48.91;16.29;9.38;29.96;19.96;9.08;20.28;7.76;26.49;35.31;15.22;15.73;18.38;22.3;12.23;47.44;18.43;33.08;20.53;19.01;11.91;18.39 1995-08-24;13.31;12.43;26.51;30.62;27.51;7.84;29.87;27.86;49.02;16.35;9.46;30.2;19.99;9.1;20.56;7.59;26.06;35.15;15.22;15.67;18.38;22.58;12.02;46.9;18.53;33.39;20.74;18.93;11.85;17.99 1995-08-25;13.4;12.47;27.13;30.68;27.78;7.98;30.22;27.81;49.23;16.56;9.57;29.96;19.43;9.13;20.33;7.51;25.81;35.21;15.47;15.67;18.13;22.52;11.8;47.33;18.68;33.69;21.12;18.93;12.09;18.19 1995-08-28;13.37;12.6;26.88;30.93;27.94;7.82;30.34;27.81;48.81;16.41;9.63;29.63;19.03;8.97;20.28;7.29;25.25;35.48;17.1;15.87;18.07;22.3;11.26;47.12;18.59;33.88;21.22;18.87;11.79;18.11 1995-08-29;13.57;12.55;27.25;31.05;28.63;7.78;30.28;27.65;49.12;16.38;9.65;30.77;18.97;8.86;20.05;7.32;25.44;35.8;16.89;15.9;18.01;22.24;11.48;47.23;18.84;34;21.28;18.93;12.09;18.07 1995-08-30;13.45;12.47;27.93;31.05;28.53;7.76;30.1;27.86;48.93;16.35;9.67;30.37;19.25;8.91;19.93;7.51;25.25;35.53;16.78;15.9;18.19;22.3;11.66;47.12;18.71;34;21.44;19.07;12.03;18.15 1995-08-31;13.03;12.55;27.93;31.05;28.69;7.76;30.1;28.08;49.15;16.38;9.65;30.69;19.71;8.8;20.28;7.63;25.69;35.59;16.57;15.9;18.13;22.24;11.56;47.33;18.62;33.94;21.65;19.04;11.81;18.03 1995-09-01;12.97;12.66;27.62;31.71;29.22;7.8;30.04;28.51;48.93;16.62;9.63;31.59;19.31;8.8;20.73;7.57;25.53;35.86;16.5;15.84;18.19;22.41;11.22;47.12;18.62;33.94;21.33;19.27;11.99;17.95 1995-09-05;13.08;12.9;27.5;32.68;29.27;8;29.87;28.45;49.15;16.77;9.63;32.08;20.48;9.13;20.68;7.92;25.13;36.73;16.57;15.98;18.26;22.73;11.88;47.23;18.49;34.06;21.49;19.41;11.99;17.67 1995-09-06;13.17;12.78;27.43;32.99;29.65;7.94;30.22;28.88;50.85;16.74;9.73;32.16;20.45;9.16;20.9;7.77;25.03;36.73;16.75;16.01;18.44;22.96;11.69;47.44;18.59;34.06;21.81;19.36;11.93;17.79 1995-09-07;13.17;12.86;27.06;32.32;29.65;7.9;29.93;28.78;50.74;17.01;9.69;31.75;20.51;9.24;20.96;8.08;24.69;37.05;16.64;16.04;18.38;23.12;11.83;46.68;18.65;33.94;21.87;19.01;12.05;17.71 1995-09-08;13.28;13.05;27.13;33.23;29.54;8.08;29.81;29.31;50.85;16.98;9.63;32.08;20.69;9.27;20.85;8.16;24.57;37.6;16.82;16.07;18.69;23.24;11.94;48.09;18.56;34.06;22.03;19.13;11.93;17.55 1995-09-11;13.63;13.13;27.13;33.65;29.11;8.08;29.87;29.85;50;17.04;9.65;32.16;21.03;9.3;20.62;8.16;23.95;37.32;17.07;16.13;18.5;23.4;12.2;47.44;18.65;34.79;22.03;19.38;12.11;17.71 1995-09-12;13.63;13.17;27.37;33.9;28.79;8.16;30.28;30.39;51.17;17.3;9.83;31.1;20.6;8.91;20.96;8.07;24.23;37.81;17.14;16.07;18.5;23.29;12.03;47.55;18.84;35.04;22.03;19.47;12.23;18.07 1995-09-13;13.37;13.05;27.8;34.32;28.63;8.2;30.97;30.55;53.4;17.48;9.93;30.61;21;8.77;21.02;8.07;23.51;37.7;17.07;16.19;19.06;23.35;12.02;48.53;19.09;35.83;22.19;19.36;12.29;18.39 1995-09-14;13.31;13.56;28.3;34.44;27.78;8.44;31.2;30.82;53.51;17.6;10.22;30.77;20.82;8.5;20.96;7.92;23.2;37.76;17.21;16.56;19.68;23.57;11.86;48.74;19.22;36.5;22.83;19.3;12.23;18.47 1995-09-15;12.88;13.79;28.73;33.9;27.88;8.52;31.32;30.92;52.44;17.54;10.47;30.94;19.83;8.75;20.68;7.72;22.92;37.22;17.35;16.47;19.93;23.85;11.68;49.07;19.5;36.75;23.31;19.21;12.35;18.43 1995-09-18;12.57;13.52;28.67;34.32;27.94;8.46;31.44;30.92;51.7;17.3;10.22;30.61;20.05;8.91;20.62;7.82;23.39;36.73;17;16.45;19.75;24.36;11.5;48.74;19.97;36.61;23.2;19.16;12.41;18.43 1995-09-19;12.31;13.87;28.42;34.26;25.16;8.46;31.73;30.44;50.53;17.45;10.16;30.77;20.63;9.08;20.56;7.79;24.04;36.4;17.21;16.62;19.68;24.19;11.66;48.85;20.2;36.93;23.15;19.27;12.11;18.63 1995-09-20;12.2;13.67;31.44;34.81;25.59;8.4;32.5;30.06;50.32;17.39;10.16;31.1;20.66;9.24;20.62;7.79;23.79;36.94;17.21;16.5;19.75;24.7;11.64;48.85;20.39;36.81;23.36;19.3;12.17;18.55 1995-09-21;12.31;13.36;30.89;34.75;25.16;8.24;32.67;29.37;50.1;17.3;10.18;31.02;20.51;8.97;20.56;7.6;23.45;36.18;16.71;16.99;20.12;25.37;11.33;47.55;20.2;37.05;23.26;19.3;11.99;18.47 1995-09-22;12.11;13.24;31.26;34.02;25.16;8.12;33.2;29.1;49.57;17.24;10.32;30.77;20.42;8.88;20.68;7.52;23.33;36.07;16.64;16.76;20.18;25.82;11.22;47.88;20.35;37.48;23.2;19.18;12.05;18.27 1995-09-25;11.83;13.44;31.38;33.59;24.84;8.12;32.97;29.15;50;17.33;10.55;30.61;20.6;8.83;20.68;7.46;23.05;35.53;16.68;17.02;20.37;25.65;11.28;47.33;20.39;37.97;23.1;19.44;11.93;18.63 1995-09-26;11.63;13.52;31.63;33.29;24.84;8.2;32.79;29.15;49.89;17.1;10.53;30.2;20.76;8.83;20.33;7.43;23.08;35.97;16.78;17.14;20.55;25.76;11.03;47.44;20.61;38.22;23.15;19.64;12.05;18.75 1995-09-27;11.89;13.44;32.49;32.87;23.98;8.26;32.97;28.72;49.46;17.16;10.4;30.45;20.39;8.72;20.1;7.38;23.45;35.53;17.07;17.19;20.18;25.54;11.08;47.33;20.8;37.97;23.42;19.7;11.87;18.59 1995-09-28;12.03;13.63;32.68;33.29;24.57;8.5;32.32;29.1;50.63;17.27;10.36;30.53;21.09;8.8;20.28;7.69;23.33;36.4;17.35;16.94;19.25;25.31;11.44;48.2;21.14;37.67;23.42;19.75;12.11;18.47 1995-09-29;12.06;13.79;32.43;33.11;24.31;8.58;32.44;29.53;50.42;17.22;10.45;30.53;20.54;8.77;20.16;7.48;23.48;36.51;17.32;17.08;19;25.14;11.31;48.85;21.11;37.67;23.52;20.18;11.93;18.39 1995-10-02;11.94;13.67;31.87;32.56;23.61;8.5;32.38;28.88;51.59;17.1;10.4;30.37;20.33;8.72;19.93;7.35;23.23;35.75;17.25;16.94;18.88;25.54;11.03;49.39;21.05;37.79;23.26;19.81;11.93;18.27 1995-10-03;11.52;13.63;31.5;31.83;23.66;8.46;33.32;28.29;51.27;17.24;10.34;29.55;20.45;8.72;19.7;7.44;23.57;34.88;17.39;17.22;19.19;26.04;11.11;49.5;20.99;38.28;23.36;19.58;11.69;18.23 1995-10-04;11.29;13.63;31.75;31.41;23.4;8.34;33.67;27.97;50;17.51;10.43;28.9;19.92;8.58;19.53;7.3;23.3;33.79;18;17.4;19.37;26.6;10.77;49.28;21.37;38.64;23.47;19.16;11.51;18.43 1995-10-05;11.77;13.71;31.94;31.35;23.56;8.32;33.2;28.83;49.57;17.45;10.32;29.23;20.36;8.64;20.16;7.57;23.48;34.34;17.93;17.4;19.19;26.72;10.94;49.83;21.4;38.64;23.43;19.44;11.51;18.35 1995-10-06;12.11;13.63;31.57;31.71;23.13;8.54;33.26;28.61;49.25;17.54;10.3;29.71;19.92;8.44;20.39;7.71;23.39;33.9;18.07;17.8;19.25;26.77;10.73;49.28;21.62;39.19;23.38;19.41;11.45;18.35 1995-10-09;12.03;13.36;31.5;31.05;22.49;8.4;33.67;28.24;48.61;17.51;10.3;28.74;19.28;8.53;19.93;7.48;22.86;32.71;18.03;17.66;19.37;26.27;10.39;49.28;21.46;39.68;23.92;19.36;11.63;17.99 1995-10-10;12.11;13.32;31.07;31.41;22.49;8.24;33.55;28.29;49.78;17.57;10.26;29.23;19.31;8.69;20.39;7.66;22.55;33.47;18.18;17.54;19.25;26.83;10.47;48.85;21.43;39.38;23.97;19.36;11.51;17.91 1995-10-11;12;13.63;30.64;32.02;22.28;8.34;33.44;28.29;48.4;17.45;10.18;29.47;19.65;8.69;20.5;7.82;22.98;33.03;18.25;17.54;19.37;26.94;10.83;48.53;21.52;39.13;23.86;19.73;11.09;17.9 1995-10-12;11.69;13.9;31.5;32.32;22.81;8.67;33.26;28.4;48.51;17.39;10.3;30.53;20.42;8.64;20.22;7.93;23.11;33.03;18.39;17.63;19.87;26.88;10.95;49.61;21.43;39.44;23.32;19.73;11.03;17.78 1995-10-13;11.77;13.98;30.76;32.74;23.72;8.77;33.32;28.4;48.72;17.81;10.32;30.12;20.57;8.55;20.33;7.8;22.98;33.03;18.39;17.89;19.75;26.88;10.78;49.18;21.56;39.26;23.49;19.95;11.15;18.46 1995-10-16;12.06;13.9;30.39;32.81;23.72;8.58;33.67;28.45;48.61;17.75;10.3;30.28;21.28;8.53;20.22;7.85;23.36;33.25;18.11;17.89;19.75;26.72;10.84;49.18;21.56;38.83;23.05;19.78;10.85;18.26 1995-10-17;11.8;13.82;31.07;32.32;23.13;8.67;33.32;28.83;50.74;17.81;10.49;30.28;22.23;8.47;20.16;8.14;24.07;32.71;18;17.86;19.62;26.49;11.39;48.74;21.52;39.13;23.49;19.84;10.97;18.06 1995-10-18;11.57;13.71;30.89;31.83;22.01;8.58;33.73;28.56;52.02;17.81;10.53;29.55;22.67;8.36;20.22;8.42;23.95;32.92;17.57;18;19.37;26.77;11.95;48.42;21.33;39.07;23.32;20.13;10.97;18.1 1995-10-19;11.66;13.43;30.83;31.77;22.59;8.44;34.55;28.88;51.91;17.9;10.69;29.31;22.85;8.25;20.22;8.46;24.41;32.92;17.39;18.2;20.12;26.94;12.09;48.42;21.56;39.75;24.08;20.13;11.03;18.26 1995-10-20;11.66;12.96;30.21;32.14;22.86;8.16;34.02;28.67;51.91;18.05;10.59;29.31;21.86;8.39;20.16;8.35;23.7;32.6;16.89;18.38;20.61;26.94;11.94;48.96;21.65;39.62;23.81;20.04;11.09;18.38 1995-10-23;11.03;13.28;30.21;32.26;22.75;8;33.85;28.13;52.66;17.87;10.4;28.98;22.54;8.5;19.59;8.39;24.6;31.73;17.03;18.61;20.24;26.72;12.05;48.74;21.4;39.56;23.86;19.5;10.91;18.3 1995-10-24;11.49;13;30.15;32.44;23.4;8;34.08;27.92;54.36;18.05;10.32;29.06;22.48;8.31;19.36;8.44;24.35;32.27;16.35;19.07;20.37;27.11;12.19;48.96;21.49;40.97;24.35;19.3;10.85;18.54 1995-10-25;11.32;12.65;29.96;32.62;22.75;8.06;33.73;26.25;53.4;18.23;10.32;28.74;22.11;8.09;19.48;8.27;23.89;31.62;16.17;18.89;20.86;27.05;11.98;48.74;21.4;40.42;24.29;20.18;10.85;18.58 1995-10-26;11.06;12.26;30.21;32.14;23.07;8;33.38;26.41;52.76;17.87;10.24;28.49;22.57;8.14;19.08;8.26;23.82;31.29;16.13;18.52;20.43;26.94;12.25;48.63;21.18;40.05;23.7;20.18;10.55;18.42 1995-10-27;11.23;12.85;30.64;32.87;23.5;8.08;33.67;26.84;53.4;17.78;10.2;28.66;22.76;8.11;19.99;8.44;23.98;32.27;16.74;18.61;20.74;26.15;12.5;48.09;21.33;39.87;23.65;20.15;10.67;18.3 1995-10-30;11.77;12.61;30.95;32.56;23.66;8.1;33.85;27;52.87;18.11;10.34;28.74;23.65;8.36;19.88;8.67;24.41;32.16;16.6;18.81;20.37;25.99;12.84;48.85;21.08;39.75;23.65;20.18;10.55;18.5 1995-10-31;11.63;12.69;31.57;31.77;24.42;8.16;33.79;26.79;53.29;18.2;10.36;28.49;22.82;8.2;19.42;8.69;24.16;32.16;16.31;18.78;20.37;25.82;12.5;49.28;21.3;39.62;24.08;20.27;10.43;18.5 1995-11-01;11.71;12.81;31.38;32.99;24.31;8.38;33.73;26.52;53.83;18.29;10.2;28.25;22.91;8.36;19.13;8.8;24.07;31.84;16.74;18.84;20.43;25.59;12.3;49.28;21.46;40.3;24.24;20.15;10.73;18.54 1995-11-02;11.8;13;31.32;33.65;24.63;8.5;33.67;26.68;53.83;17.93;10.4;28.82;23.25;8.88;19.99;9.06;24.75;32.05;17.32;18.72;20.61;25.37;12.5;49.61;21.62;40.78;24.51;20.38;11.33;18.5 1995-11-03;11.91;13;31.44;33.65;24.1;8.64;33.44;26.79;55;18.14;10.28;28.57;23.13;8.91;19.93;9.01;25.22;32.27;17.03;18.49;20.24;25.54;12.44;51.56;22.16;40.72;24.24;20.44;11.27;18.7 1995-11-06;11.91;12.89;31.44;33.84;24.58;8.83;33.08;26.74;55.31;17.96;10.3;29.23;22.48;8.97;19.42;8.8;24.97;31.4;16.74;18.46;20.49;25.31;12.17;51.23;22.06;40.11;24.08;20.27;11.21;18.62 1995-11-07;11.88;12.61;31.26;33.84;24.58;8.6;33.5;26.57;55.21;17.78;10.4;29.71;21.65;8.94;19.36;8.25;24.54;30.97;16.53;18.84;20.49;25.93;11.62;50.37;21.84;39.62;24.13;20.07;11.39;18.62 1995-11-08;12;13;31.32;33.9;23.88;8.97;34.2;26.84;55.1;18.26;10.63;29.23;21.77;9.1;20.33;8.2;24.29;30.86;17.03;18.92;20.86;26.27;11.91;51.23;22.31;40.36;24.08;20.44;11.39;19.19 1995-11-09;12.05;13.55;31.07;33.96;24.47;9.23;33.73;26.79;55.21;18.08;10.65;29.8;23;9.1;20.22;8.58;24.44;30.32;17.07;18.75;20.86;26.21;12.38;51.99;22.35;40.78;23.86;20.78;11.6;18.99 1995-11-10;12.4;13.47;31.07;34.56;24.36;8.95;34.2;26.57;56.48;17.99;10.75;29.71;23.4;9.16;20.39;8.49;24.2;30.64;17.07;18.45;21.05;26.15;12.11;51.77;22;40.6;23.59;20.61;11.51;19.07 1995-11-13;12.4;13.39;31.2;34.81;24.26;8.73;34.73;26.37;56.48;18.2;10.75;29.31;23;9.19;20.73;8.35;24.2;30.75;16.82;18.91;21.42;26.27;12.04;51.13;22.16;41.27;23.54;20.24;11.51;18.66 1995-11-14;12.17;13.12;31.2;34.68;24.1;8.48;34.79;27.61;58.08;18.29;10.73;29.67;21.96;9.54;20.56;8.1;23.7;30.53;16.28;19.23;21.05;26.6;11.75;53.4;22.22;40.78;23.32;20.1;11.27;18.22 1995-11-15;12;13.35;31.81;35.9;24.1;8.58;34.91;28.05;58.72;18.53;10.81;30.57;22.79;9.63;20.48;8.05;23.73;30.32;16.24;19.87;21.55;26.94;11.75;53.07;22.66;42.5;23.27;20.34;11.45;18.58 1995-11-16;12.03;13.47;31.94;36.81;23.77;8.79;35.14;27.45;58.61;18.56;11.08;30.24;22.97;9.57;20.71;7.82;23.76;30.75;16.53;19.49;21.86;26.88;11.23;55.24;22.95;42.99;23.27;20.83;11.45;18.54 1995-11-17;12.03;13.82;32.24;35.78;23.88;8.89;35.26;27.94;58.61;18.91;10.98;30.73;21.8;9.79;20.71;7.8;23.64;30.97;16.82;19.52;21.98;26.77;10.92;55.67;22.82;43.54;23.27;20.68;11.33;19.03 1995-11-20;12;13.39;32.18;35.53;23.93;8.73;35.38;28.15;59.78;18.91;10.9;31.23;20.69;9.71;20.59;7.72;23.11;31.51;16.85;19.35;21.79;26.66;10.75;56.11;22.88;42.92;23.11;20.45;11.69;19.35 1995-11-21;12.63;13.51;31.75;35.59;25.55;8.6;36.08;28.21;59.46;19;11.04;32.13;20.69;9.74;20.31;7.83;23.48;31.07;17.25;19.75;22.35;26.66;11;56.3;22.79;42.31;23.27;20.86;11.81;19.55 1995-11-22;13.23;13.39;31.94;35.96;25.71;8.6;35.26;29.13;59.04;18.76;10.86;32.78;20.69;9.6;20.65;7.69;23.67;32.17;17.32;19.61;21.79;26.49;10.92;56.08;22.66;41.7;23.11;21.14;11.81;19.91 1995-11-24;13.29;13.55;32.06;35.66;25.71;8.81;35.38;29.02;59.46;18.73;10.81;32.54;20.91;9.65;20.94;7.83;23.82;32.17;17.25;19.55;21.67;26.38;11;56.08;22.5;42.31;23.16;21.34;11.93;20.07 1995-11-27;13.31;13.51;32.37;35.53;26.41;8.67;35.08;29.45;59.46;18.85;10.71;32.13;21.25;9.85;21.11;7.46;23.82;33.04;16.99;19.52;21.92;26.32;10.91;56.19;22.6;42.92;23.22;21.32;11.93;20.19 1995-11-28;13.17;13.2;33.05;34.93;26.73;8.91;35.43;29.34;58.93;18.85;10.98;31.72;21.22;9.82;21.74;7.93;24.1;32.61;16.99;19.72;21.98;26.72;11.44;56.19;22.79;41.7;23.32;21.29;11.81;19.75 1995-11-29;13.37;13.47;32.98;35.59;26.68;9.51;35.6;29.13;59.38;18.76;11.08;32.21;20.79;9.76;21.51;7.83;24.13;33.26;17.14;19.9;21.92;27.33;11.22;57.5;22.5;42.07;23.38;21.43;11.9;19.79 1995-11-30;13.4;13.28;32.49;35.35;26.41;9.61;35.72;28.8;58.42;18.44;11;31.8;20.45;9.76;21.74;7.57;24.01;33.48;17.21;20.04;22.17;27.78;10.89;57.06;22.19;42.31;23.32;21.55;11.59;19.31 1995-12-01;13.14;13.24;32.92;35.66;26.25;9.59;35.73;29.29;57.78;18.53;11.24;32.37;20.17;9.65;21.91;7.58;23.54;32.82;17.14;19.87;22.29;27.67;10.78;56.95;22.35;41.46;23.59;21.86;11.71;19.67 1995-12-04;13.2;13.43;33.11;35.29;26.46;9.74;35.95;29.99;58.52;18.73;11.39;33.6;20.39;9.49;22.31;7.68;23.89;32.5;17.5;20.3;22.1;27.84;10.98;56.85;22.76;41.34;24.02;22.18;11.65;19.91 1995-12-05;13.34;13.71;33.11;35.9;26.89;10.08;36.48;29.78;56.6;19;11.45;33.36;20.14;9.68;22.89;7.63;23.79;33.15;17.6;20.71;22.42;28.46;10.75;57.61;22.69;42.44;24.02;22.29;11.71;20.07 1995-12-06;13.34;13.98;32.31;36.44;26.89;10.02;37.42;29.72;58.63;19.18;11.7;33.36;19.96;9.93;22.43;7.59;23.79;33.15;17.89;21;22.54;28.78;11.33;58.37;22.98;43.05;24.08;22.18;11.65;20.11 1995-12-07;13.03;13.92;32.49;35.92;26.14;9.92;36.95;29.34;57.99;19.24;11.61;32.29;20.26;9.85;21.97;7.65;23.54;32.82;17.21;21.02;22.23;28.61;11.31;58.37;22.91;43.05;23.97;22.08;11.47;19.63 1995-12-08;12.83;13.61;32.09;35.59;26.19;9.86;37.01;29.45;58.85;19.48;11.53;32.29;21.4;9.71;22.14;7.86;24.07;32.39;17.39;20.88;22.48;28.67;11.81;58.37;22.57;42.62;23.73;21.83;11.47;19.57 1995-12-11;12.6;13.43;32.18;35.35;26.57;9.82;37.42;29.99;60.02;20.04;11.59;32.7;21.34;9.71;22.66;7.9;23.92;31.95;17.21;20.85;22.73;28.55;11.64;59.68;22.76;42.37;24.08;21.95;11.41;19.79 1995-12-12;12.45;13.63;32.68;36.08;26.35;9.8;37.78;29.78;58.2;20.13;11.8;32.62;20.48;9.93;21.91;7.74;23.7;31.07;17.1;21;22.91;28.55;11.42;60.23;22.91;42.07;24.13;21.63;11.47;19.75 1995-12-13;12.51;13.59;33.6;37.11;26.57;9.88;37.72;29.62;58.1;20.43;11.8;32.62;19.89;9.9;22.72;7.79;23.48;30.96;17.17;21.02;23.28;29.4;11.47;60.88;23.49;42.31;24.62;21.8;11.29;19.55 1995-12-14;12.51;13.28;32.92;35.66;26.68;9.92;37.13;30.16;58.1;19.78;11.7;32.78;19.25;10.07;22.2;7.46;23.3;31.07;16.85;21.17;23.59;30.19;11.09;60.01;23.81;42.13;24.56;21.57;11.23;19.51 1995-12-15;12.51;12.96;33.54;36.56;25.82;9.78;37.07;29.94;58.95;19.6;11.86;33.11;18.82;9.98;22.26;7.24;22.43;31.62;16.56;21.14;23.28;29.68;11.05;58.15;23.75;42.07;24.67;21.72;11.17;19.63 1995-12-18;12.34;12.81;32.43;35.35;24.85;9.43;36.6;29.67;56.92;19.24;11.9;33.11;19.03;9.9;21.86;7.12;22.11;31.51;16.42;20.62;22.66;29.29;10.88;59.25;23.33;41.03;24.51;20.97;11.05;19.11 1995-12-19;12.94;12.92;32.55;36.56;26.19;9.51;36.42;29.4;57.13;19.54;11.8;33.11;20.66;10.18;21.74;7.51;22.83;32.5;16.92;20.13;22.17;28.72;11.36;58.48;22.98;41.15;24.72;21.26;11.23;19.15 1995-12-20;12.86;12.92;32.12;37.84;25.82;9.33;35.01;29.51;56.28;19.15;11.47;33.36;20.48;10.34;21.74;7.41;22.21;32.06;16.71;20.19;21.98;28.5;10.89;57.61;22.08;40.42;24.24;21.29;10.87;19.15 1995-12-21;12.23;12.96;31.75;37.23;26.46;9.25;34.3;29.78;57.03;19.3;11.55;34.18;20.63;10.4;22.03;7.4;22.58;32.5;16.67;20.45;22.42;29.34;11.25;57.17;22.5;40.3;24.45;22.03;11.23;19.31 1995-12-22;12.23;12.89;32.55;37.6;26.19;9.49;33.95;29.83;56.92;19.39;11.74;34.09;20.85;10.37;22.14;7.34;22.67;32.5;16.71;20.01;22.17;29.34;11.31;55.86;22.66;40.6;24.45;21.89;11.11;19.51 1995-12-26;11.8;12.92;31.87;37.72;25.55;9.76;35.18;30.26;57.45;19.42;11.82;33.85;21.09;10.51;22.26;7.38;22.8;32.28;16.82;20.01;22.29;30.08;11.28;55.75;22.88;40.85;24.72;21.8;10.99;19.39 1995-12-27;11.4;12.92;32;37.78;25.39;10.14;35.18;30.32;58.1;19.54;11.76;33.52;20.82;10.51;22.03;7.32;22.86;32.39;16.92;20.1;22.73;29.29;11.11;56.41;23.2;40.66;24.94;21.8;10.99;19.35 1995-12-28;11.57;12.81;31.87;37.72;25.12;10.26;35.3;30.21;57.67;19.75;11.65;33.36;20.63;10.4;21.97;7.1;22.39;32.93;16.85;19.9;22.42;29.85;10.92;56.3;22.98;40.72;24.94;21.83;10.87;19.07 1995-12-29;12.11;12.92;31.94;38.02;25.28;10.12;35.01;30.26;57.35;19.33;11.8;34.67;20.63;10.51;21.8;7.06;22.71;33.15;16.85;19.78;22.42;29.62;10.97;57.94;23.07;40.6;24.67;21.8;10.75;18.93 1996-01-02;12.45;12.96;33.23;38.75;25.6;9.98;35.36;31.19;58.74;19.21;12.04;34.26;20.57;10.42;22.6;7.29;22.58;34.25;16.85;19.49;22.6;29;11.22;59.14;23.49;40.66;25.16;21.55;11.23;19.58 1996-01-03;12.66;13.03;33.79;38.38;26.03;9.9;35.66;31.29;59.59;19.27;12.06;34.01;20.11;10.23;23.18;7.18;22.18;34.36;17;20.27;22.6;28.61;10.86;59.03;23.52;41.89;25.53;21.43;11.35;19.7 1996-01-04;12.77;12.92;33.05;37.41;25.82;9.96;35.36;31.51;59.81;19.39;11.92;33.6;19.65;10.2;22.66;7.15;21.59;34.14;16.27;20.07;22.73;28.78;10.92;58.81;23.49;42.56;25.48;21.43;11.47;19.46 1996-01-05;12.68;12.88;32.98;38.08;26.25;9.8;35.18;31.56;58.95;19.87;11.94;33.03;19.49;9.96;22.37;7.15;22.02;33.92;16.2;20.07;22.35;28.44;10.8;58.92;22.95;42.74;25.42;21.37;11.29;19.82 1996-01-08;12;12.88;32.98;38.93;26.14;9.74;35.42;31.56;58.85;20.1;12.02;33.19;19.62;9.68;22.54;7.17;22.15;34.14;16.2;20.33;22.42;28.84;10.78;58.48;23.01;42.92;25.17;21.63;11.29;19.94 1996-01-09;11.79;12.68;32.71;38.5;25.44;9.69;34.95;31.87;58.1;19.72;11.91;32.43;19.27;9.57;22.72;6.84;21.56;33.86;15.8;20.45;22.04;28.67;10.02;57.64;22.82;42.86;25.01;21.46;11.11;19.97 1996-01-10;11.57;12.25;32;37.23;25.17;9.29;34.36;31.08;56.81;19.12;11.53;31.72;18.91;9.68;21.97;6.73;21.68;33.26;15.66;19.78;21.67;27.65;10.3;57.17;22.34;42.31;24.08;20.91;10.93;19.18 1996-01-11;11.74;12.41;32.18;37.72;25.55;9.29;34.71;31.02;56.71;19.24;11.55;32.21;19.59;9.63;22.03;7.07;21.68;33.92;15.66;19.38;21.92;27.76;10.83;57.39;22.47;41.64;24.25;21.14;11.05;19.42 1996-01-12;11.68;12.25;32.37;37.72;25.17;9.53;34.3;31.02;57.13;18.97;11.51;32.29;19.31;9.57;22.77;7.04;21.46;33.59;16.09;19.84;22.1;28.05;10.72;56.74;23.07;41.76;24.19;21.34;10.75;19.3 1996-01-15;11.57;12.17;32.55;37.35;24.47;9.47;34.71;30.37;57.88;18.76;11.51;32.21;18.66;9.57;22.77;6.64;20.66;33.04;15.95;20.01;21.92;28.72;10.31;56.74;23.01;41.89;24.03;21.23;10.75;19.3 1996-01-16;11.54;12.45;32.86;36.87;23.88;9.7;35.3;30.54;59.27;19.03;11.61;32.29;19.49;9.65;22.43;6.93;21.62;31.95;16.92;20.07;22.17;29.23;10.8;58.7;23.11;43.41;25.12;21.11;10.87;19.3 1996-01-17;11.57;12.68;33.05;37.05;23.34;10.04;34.48;30.7;59.17;19.12;11.7;31.96;18.91;9.13;22.2;6.22;21.77;32.39;17.21;20.21;23.04;29.57;10.61;55.65;23.27;42.19;24.68;21.11;9.84;19.14 1996-01-18;11.77;13.11;32.98;38.2;25.66;9.8;34.6;30.64;57.35;19.3;11.88;31.14;18.6;9.35;22.31;6.34;23.92;33.15;17.03;20.07;24.53;29.46;10.95;54.66;23.43;42.13;24.57;21.2;9.3;19.22 1996-01-19;12.03;13.47;32.24;38.02;25.55;9.92;34.6;30.97;59.38;19.33;12.17;31.06;19.15;9.65;22.37;6.39;25.35;33.48;17.21;19.98;24.09;29.57;11.48;54.66;24;42.5;24.19;21.55;9.6;19.3 1996-01-22;11.97;13.43;31.87;38.38;27.18;9.88;34.3;31.83;58.85;18.97;12.13;32.78;19.89;9.74;22.31;6.47;25.41;33.81;17.47;20.07;23.91;29.91;11.5;54.99;24.16;42.25;23.92;21.55;9.9;19.46 1996-01-23;12.25;13.03;32;37.66;27.07;9.98;34.65;31.19;58.31;18.59;11.96;32.7;19.83;10.07;22.09;6.55;25.59;33.26;17.68;20.3;24.15;30.19;11.19;54.55;23.9;42.13;23.81;21.66;9.84;19.46 1996-01-24;12.2;12.84;32.18;37.35;26.85;10.02;35.42;32.11;58.74;18.56;12.08;32.78;20.69;10.09;21.91;6.81;26.59;33.15;17.94;21.69;24.15;30.64;11.41;55.21;24.1;43.17;24.25;22.38;9.66;19.54 1996-01-25;12.08;12.8;31.75;37.35;26.25;9.86;34.71;31.94;59.7;18.76;12.25;33.11;20.11;10.04;21.97;6.79;25.87;34.47;18.26;21.52;24.34;30.19;11.17;55.54;23.68;41.95;24.19;22.64;9.66;19.38 1996-01-26;12.11;13.54;31.94;37.23;26.96;9.82;35.13;32.11;61.09;19;12.37;33.52;20.57;9.93;22.49;6.84;26.03;34.36;18.23;21.57;24.96;30.64;11.31;56.95;23.71;42.56;24.41;22.67;9.66;19.54 1996-01-29;12.37;13.66;32.37;37.41;27.61;10.06;35.01;32.54;60.88;18.88;12.27;34.26;20.54;9.68;22.49;6.77;26.46;34.79;19.09;21.8;25.02;31.09;11.3;56.85;23.78;41.76;24.41;22.75;9.66;19.86 1996-01-30;12.88;14.09;32.74;37.66;27.88;10.4;35.48;33.24;62.38;18.73;12.37;35.16;20.76;9.85;23;6.73;26.99;36;19.31;22.3;24.96;31.66;11.35;56.19;24.29;41.52;24.36;23.15;9.72;20.46 1996-01-31;12.76;14.45;32.98;37.6;27.88;10.62;35.54;33.24;62.8;19.12;12.58;34.5;20.88;10.12;22.89;6.87;26.96;35.67;19.38;22.21;24.96;31.66;11.56;56.3;23.71;41.09;24.57;23.58;9.84;20.66 1996-02-01;12.62;14.02;32.74;37.78;27.77;10.48;35.6;34.05;62.59;19.33;12.62;35.16;21.43;10.15;23.35;6.99;27.08;36;19.06;21.83;24.84;31.6;11.77;56.95;23.87;41.03;24.9;23.27;10.51;20.06 1996-02-02;12.88;14.05;31.94;37.84;27.45;10.28;35.42;33.24;62.27;19.24;12.64;34.09;21.4;10.01;23.4;7.06;27.24;35.45;18.88;22.18;24.84;31.32;11.62;57.28;23.71;40.78;25.01;23.15;10.39;19.94 1996-02-05;12.73;14.29;32.12;38.57;27.18;10.28;35.95;33.68;62.06;19.24;12.8;34.67;21.96;10.09;23.75;7.27;27.89;35.56;18.91;22.64;25.09;31.2;12.14;58.15;24.29;40.97;25.17;22.98;10.75;19.82 1996-02-06;12.82;14.29;33.35;38.87;27.5;10.34;36.13;34.38;63.34;19.39;12.97;34.42;22.3;9.93;24.21;7.4;28.51;35.89;19.2;22.47;25.64;30.41;12.06;58.26;24.13;40.48;25.6;23.47;10.69;20.14 1996-02-07;13.05;14.41;32.98;38.75;27.66;10.4;36.78;34.43;63.77;19.42;12.84;34.59;22.05;10.07;24.55;7.24;27.99;35.78;19.38;22.44;26.45;31.15;12.11;58.59;24.22;40.97;25.98;23.96;10.93;20.5 1996-02-08;13.11;14.88;33.17;38.57;28.2;10.56;37.84;34.27;65.59;19.69;13.03;33.68;22.42;10.23;25.07;7.2;28.2;35.56;19.42;22.85;26.58;31.6;12.36;59.57;24.51;42.07;25.66;23.99;10.93;20.46 1996-02-09;12.96;14.88;32.8;40.08;27.99;10.54;37.54;33.84;65.69;19.69;13.01;34.09;22.2;10.34;25.53;7.21;28.2;35.45;19.35;22.93;26.2;31.6;12.52;59.68;24.7;42.93;25.77;23.47;10.81;20.18 1996-02-12;13.22;14.8;33.29;40.38;29.29;10.68;37.54;34.98;64.09;19.87;13.05;34.67;22.27;10.2;24.84;7.24;28.64;35.45;19.56;22.88;26.89;31.88;12.44;60.45;25.15;42.37;26.04;23.64;10.99;20.34 1996-02-13;13.05;14.76;33.54;40.32;29.23;10.79;38.07;34.87;65.27;19.87;13.07;35.01;21.77;10.37;24.9;7.1;28.23;34.79;19.56;22.9;26.14;31.77;12.45;59.79;25.22;42.86;25.82;24.3;10.57;20.46 1996-02-14;12.99;14.68;33.17;40.45;29.02;10.91;38.19;34.66;66.34;19.69;12.9;34.68;21.8;10.29;25.18;7.21;28.39;34.14;19.6;22.59;25.09;31.88;12.34;59.79;25.02;41.95;24.95;24.25;10.69;20.58 1996-02-15;12.85;14.68;32.74;40.02;28.85;10.93;38.31;34.77;66.12;19.72;12.78;33.11;21.25;10.56;25.23;7.15;29.23;33.81;19.6;22.08;25.33;31.43;12.31;58.92;24.64;42.19;24.25;23.99;10.39;20.54 1996-02-16;12.82;14.53;32.43;39.6;29.02;10.87;37.95;34.28;64.3;19.42;12.7;33.45;23.47;10.42;25.23;7.16;29.32;32.82;19.6;21.85;24.96;31.04;12.23;58.05;24.7;42.13;24.19;23.79;10.27;20.62 1996-02-20;12.48;14.41;32.31;39.17;29.39;10.64;38.01;34;62.59;19.27;12.62;33.45;23.59;10.07;24.65;7.2;29.6;32.93;19.31;21.5;24.71;30.02;12.22;58.05;24.54;41.27;23.87;23.58;10.08;20.38 1996-02-21;12.56;14.72;32.8;40.26;29.83;10.71;38.6;34.11;63.02;19.51;12.76;33.28;24.24;10.2;24.83;7.37;29.88;32.6;20.03;22.02;25.64;30.13;12.48;57.14;25.02;40.91;24.08;24.29;10.57;20.5 1996-02-22;12.94;14.76;32.55;40.51;30.42;11.13;39.6;34.44;64.3;19.9;13.05;34.11;25.41;10.4;25.29;7.58;30.84;33.15;20.43;22.08;26.2;30.36;12.81;58.46;25.41;40.54;24.68;24.72;10.81;20.74 1996-02-23;13.34;14.72;32.74;40.57;30.31;11.29;39.19;34.93;64.52;19.6;13.07;33.61;25.47;10.29;25.63;7.56;31.22;33.26;20.97;21.7;25.83;30.36;12.94;57.8;25.6;40.78;24.3;25.24;10.75;20.9 1996-02-26;12.85;14.37;32.06;39.66;29.99;11.21;38.54;34.55;62.91;19.15;12.86;34.27;24.88;9.87;25.8;7.51;31.03;32.6;20.29;21.76;25.21;29.74;12.58;56.48;25.69;40.85;23.98;25.07;10.51;20.9 1996-02-27;12.65;14.68;31.57;39.35;30.04;11.15;38.72;34.49;62.27;18.91;12.74;34.02;25.1;9.71;25.8;7.49;31.99;32.49;20.5;21.7;25.09;29.4;12.52;56.92;25.57;40.6;24.08;24.87;10.51;20.9 1996-02-28;12.56;14.45;31.57;39.17;29.34;11.17;38.37;33.89;61.54;18.64;12.47;34.11;25.5;9.54;25.4;7.55;31.65;32.27;20.76;21.79;24.65;29.74;12.52;57.14;25.53;40.17;23.7;25.01;10.27;21.19 1996-02-29;13.08;14.41;31.38;39.35;28.91;10.81;38.07;33.35;61.54;18.94;12.37;33.86;24.82;9.52;25.63;7.31;30.47;31.5;20.72;21.7;24.84;29.91;12.34;57.25;25.31;40.11;23.81;24.81;10.27;21.07 1996-03-01;13.17;14.6;30.89;39.05;29.23;11.03;38.72;34.33;61.43;19;12.6;34.77;23.44;9.74;26.38;6.97;29.35;31.61;21.05;22.29;25.02;30.41;11.94;57.14;25.57;41.4;23.43;24.66;10.45;21.23 1996-03-04;13.37;14.72;31.44;39.54;29.39;11.09;39.6;34.87;61.75;18.91;12.76;34.52;23.16;10.48;27.3;6.82;28.86;32.16;21.05;22.46;25.52;30.87;12.03;57.14;25.95;41.89;23.43;25.56;10.75;21.47 1996-03-05;13.34;14.76;31.94;39.41;29.34;10.93;39.72;35.2;63.47;19.27;12.82;34.52;23.9;10.7;26.84;6.89;29.57;32.16;20.9;22.34;26.2;31.09;12.27;57.58;26.59;42.8;24.08;25.42;10.99;21.47 1996-03-06;13.42;14.6;31.69;39.17;29.34;10.93;39.19;34.71;64.98;19.6;12.76;34.44;23;10.4;26.9;6.62;29.07;32.38;20.47;22.26;26.02;30.06;12.12;57.91;26.49;42.31;23.92;25.44;11.05;21.39 1996-03-07;13.51;14.64;32.06;38.99;29.34;10.87;39.37;34.38;64.66;19.72;12.76;34.68;23;10.59;26.5;6.61;29.1;33.59;20.07;22.81;26.14;30.4;12.16;57.8;26.72;42.8;23.65;25.18;10.93;21.51 1996-03-08;13.37;14.02;31.13;38.14;29.12;10.22;37.84;33.24;61.97;18.88;12.25;33.61;22.3;10.26;25.46;6.65;28.39;33.81;19.2;22.05;25.27;27.67;11.89;55.38;25.5;41.7;22.67;24.49;10.87;21.11 1996-03-11;14.14;13.98;30.64;40.26;30.26;10.12;38.25;34.55;64.01;18.94;12.54;34.77;23.44;10.56;26.38;6.87;29.13;33.7;19.06;22.11;25.09;29.43;12.06;55.82;26.08;42.07;22.84;25.3;10.75;21.35 1996-03-12;14.11;14.17;30.52;39.66;30.48;9.9;38.31;34.87;62.61;19;12.29;34.6;23.1;10.67;26.61;6.82;28.39;34.03;18.99;21.85;25.15;28.64;11.97;57.58;26.17;41.89;22.24;25.94;10.81;21.79 1996-03-13;14.17;14.13;30.76;39.17;30.59;10.14;38.37;35.53;62.72;19.06;12.23;34.27;23.34;10.67;25.92;6.98;28.79;34.15;19.31;21.56;25.02;27.96;12.61;57.03;25.3;41.34;22.19;26.01;11.11;22.07 1996-03-14;14.14;14.84;30.33;39.9;30.69;10.12;38.54;35.04;64.01;19.3;12.31;34.6;23.56;10.67;26.61;6.98;29.04;34.15;19.74;21.5;25.15;28.13;12.45;55.6;23.88;41.15;22.08;25.82;11.41;22.43 1996-03-15;14.03;15.19;30.27;39.23;31.18;10.06;38.25;35.42;62.94;18.82;12.41;34.52;24.61;10.89;25.92;7.32;29.79;34.59;19.64;21.82;25.46;28.18;12.8;55.82;24.62;40.66;22.19;25.65;11.5;22.27 1996-03-18;14.63;15.31;30.52;41.54;31.83;10.34;39.02;36.02;63.58;19.42;12.76;35.01;25.38;11;26.21;7.4;30.97;35.03;20.18;21.91;25.89;28.47;13.16;56.81;23.56;41.76;22.62;25.73;11.86;21.51 1996-03-19;14.57;15.35;30.52;42.69;31.34;10.36;39.02;36.73;63.91;19.75;12.64;35.84;24.94;10.86;25.86;7.31;30.25;35.25;20.21;21.47;25.02;28.18;13.36;57.25;22.3;41.7;22.89;26.37;11.5;20.9 1996-03-20;14.23;15.27;30.39;42.33;30.69;10.32;39.85;36.4;63.15;19.18;12.66;35.34;24.05;10.81;25.92;6.9;29.07;34.37;20.58;21.76;25.27;28.58;13.08;57.14;23.11;42.56;23.22;26.86;11.56;20.98 1996-03-21;14.43;15.23;30.21;42.51;30.31;10.4;39.55;36.4;62.83;19.18;12.68;35.43;23.34;10.64;25.86;6.95;28.54;33.92;20.83;21.85;24.9;29.72;12.59;56.7;22.4;42.62;23.38;26.51;11.44;20.74 1996-03-22;14.34;15.31;30.21;43.11;29.99;10.48;39.67;36.18;62.94;19.39;12.84;35.26;23.9;10.84;26.32;6.98;28.39;33.81;20.58;21.94;25.21;28.81;12.64;56.7;22.27;42.99;23.11;26.66;11.5;20.86 1996-03-25;14.43;15.43;30.76;42.63;30.04;10.42;39.96;35.96;63.58;19.93;12.94;36.01;23.22;10.78;26.38;6.83;27.02;34.15;20.5;21.73;24.96;28.35;12.48;57.03;22.62;42.44;23.27;26.77;11.44;20.62 1996-03-26;14.6;15.31;30.95;42.63;30.26;10.58;40.14;35.58;62.61;20.49;12.94;35.92;23.07;10.64;25.98;6.98;27.52;34.59;20.47;21.97;24.71;29.09;12.84;57.25;22.98;42.74;23.38;26.86;11.44;20.74 1996-03-27;14.46;15.19;30.52;42.99;30.1;10.54;39.67;35.42;61.97;20.04;12.92;35.18;23.13;10.67;26.21;7.04;27.64;34.59;20.68;21.62;24.53;28.64;12.81;57.14;22.62;41.95;23.16;26.31;11.44;20.74 1996-03-28;14.8;15.55;30.21;42.87;29.67;10.46;39.67;35.86;61.54;19.96;12.82;35.76;23;10.7;26.61;7.01;27.27;34.48;20.65;21.53;24.46;28.58;12.78;58.35;22.75;41.95;23.16;26.28;11.62;20.74 1996-03-29;14.4;15.51;30.15;42.02;29.45;10.66;39.14;36.18;61.11;19.42;12.76;35.18;23.19;10.51;27.24;7.07;27.64;34.81;20.4;21.41;23.84;28.24;12.89;56.81;22.66;41.46;22.84;25.94;11.14;20.54 1996-04-01;14.17;15.78;30.7;41.17;29.23;10.71;39.85;36.56;62.4;19.78;13.01;37.08;23.71;10.51;27.19;7.1;27.43;34.15;21.12;21.65;24.46;28.75;12.84;58.46;23.27;42.25;21.64;25.82;11.38;20.86 1996-04-02;14.14;15.85;31.26;41.84;28.85;10.66;39.73;36.84;62.29;19.96;13.03;36.75;23.62;10.4;27.3;7.07;29.23;34.03;21.48;22.11;24.53;28.81;13.08;57.8;23.33;42.19;21.81;26.14;11.01;21.07 1996-04-03;13.88;15.77;31.63;42.14;29.56;10.68;39.73;36.62;61.75;19.98;13.15;36.34;23.74;10.34;27.01;7.17;29.76;34.15;21.23;21.85;24.22;28.81;13.06;57.69;23.79;42.44;21.86;26.28;10.95;21.11 1996-04-04;14.26;15.97;31.01;41.42;29.72;10.64;39.61;36.89;60.68;20.34;13.17;36.75;23.74;10.29;26.96;7.37;29.26;34.26;21.23;21.97;24.22;28.98;13.05;57.36;23.82;42.62;21.59;26.17;10.89;20.9 1996-04-08;14.55;15.38;29.84;40.26;29.29;10.1;39.02;36.35;59.6;19.87;13.05;36.09;24.02;10.01;26.32;7.54;29.66;33.92;20.43;21.39;23.78;28.07;12.97;56.7;23.4;41.4;20.9;25.85;10.71;20.7 1996-04-09;14.8;14.95;29.84;39.84;28.91;9.98;38.66;36.07;59.71;19.87;12.84;36.09;23.87;10.09;26.27;7.69;29.29;34.59;20.03;21.18;23.47;27.73;12.7;56.37;23.08;40.6;20.9;25.5;10.65;20.46 1996-04-10;15.03;14.47;30.21;39.05;28.8;9.61;37.3;36.07;59.28;19.63;12.56;36.58;24.08;9.76;25.92;7.68;28.82;35.14;19.38;20.49;23.47;26.65;12.7;56.26;22.53;39.62;20.85;25.18;10.59;19.61 1996-04-11;14.95;14.55;30.39;38.38;29.72;9.55;37.78;35.26;59.82;19.63;12.39;36.17;23.74;9.68;25.69;7.51;29.2;35.36;19.35;20.31;23.1;26.94;12.64;56.15;22.59;40.17;20.52;24.84;10.59;19.45 1996-04-12;15.01;14.83;30.89;39.54;30.42;9.84;38.19;35.86;59.82;19.51;12.6;36.75;23.5;9.87;25.92;7.41;27.71;34.81;19.82;20.57;24.03;27.5;12.64;56.37;22.98;40.72;20.74;24.9;10.95;19.77 1996-04-15;14.95;15.14;30.7;39.54;31.02;10.08;38.31;35.91;60.03;19.93;12.82;37.41;24.02;10.09;25.98;7.54;28.36;35.25;20;20.83;24.09;27.28;12.94;57.14;23.08;41.21;21.12;25.33;11.01;19.93 1996-04-16;14.86;14.91;30.52;39.17;30.53;10.02;38.49;36.13;62.83;19.93;12.74;37.99;24.51;10.2;26.38;8.07;28.7;36.24;19.96;21.15;24.15;27.22;13.16;56.7;23.5;41.76;21.39;25.85;10.95;20.05 1996-04-17;14.75;15.1;30.27;38.57;29.34;9.76;37.89;36.45;62.61;19.9;12.82;37.9;24.24;10.15;26.15;7.98;26.15;35.69;19.74;21.04;23.35;27.33;13.24;56.81;23.17;41.09;21.72;25.44;10.89;20.09 1996-04-18;14.83;14.87;30.02;39.48;28.46;9.8;37.6;36.45;64.12;19.51;12.99;37.66;24.61;10.15;26.55;8.18;26.21;35.8;19.78;21.27;23.22;27.84;13.62;56.81;23.04;41.34;21.67;25.42;10.71;20.26 1996-04-19;14.6;14.67;30.09;39.35;28.3;9.88;37.24;36.45;64.44;19.54;12.97;37.33;24.54;10.23;26.38;8.11;26.18;34.81;19.6;21.1;23.1;28.07;13.72;56.59;22.75;40.97;21.78;25.82;10.89;20.34 1996-04-22;14.52;14.91;30.09;39.9;28.51;9.94;38.13;36.78;64.98;19.54;13.03;37;24.94;10.2;26.32;8.42;26.65;34.92;19.35;20.89;23.59;27.96;14.09;56.81;22.72;41.64;22.11;26.17;10.95;20.18 1996-04-23;14.49;14.83;29.9;39.48;28.46;10.12;38.31;36.89;65.41;20.16;13.01;37.16;25.41;10.15;26.67;8.47;26.59;34.81;19.42;21.01;23.41;28.01;14.08;56.7;22.69;41.58;22.05;26.25;11.07;19.89 1996-04-24;14.37;14.71;29.84;39.05;28.19;9.96;38.01;36.51;66.06;20.07;12.94;36.91;26.15;10.12;26.55;8.74;26.53;34.48;19.31;20.83;23.35;27.39;13.94;56.92;22.49;41.34;22;25.82;11.07;19.53 1996-04-25;14.32;14.99;30.21;39.05;29;10.02;38.43;35.2;65.73;20.13;12.78;36.83;27.1;10.31;26.84;8.66;26.9;35.47;19.74;20.92;23.53;27.28;14.09;57.14;22.56;41.82;21.94;25.62;11.2;19.73 1996-04-26;14.4;15.26;30.27;39.17;28.24;10.04;38.43;34.55;65.41;20.1;12.76;36.25;27.01;10.37;27.07;8.61;26.77;35.03;20;21.04;23.84;27.22;14.19;57.25;23.04;41.52;21.83;25.5;11.5;19.93 1996-04-29;14.52;15.22;30.27;39.17;27.97;9.96;38.37;34.82;66.06;20.46;12.72;36.17;26.42;10.42;26.78;8.47;26.99;35.8;19.93;21.33;23.97;27.56;14.08;58.02;23.11;41.21;21.94;25.04;11.32;19.93 1996-04-30;14.34;15.3;30.21;39.84;27.91;9.94;38.54;34.98;65.84;20.25;12.66;35.84;26.08;10.42;26.73;8.42;26.77;35.14;19.96;21.47;23.78;27.45;14.16;57.8;23.27;41.34;21.94;25.53;11.56;19.97 1996-05-01;14.31;15.3;29.84;39.11;28.13;9.88;38.66;34.82;67.13;19.93;12.76;36.01;25.96;10.42;27.65;8.44;26.81;35.58;19.89;21.53;24.28;27.5;14.39;57.91;23.4;41.46;21.94;25.42;11.74;19.49 1996-05-02;14.19;14.91;29.28;37.6;28.13;9.55;38.01;34.38;66.06;19.69;12.7;36.09;25.68;10.26;27.19;8.46;26.81;35.58;18.99;20.78;23.53;26.65;13.95;57.47;22.91;40.66;21.67;24.92;11.44;19.33 1996-05-03;14.48;14.91;29.28;37.84;27.75;9.35;37.72;34.28;65.63;19.63;12.62;36.09;25.25;10.26;26.96;8.54;26.87;35.8;19.09;20.78;23.16;26.43;13.86;56.59;22.91;40.6;21.72;24.72;11.36;19.01 1996-05-06;15.23;14.47;29.41;37.23;27.81;9.23;38.25;34.17;63.47;19.69;12.49;35.92;26.24;10.23;26.96;8.55;26.59;35.36;18.8;20.83;23.66;25.86;13.97;57.8;22.69;40.72;21.61;24.29;11.38;19.37 1996-05-07;15;14.55;29.16;36.32;27.48;9.21;38.49;33.68;63.58;19.63;12.35;35.67;25.62;10.26;26.21;8.44;26.31;35.25;19.06;20.83;23.47;26.2;14.14;56.81;22.3;40.42;21.67;24.17;11.38;19.13 1996-05-08;15;15.1;29.59;37.05;27.42;9.53;39.14;34.28;65.3;19.93;12.45;35.59;25.56;10.12;26.5;8.55;26.31;35.14;19.53;21.33;23.78;26.94;14.28;56.7;22.66;41.21;21.89;23.97;11.74;19.01 1996-05-09;14.92;14.79;29.78;37.47;27.59;9.49;39.14;34.11;63.47;19.78;12.62;35.34;25.68;10.48;26.5;8.53;26.59;34.81;19.42;21.1;23.41;26.48;14.19;56.37;22.59;41.86;21.94;25.01;11.44;18.77 1996-05-10;15.2;14.99;30.15;38.51;27.7;9.57;39.67;34.55;64.34;19.9;12.74;34.93;26.73;10.89;26.55;8.6;26.43;34.92;19.93;21.27;23.53;26.94;14.36;57.36;22.72;42.19;22.05;25.44;11.5;19.09 1996-05-13;15.29;15.1;30.58;38.51;27.91;9.7;40.67;35.02;65.73;20.13;12.86;35.1;27.69;11.47;27.07;8.92;26.74;35.91;20.14;21.5;23.72;27.22;14.83;57.69;23.2;42.56;21.94;25.33;11.74;19.57 1996-05-14;15.18;14.99;30.95;39.66;28.4;9.82;41.97;36.33;66.38;20.19;12.92;36.44;27.81;11.69;27.24;9.06;26.99;36.13;20.21;21.47;23.72;27.5;14.88;57.36;23.53;42.44;21.94;25.16;11.98;19.61 1996-05-15;15.2;14.91;31.38;39.48;29.06;9.86;42.09;35.51;65.63;20.16;12.9;36.69;28.02;11.3;27.13;9;27.08;35.8;20.07;21.79;23.66;27.84;14.7;57.58;23.5;42.5;21.94;25.44;11.86;19.45 1996-05-16;15.12;14.75;30.76;39.96;29.93;9.84;43.04;35.13;65.84;19.98;13.09;36.94;25.93;11.52;26.83;8.94;26.99;36.35;20.11;21.88;23.72;28.18;14.64;59.23;23.62;42.93;21.72;25.39;11.92;19.57 1996-05-17;15.03;14.83;30.21;40.26;29.98;9.98;43.63;35.73;64.66;20.19;13.31;37.36;26.95;11.41;26.94;8.84;27.55;37.12;20.54;22.11;23.91;28.86;14.62;60.33;24.66;42.86;21.78;25.33;11.92;19.73 1996-05-20;14.6;14.95;30.76;40.08;29.55;10.02;43.98;36.39;66.59;20.79;13.83;37.69;27.07;11.72;27.29;8.83;27.86;37.78;20.54;22.2;24.15;28.81;14.59;61.21;24.82;42.86;21.56;25.42;11.92;19.93 1996-05-21;14.69;14.91;30.83;40.69;29.82;10.1;43.98;36.72;65.63;20.52;13.64;37.61;26.73;11.61;26.77;8.74;27.58;37.67;20.47;22.29;24.22;28.64;14.39;61.54;25.01;43.29;21.78;25.36;11.98;20.09 1996-05-22;14.51;15.06;31.01;41.42;30.15;10.18;44.57;36.33;66.16;20.91;13.91;37.53;26.27;11.52;27.06;8.69;27.43;38.33;21.05;22.61;24.65;28.64;14.61;61.62;25.21;43.96;22.05;25.89;12.22;20.22 1996-05-23;14.43;14.99;30.76;41.36;29.44;10.06;44.1;36.5;64.55;20.94;13.87;37.36;26.05;11.41;26.94;8.81;27.15;37.67;20.79;22.49;24.4;28.75;14.81;61.4;26.82;43.78;21.67;25.72;11.92;19.97 1996-05-24;14.48;14.95;31.01;40.69;29.76;10.08;44.93;36.33;65.3;20.73;13.93;36.78;26.11;11.41;26.66;8.83;27.02;36.78;20.72;22.75;24.34;29.26;14.81;62.28;26.72;44.21;21.89;25.63;12.1;20.14 1996-05-28;14.19;14.67;31.44;41.54;29.49;9.88;43.51;36.33;64.34;20.58;13.56;37.36;25.93;11.33;26.31;9.01;26.9;36.23;20.5;22.7;23.97;28.86;14.66;62.17;25.82;43.66;21.67;25.31;12.35;20.01 1996-05-29;14.28;14.79;31.63;41.17;29.6;9.91;43.51;35.62;64.34;20.28;13.48;36.78;25.9;11.14;25.67;8.87;26.56;35.68;20.29;22.43;24.15;28.92;14.64;61.07;26.11;43.05;21.45;25.17;12.35;19.49 1996-05-30;14.45;14.55;31.01;41.6;28.89;10.09;44.22;35.62;65.22;20.64;13.64;36.94;26.08;11.39;25.73;8.89;26.65;35.68;20.25;22.78;24.28;29.49;14.78;60.96;26.01;43.48;21.39;25.28;12.35;19.73 1996-05-31;14.22;14.43;30.76;41.36;28.57;10.06;43.51;35.02;64.36;20.19;13.56;36.69;26.24;11.25;25.33;9.39;26.53;35.34;20.25;22.7;23.91;29.32;14.84;60.4;25.66;42.99;21.61;25.4;12.53;19.57 1996-06-03;14.25;14.2;30.39;40.93;28.02;10.09;43.75;35.73;63.71;20.01;13.58;37.36;25.96;11.44;25.44;9.53;26.18;35.34;20.21;22.61;24.15;29.38;14.8;60.51;25.59;42.93;21.5;25.28;12.59;19.45 1996-06-04;14.11;14.28;30.15;40.81;28.62;10.27;43.98;35.4;64.47;20.22;13.74;37.53;26.64;12.05;25.44;9.49;26.31;35.34;20.47;22.9;24.03;29.55;14.73;60.62;26.17;43.35;21.61;25.4;12.71;19.37 1996-06-05;13.76;14.67;30.58;41.17;28.79;10.48;45.17;35.13;65.65;20.22;13.83;37.86;26.11;12.29;25.67;9.56;26.06;35.23;21.19;23.13;24.15;30;15.11;61.51;26.21;44.15;21.78;25.81;12.59;19.49 1996-06-06;13.36;14.35;30.21;40.99;28.24;10.42;44.22;35.13;65.01;20.1;14.13;37.44;25.71;12.1;25.79;9.36;25.16;34.68;21.12;22.9;24.03;29.47;14.98;61.07;26.3;44.39;21.78;26.04;12.47;20.14 1996-06-07;13.76;14.31;30.21;41.66;28.57;10.09;44.34;35.57;65.44;20.46;14.07;36.86;26.15;11.99;25.96;9.36;25.28;35.01;20.76;22.99;23.84;29.75;15.16;61.95;26.11;44.33;21.67;26.56;12.59;20.38 1996-06-10;13.76;14.39;30.39;41.9;28.3;10.27;44.22;35.07;65.76;20.34;14.09;37.03;25.96;12.32;25.67;9.22;25.5;34.79;20.87;23.16;23.72;29.75;15.08;61.4;26.24;44.45;21.61;26.33;12.53;20.09 1996-06-11;13.82;14.24;30.52;41.17;28.73;10.33;44.46;34.8;66.3;20.25;13.87;37.03;26.21;12.49;25.56;9.36;25.62;35.12;20.9;23.31;23.66;29.18;15.27;60.4;26.75;43.96;21.56;26.01;12.59;20.09 1996-06-12;13.76;14.2;30.33;40.75;28.19;10.42;43.86;35.13;67.17;20.04;13.97;37.53;25.34;12.16;26.14;9.54;25.59;35.23;20.94;23.31;23.91;29.07;15.62;61.4;27.15;43.72;21.5;25.95;12.59;20.09 1996-06-13;13.7;14.2;30.39;40.38;28.13;10.57;43.98;34.47;68.47;20.01;14.05;37.28;24.88;12.02;26.31;9.33;25.66;34.35;21.01;22.78;23.72;29.36;15.58;60.62;27.21;43.66;21.61;25.72;12.61;19.89 1996-06-14;13.53;14.16;30.95;40.45;28.4;10.45;43.39;34.41;68.36;19.9;14.05;37.11;24.45;11.94;26.25;9.08;25.25;34.68;20.94;22.84;23.41;29.18;15.38;60.51;27.47;43.6;21.45;25.72;12.67;19.81 1996-06-17;13.56;14.16;31.2;40.32;28.46;10.45;43.75;34.63;67.93;20.13;14.13;37.03;24.39;11.91;26.02;8.95;25.47;35.34;20.9;22.73;23.35;29.01;15.58;60.51;27.21;43.35;21.34;25.63;12.55;19.97 1996-06-18;13.76;14.16;31.13;40.32;28.57;10.6;43.86;34.36;67.6;20.1;14.03;36.78;24.05;11.66;25.85;8.75;25.16;35.23;20.79;22.32;22.85;28.96;15.3;59.63;26.72;42.93;21.18;25.63;12.25;19.65 1996-06-19;13.7;14.16;30.33;41.11;28.73;10.51;44.1;34.3;68.03;20.22;14.03;36.69;23.87;11.69;26.19;8.87;25.38;35.34;20.54;22.38;22.85;29.13;15.22;60.73;26.69;43.96;21.07;25.81;11.95;19.69 1996-06-20;13.62;13.68;30.58;42.39;29.22;10.45;44.34;35.07;68.36;20.4;14.03;36.44;23.47;11.74;26.31;8.84;25.03;35.56;20.11;22.32;22.85;29.64;15.22;61.07;26.72;44.15;21.45;25.95;12.07;19.89 1996-06-21;13.65;13.96;31.01;43.23;29.93;10.57;45.17;35.46;68.79;20.55;14.26;36.53;23.59;12.05;26.37;8.87;24.51;35.56;19.53;22.43;22.97;29.7;15.48;61.07;26.92;44.39;21.56;26.7;12.43;20.3 1996-06-24;13.42;14.08;30.95;43.17;30.15;10.63;46.23;35.4;68.9;20.49;14.32;36.2;24.17;12.05;26.48;9.15;24.76;35.23;19.89;22.55;23.35;29.24;15.52;61.51;27.28;44.76;21.5;26.5;12.49;20.05 1996-06-25;13.27;14.24;30.64;43.84;29.71;10.91;46;34.85;68.25;20.58;14.38;35.36;23.62;12.13;26.48;9.06;24.79;34.01;20.29;23.02;23.53;29.64;15.25;61.73;27.24;45.74;21.39;26.76;12.31;20.38 1996-06-26;13.33;14.24;30.39;43.17;29.17;10.76;46.59;34.74;66.41;20.73;14.24;34.61;23.44;11.61;26.54;9.01;24.51;33.57;20.25;23.02;23.35;29.64;15.06;61.73;27.08;45.74;21.23;26.68;12.43;20.09 1996-06-27;13.33;14.31;30.58;43.54;29.27;10.85;46.35;34.8;66.95;20.85;14.34;35.03;24.36;12.07;26.19;9.19;24.57;33.13;20.32;22.9;23.1;29.87;14.99;60.73;27.34;44.64;21.5;26.76;12.31;20.34 1996-06-28;13.24;14.08;30.58;42.26;29.49;11.06;46.47;34.74;67.28;20.7;14.21;34.86;24.54;11.88;26.42;9.13;24.6;32.68;20.43;23.07;23.22;29.47;15.02;61.07;27.11;44.33;21.56;26.7;12.31;20.26 1996-07-01;13.39;14.28;30.58;43.6;30.47;11.15;46.83;36.06;66.63;20.79;14.3;36.2;25.04;11.94;26.71;9.34;25.22;34.01;20.65;23.13;23.6;30.15;15.29;63.17;27.34;44.33;21.61;26.82;12.07;20.05 1996-07-02;13.33;14.27;30.27;44.63;30.42;11.33;46.95;35.68;66.3;21.12;14.34;35.78;24.02;11.88;27.06;9.29;24.85;33.9;20.74;23.19;23.28;30.1;15.2;60.84;27.28;43.6;21.45;26.94;12.07;19.73 1996-07-03;13.13;14.31;30.09;44.33;30.53;11.12;46.47;35.18;67.28;21.27;14.3;34.7;23.19;12.18;27.23;9.31;24.48;33.68;20.81;23.02;22.91;30.1;15.14;61.07;27.28;43.66;21.83;26.91;12.07;19.65 1996-07-05;12.93;13.79;29.59;43.6;29.76;10.79;45.05;34.52;65.01;20.97;14.03;33.37;22.7;11.91;26.83;8.97;24.32;32.91;20.05;22.55;22.6;29.36;14.8;59.96;26.56;42.93;21.45;26.41;11.88;19.13 1996-07-08;12.93;13.55;29.41;43.54;30.15;10.54;44.93;34.14;64.36;20.97;13.74;33.2;22.45;11.39;26.6;9.08;24.44;33.24;19.61;22.38;22.1;29.58;15.04;59.63;26.33;42.8;21.09;26.01;11.64;19.01 1996-07-09;13.1;13.75;29.1;43.84;30.42;10.51;45.05;34.52;63.92;21.09;13.87;33.28;21.46;11.55;26.71;9.12;24.6;34.68;19.79;22.03;22.23;29.47;15;59.85;26.59;43.17;21.47;26.12;11.76;18.52 1996-07-10;13.42;13.55;29.35;43.78;30.15;10.39;45.52;34.85;65.33;21.18;13.99;33.7;21.93;11.44;26.25;9.06;24.57;34.57;20.01;22.38;22.23;29.64;14.94;61.07;26.69;43.29;21.47;25.81;11.64;18.76 1996-07-11;13.1;13.28;28.91;42.75;29.93;10;45.17;34.69;60.9;21.3;13.74;32.78;19.31;11.06;25.85;8.64;23.85;35.34;19.75;22.38;22.1;29.24;14.31;59.74;26.59;42.74;21.25;25.54;11.46;18.12 1996-07-12;13.3;13.36;29.02;42.82;29.22;10.06;44.69;34.19;61.44;21.37;13.76;32.12;19.25;11.19;25.5;8.86;23.68;35.56;19.83;22;21.92;28.91;14.05;59.3;26.56;42.19;21.75;25.4;11.58;18.36 1996-07-15;12.87;13;27.81;42.08;27.75;9.79;43.15;33.21;57.98;21.06;13.33;31.29;18.85;10.78;25.21;8.6;22.58;35.34;19.21;21.44;21.24;28.39;13.83;56.64;26.23;41.15;21.36;24.88;11.34;17.71 1996-07-16;12.81;13.16;27.37;41.11;28.89;9.88;43.75;33.1;60.57;20.58;13.25;31.29;20.51;10.95;25.44;8.7;23.79;35.12;19.46;22.49;21.48;27.87;14.42;56.42;26.17;41.34;21.42;24.44;11.1;18.08 1996-07-17;12.98;13.4;27.81;41.36;28.62;10.12;43.63;32.82;63.06;20.28;13.56;32.62;21.19;11.41;25.27;8.91;23.39;34.46;19.75;22.14;21.98;28.61;14.64;55.76;25.91;41.27;21.25;24.38;11.76;18.08 1996-07-18;13.04;13.36;26.7;42.75;29.56;10.33;44.93;33.15;64.36;20.43;13.74;32.62;21.56;11.74;25.56;9.01;23.42;34.79;20.27;22.9;22.54;29.36;14.98;57.64;26.33;41.95;21.47;25.25;11.7;18.48 1996-07-19;13.01;13.12;26.33;42.33;29.34;10.18;44.69;33.43;63.82;20.34;13.46;32.03;21.19;11.58;25.61;9.05;23.3;34.46;20.05;23.02;22.54;29.47;15.12;57.86;26.2;41.82;21.8;25.08;11.64;18.52 1996-07-22;12.9;12.96;25.46;41.9;28.74;9.97;44.93;33.43;63.38;20.34;13.25;32.45;21.31;11.52;25.85;8.98;22.98;33.9;19.83;22.78;22.54;29.93;14.97;57.64;26.04;42.13;21.92;24.79;11.28;18.08 1996-07-23;12.87;13.12;24.78;40.75;28.36;9.97;44.34;32.77;63.17;20.16;13.01;31.87;20.2;11.08;26.71;8.64;22.43;33.46;19.54;22.08;22.35;29.01;14.02;57.3;25.97;42.13;21.8;24.91;11.22;17.91 1996-07-24;12.93;13.44;25.09;41.66;28.63;9.85;43.51;33.92;63.82;19.93;13.09;31.04;21.5;11;26.83;8.58;22.8;33.24;19.5;22.14;22.54;29.47;14.34;56.09;26.04;41.82;21.75;24.93;11.58;17.55 1996-07-25;13.04;13.67;25.28;42.75;28.09;9.94;43.75;34.8;63.82;19.98;13.21;31.62;21.56;10.92;26.77;8.97;25.75;33.02;19.94;22.08;22.85;29.13;14.81;56.2;26.14;41.76;21.64;25.14;11.64;17.55 1996-07-26;13.21;13.87;25.59;42.87;29.02;9.88;44.69;35.35;63.06;19.84;13.33;31.79;21.74;11.11;27.06;9.23;25.81;33.68;20.16;22.43;22.97;29.3;14.89;56.09;26.62;42.5;21.69;26.07;11.64;17.47 1996-07-29;13.33;13.83;25.28;41.96;28.47;9.94;43.86;34.91;62.3;19.69;13.11;31.45;21;11.36;26.77;9.06;26.03;33.79;19.79;22.2;22.79;28.9;14.61;56.53;26.53;42.56;21.31;25.46;11.52;17.23 1996-07-30;13.39;13.91;25.15;42.57;28.25;9.85;43.98;35.13;63.49;19.48;13.13;32.12;21.5;11.33;27;9.25;26.68;33.46;20.05;22.49;22.97;29.18;14.83;57.53;26.85;43.17;21.2;25.78;11.64;17.83 1996-07-31;13.44;13.87;25.77;42.93;28.85;10.24;44.46;35.46;64.57;19.6;13.48;32.45;21.68;11.08;27.18;9.34;26.71;33.57;20.27;22.26;23.04;29.3;14.73;57.53;27.28;43.66;21.58;26.12;11.64;17.95 1996-08-01;13.84;14.27;26.08;43.23;29.45;10.7;45.64;35.46;65.55;19.87;13.66;33.45;21.56;11.41;27.7;9.57;26.65;34.12;20.74;22.9;23.41;30.04;15.08;58.3;27.6;43.84;22.03;26.18;11.88;18.52 1996-08-02;14.08;14.43;26.7;44.45;29.78;10.88;46.71;35.79;66.2;20.19;14.11;33.62;22.3;11.83;28.91;9.79;27.05;34.24;21.58;23.13;23.78;30.32;15.42;59.52;27.8;44.39;22.36;26.15;11.88;18.72 1996-08-05;14.05;14.27;26.82;43.42;30.17;10.73;46.59;35.95;66.41;20.07;14.07;33.87;21.99;11.55;28.62;9.71;27.15;34.79;21.32;23.48;23.47;30.38;15.22;58.74;27.37;44.64;22.36;26.3;11.88;18.84 1996-08-06;14.11;14.27;26.7;44.02;30.28;10.82;46.83;36.17;66.52;20.01;14.17;33.95;21.74;11.52;28.39;9.93;27.24;34.57;21.25;23.54;23.6;30.67;15.5;59.3;27.41;44.52;22.25;26.65;11.95;19.04 1996-08-07;14.02;14.31;27.25;44.75;30.49;11.09;46.71;36.23;67.71;19.78;14.05;33.62;22.67;11.66;29.03;10.24;27.99;35.01;21.18;24.01;23.84;30.5;15.59;58.3;27.57;44.39;22.03;27;12.01;18.84 1996-08-08;14.02;14.19;27.25;44.87;30.6;11.03;46.47;36.61;66.95;19.69;13.91;33.87;22.73;11.8;28.97;10.04;28.2;35.23;21.1;23.89;23.72;30.5;15.66;58.63;27.5;42.99;21.86;27.14;12.01;18.56 1996-08-09;14.08;14.43;27.07;44.14;30.6;11;46.23;36.28;65.98;19.21;13.72;34.53;22.42;12.02;28.8;10.24;27.92;35.45;21.29;23.89;23.66;30.78;15.56;58.08;23.69;42.93;21.86;27.26;12.25;18.44 1996-08-12;14.02;14.43;27.5;44.14;31.1;11.12;47.18;36.5;65.65;19.45;13.93;35.28;22.05;12.18;28.8;10.21;27.86;36.56;21.5;24.53;23.53;31.64;15.66;58.41;24.41;43.41;22.03;27.31;12.55;18.88 1996-08-13;13.99;14.23;26.76;43.78;30.77;10.91;47.66;36.25;65.33;19.39;13.93;35.05;21.56;12.07;28.91;9.98;27.18;36.23;21.76;24.47;23.53;31.52;15.44;58.19;23.46;43.41;22.03;27.14;12.55;18.72 1996-08-14;14.31;14.27;26.7;43.96;30.6;10.85;48.01;36.31;65.55;19.27;13.99;34.79;21.43;11.85;28.8;10.16;27.64;36.12;21.87;24.76;23.6;31.24;15.61;58.74;23.79;43.78;21.92;27.14;12.79;18.76 1996-08-15;14.13;14.23;27.07;44.33;30.49;10.82;48.49;36.2;65.01;19.24;13.89;35.05;19.71;11.61;28.96;10.16;27.55;36.23;21.98;24.76;23.53;31.52;15.64;59.08;23.46;43.54;21.8;27.29;13.16;18.68 1996-08-16;14.28;14.35;27.37;44.51;30.55;11.06;49.08;36.42;64.9;19.63;13.91;35.05;20.63;11.61;29.13;10.07;27.33;36.34;22.23;24.15;23.47;31.58;15.53;59.3;23.1;44.15;21.75;26.94;13.52;18.76 1996-08-19;14.31;14.31;26.7;44.45;30.82;11.12;48.96;36.14;64.36;19.9;13.93;34.46;21.06;11.74;29.31;10.04;27.33;36.34;22.42;24.39;23.72;31.64;15.44;59.85;23.43;44.27;21.8;26.82;13.04;18.72 1996-08-20;14.63;14.31;26.82;44.51;31.26;11.21;48.61;36.97;63.82;19.96;13.93;34.37;20.94;11.63;29.65;9.89;27.46;36.56;22.67;24.21;23.53;31.35;15.42;60.62;23.85;43.9;21.75;26.94;13.22;18.48 1996-08-21;14.86;14.47;26.82;44.21;31.26;11.09;48.25;36.92;63.92;19.75;13.76;34.29;20.63;11.8;29.54;9.98;27.89;36.34;22.74;24.27;23.47;31.35;15.44;59.61;22.84;43.6;21.53;26.39;13.04;18.68 1996-08-22;14.63;14.55;26.76;43.48;31.48;11.21;49.32;36.97;64.9;19.93;13.87;34.54;21.19;11.91;29.71;10.32;27.99;36.67;23.14;24.33;23.66;31.41;15.62;59.61;22.62;44.33;21.75;26.83;13.22;18.76 1996-08-23;14.77;14.55;26.94;43.84;31.21;11.09;48.72;36.86;64.68;19.66;14.05;34.29;21.5;11.83;29.65;10.15;28.08;36.78;22.78;23.92;23.6;30.95;15.41;58.83;22.94;44.27;21.64;26.86;13.04;18.84 1996-08-26;14.57;14.47;26.45;43.84;31.21;11.06;48.49;36.53;64.25;19.45;14.03;33.96;22.11;11.85;29.6;10.1;27.95;37.12;22.63;23.63;23.66;30.55;15.36;58.94;23.56;43.78;21.36;26.89;13.04;19.16 1996-08-27;14.57;14.47;26.45;44.27;31.1;11.12;48.96;36.64;64.25;19.66;14.17;33.54;22.3;11.91;29.6;10.13;27.77;36.67;22.63;23.8;23.6;30.67;15.59;60.06;23.95;44.33;21.14;26.92;13.04;19.04 1996-08-28;14.68;14.39;26.26;44.69;30.71;10.97;48.61;36.53;63.92;19.48;14.15;33.28;22.42;12.1;29.54;10.1;28.58;36.56;22.49;23.57;23.53;30.89;15.7;60.17;23.82;44.94;20.81;26.77;13.04;18.8 1996-08-29;14.42;14.07;25.89;44.45;30.38;10.73;47.78;36.59;63.29;19.06;13.89;33.12;21.93;11.91;29.07;10.12;28.61;35.89;22.12;23.33;23.28;30.32;15.52;60.06;23.56;43.9;20.7;26.51;12.82;18.64 1996-08-30;14.39;13.87;25.89;43.9;30.17;10.51;47.42;36.31;63.08;19.42;13.62;33.28;21.56;11.69;28.67;9.92;28.42;35.67;21.69;23.04;23.04;29.93;15.31;61.28;23.4;43.48;20.59;26.31;12.82;18.4 1996-09-03;14.57;13.71;25.89;43.96;30.38;10.73;48.13;36.92;62.86;19.96;13.78;33.37;21.99;11.63;28.73;10.15;28.64;35.78;21.91;22.98;23.04;29.7;15.42;60.95;23.37;43.54;20.48;26.37;12.88;18.4 1996-09-04;14.71;13.75;25.89;44.33;31.1;10.54;48.01;36.81;62.42;19.98;13.81;32.78;21.8;11.77;28.84;10.23;28.48;36.34;21.76;22.98;22.85;30.11;15.42;60.61;23.56;43.29;21.03;26.34;12.94;18.32 1996-09-05;14.6;13.63;25.65;43.9;30.77;10.42;47.42;36.75;62.1;19.81;13.64;32.19;21.19;11.69;28.61;10.03;28.11;36.34;21.54;22.69;22.79;30.05;15.19;60.17;23.5;42.99;20.59;26.07;12.58;17.95 1996-09-06;14.39;13.63;26.02;43.78;31.43;10.6;48.66;36.97;62.86;20.01;13.89;32.03;21.5;11.94;29.02;10.1;28.7;36.34;21.94;23.27;22.97;29.77;15.31;60.61;23.66;43.29;20.42;26.19;12.58;18.4 1996-09-09;14.51;13.83;26.33;43.72;32.19;10.91;49.08;37.47;62.42;20.07;14.03;32.36;21.62;12.1;29.54;10.38;29.23;36.56;21.94;23.33;23.41;30.51;15.61;60.95;23.92;43.78;20.65;27.01;12.88;18.8 1996-09-10;14.34;13.67;26.45;43.6;31.75;10.85;49.67;37.3;63.08;19.87;14.09;32.11;21.8;12.05;29.6;10.48;29.35;37.01;22.31;23.1;23.41;30.74;15.55;60.61;23.79;44.39;20.59;26.95;12.94;18.68 1996-09-11;14.19;13.79;27.13;43.78;31.59;10.94;49.32;37.69;63.62;20.22;14.09;32.03;21.62;12.13;29.65;10.57;29.32;36.56;22.71;23.04;23.6;30.74;15.64;60.73;23.98;44.39;20.65;27.04;12.94;18.92 1996-09-12;14.34;13.99;27.07;43.9;31.48;11.03;49.32;37.75;63.29;20.25;14.26;32.36;21.93;12.29;29.77;10.62;29.13;37.34;22.85;23.04;23.47;30.86;16.08;61.51;23.97;44.45;20.92;27.18;13.31;19.53 1996-09-13;14.37;14.15;27.25;44.14;32.47;11.36;50.39;38.02;65.69;20.13;14.48;33.03;22.97;12.43;29.71;10.96;30.35;37.56;23.14;23.39;23.66;31.14;16.38;62.29;24.17;45.19;21.36;27.47;13.24;19.61 1996-09-16;14.71;14.55;27.99;44.21;32.68;11.39;50.5;38.46;65.69;20.28;14.48;33.28;23.77;12.82;29.6;11.02;30.5;39.01;23.29;23.45;24.22;31.26;16.44;62.29;24.3;45.49;21.47;28.23;13.31;19.45 1996-09-17;14.63;14.27;28.11;44.14;32.19;11.39;49.55;38.63;64.6;20.28;14.26;33.62;23.9;12.57;29.31;11.72;30.72;39.57;22.78;23.39;23.72;31.37;16.73;63.73;24.86;45.31;21.31;27.91;13.18;19.73 1996-09-18;14.54;14.15;28.48;44.21;32.03;11.21;49.32;38.58;65.14;20.43;14.3;33.54;23.77;12.38;29.02;11.89;30.94;39.46;22.71;23.22;23.66;31.37;17.06;63.07;24.63;45.19;21.31;27.65;12.94;19.77 1996-09-19;14.25;14.23;28.18;44.81;32.63;11.39;49.44;38.19;65.47;20.46;14.4;32.61;23.77;12.54;28.61;12.06;30.69;39.24;22.56;23.39;23.6;31.43;17.22;62.84;24.76;44.58;21.36;27.65;13.06;20.5 1996-09-20;14.02;14.39;28.05;46.02;32.9;11.51;48.6;38.24;65.36;20.7;14.6;32.95;24.14;12.62;29.13;12.11;30.56;38.35;22.74;23.63;23.6;31.49;17.27;62.4;24.47;45.62;21.64;27.65;13.43;20.38 1996-09-23;13.61;14.27;28.18;45.9;32.85;11.51;48.6;38.41;66.45;20.64;14.5;32.61;23.71;12.54;29.71;11.91;30.87;38.35;23.11;23.74;23.72;31.83;17.22;62.4;24.17;45.86;21.58;27.82;13.18;20.54 1996-09-24;13.55;14.27;25.4;45.72;33.01;11.42;48.96;38.8;66.34;20.55;14.73;32.45;23.84;12.46;29.31;12;30.84;38.01;23.11;23.57;23.91;31.72;17.11;62.17;24.24;46.53;21.42;27.82;12.94;20.25 1996-09-25;13.73;14.55;25.46;45.96;32.74;11.6;48.72;38.41;67.21;20.28;14.99;31.86;23.77;12.35;29.25;12.09;31.43;37.68;23.29;23.51;23.53;31.6;16.95;62.06;23.97;46.9;21.25;28.17;12.64;20.21 1996-09-26;13.67;14.58;25.65;46.27;32.52;11.82;48.96;39.35;67.64;20.01;14.81;31.86;23.16;12.46;29.94;12.11;30.91;37.34;23.51;23.86;23.6;32.46;16.5;62.17;23.84;47.14;21.03;28.03;12.52;20.01 1996-09-27;13.64;14.66;25.34;46.02;32.41;11.85;48.25;39.57;68.08;19.87;14.99;31.69;23.47;12.4;30;12.05;31;37.12;23.51;24.09;23.78;32.23;16.8;62.17;23.81;47.33;21.03;28.06;12.7;20.34 1996-09-30;13.67;14.66;25.77;45.84;33.01;11.91;48.37;38.96;68.3;19.84;14.91;32.19;24.02;12.51;30.58;11.87;30.94;37.9;23.36;23.98;23.53;32.29;16.48;62.17;23.71;47.7;21.25;28.09;12.82;20.42 1996-10-01;13.93;14.74;19.18;46.21;32.3;12.09;47.65;39.63;67.43;20.31;14.85;33.12;23.59;12.82;30.58;11.91;30.75;38.23;23.65;23.92;23.6;32.58;16.52;61.84;24.2;47.82;21.31;28.09;12.64;20.17 1996-10-02;14.08;14.86;19.43;46.75;32.47;12.36;47.3;40.01;67.86;20.43;15.05;33.45;22.67;12.84;30.41;12.31;31.28;37.68;23.71;23.98;23.35;32.35;16.84;62.51;24.4;47.57;22.08;28.14;12.45;20.29 1996-10-03;13.99;14.74;19.24;47.06;32.36;12.36;46.46;39.96;68.19;20.49;15.05;33.2;22.3;12.84;30.93;12.37;31.06;38.01;23.75;23.86;23.1;32.69;16.75;62.51;24.04;48;21.92;28.17;12.82;20.38 1996-10-04;13.9;15.06;19.55;47.48;32.19;12.88;47.53;41.28;68.4;20.94;15.32;32.95;21.5;12.98;31.05;12.64;31.46;38.35;24;24.27;23.04;32.69;17.05;62.73;24.5;48.86;21.97;28.44;12.82;20.7 1996-10-07;13.53;15.14;19.73;47.84;31.92;12.88;47.77;40.84;65.58;20.94;15.42;33.03;22.6;12.87;30.58;12.98;31.77;38.01;24.04;24.33;23.16;32.29;17.19;62.29;24.7;48.37;21.86;28.35;13;20.7 1996-10-08;13.06;15.02;19.43;47.54;31.64;12.6;47.53;41.5;66.34;20.85;15.3;33.54;22.23;12.73;30.18;12.64;31.9;37.12;23.86;24.27;22.91;32.81;16.92;62.51;24.7;47.63;21.72;28.61;13.18;20.54 1996-10-09;12.95;14.93;19.43;47.3;31.48;12.45;47.3;41.34;65.9;20.52;15.22;33.87;22.6;12.51;30;12.54;31.37;37.79;23.64;23.98;22.91;32.35;16.81;62.51;24.47;47.21;21.55;28.58;12.82;20.53 1996-10-10;13.47;14.77;19.12;47.36;31.53;12.3;46.58;42;65.69;20.46;15.08;33.45;22.11;12.68;30.06;12.42;31.74;37.9;23.78;23.8;22.66;31.95;16.72;63.07;24.6;46.66;21.27;28.38;13.12;20.57 1996-10-11;13.53;14.97;19.12;47.48;32.08;12.57;47.3;42.61;66.34;20.58;15.46;33.62;22.79;12.73;30.18;13.1;32.27;38.01;23.93;24.09;22.85;32.06;17.14;64.18;24.76;46.29;21.44;28.47;13.37;20.69 1996-10-14;13.53;15.09;19.12;47.6;32.47;12.85;46.94;42.44;67.75;20.88;15.57;34.79;23.1;12.76;30;13.38;32.3;38.23;24.22;24.56;23.16;32.86;17.08;63.62;24.7;46.72;21.49;28.67;13.24;20.73 1996-10-15;13.64;14.93;19.43;47.6;33.4;12.79;46.35;42.44;68.73;20.76;15.61;34.96;22.79;12.49;29.89;13.82;32.18;37.45;24.22;23.98;23.1;32.69;17.36;63.29;24.83;47.57;21.27;28.52;13.06;20.81 1996-10-16;13.61;15.09;19.67;47.18;32.74;12.79;46.11;41.95;68.4;20.82;15.57;35.38;23.28;12.51;30.06;14;31.71;37.68;23.86;23.98;22.66;33.04;17.25;64.29;25.33;46.96;22.05;28.93;13.18;21.18 1996-10-17;13.87;15.05;19.67;47.54;32.75;12.91;46.82;42.39;68.4;21;15.59;35.72;23.22;12.57;30;13.77;31.22;37.56;24.04;24.5;22.97;34.35;16.94;64.29;25.72;47.7;22;29.28;13.49;20.98 1996-10-18;13.82;14.93;19.67;47.66;32.64;12.85;47.53;42.83;69.38;21.3;15.59;35.63;23.47;12.68;29.94;13.68;32.15;37.79;24.19;24.27;22.91;34.58;16.84;64.63;24.3;48.49;22.27;29.72;13.67;21.02 1996-10-21;13.79;14.85;19.61;47.9;32.59;12.91;47.3;42.83;69.49;21.21;15.69;36.13;22.85;12.71;30;13.4;32.33;38.12;24.37;23.74;22.17;34.41;16.75;63.85;24.7;47.33;22.39;29.6;13.37;21.22 1996-10-22;13.55;14.81;19.61;47.72;32.2;12.85;47.65;43;68.73;20.97;15.67;36.64;22.85;12.62;30.06;13.12;31.56;38.01;24.15;23.27;22.23;34.7;16.56;63.73;24.43;47.51;22.33;29.25;13.43;21.54 1996-10-23;13.44;14.85;18.69;47.06;31.7;12.97;47.77;41.78;67.86;21.12;15.81;36.39;22.79;12.38;29.77;13.6;32.12;38.23;24.3;23.27;22.23;34.81;16.81;63.96;24.57;47.08;22.27;28.82;13.37;21.38 1996-10-24;13.87;14.89;17.88;46.33;31.54;12.91;47.77;41.45;66.88;20.79;15.75;36.39;22.11;12.4;29.54;13.37;31.65;38.12;24.48;22.75;22.1;34.47;17.08;63.51;24.17;45.98;22.05;29.78;13.06;21.14 1996-10-25;13.84;14.85;17.95;45.66;30.99;12.76;47.41;41.62;66.23;21.09;15.71;36.22;22.48;12.16;29.48;13.1;31.43;38.46;24.55;22.1;22.17;33.61;17.05;66.3;24.43;45.98;21.94;30.07;13.12;21.42 1996-10-28;13.79;14.85;17.64;45.42;30.49;12.63;47.18;41.12;66.12;21.03;15.57;36.13;22.3;11.88;29.07;13.18;31.65;38.46;24.41;22.28;21.86;33.44;17.08;67.08;24.63;46.59;22;29.63;13.24;21.46 1996-10-29;13.99;14.57;17.58;45.36;30.49;13.18;47.3;41.5;66.88;21.36;15.73;36.22;21.8;12.1;29.25;12.98;31.22;38.57;24.81;22.57;22.04;33.9;16.92;68.19;24.76;47.88;21.94;29.37;13.31;21.26 1996-10-30;13.8;14.73;17.39;45.72;30.27;13.09;47.89;40.68;68.4;21.24;15.73;35.72;21.74;11.61;30.29;13.27;31.4;37.9;25.07;22.46;22.1;33.67;17.03;67.19;24.47;47.82;21.72;29.72;12.76;21.22 1996-10-31;13.66;14.97;17.27;46.27;30.22;13.15;48.01;41.01;69.27;21.12;15.85;35.97;21.74;12.07;30.41;13.66;32.05;38.01;25.18;23.04;22.1;33.9;17.16;68.08;24.4;48.43;21.66;30.04;12.88;21.3 1996-11-01;13.83;14.97;17.02;44.57;30.6;13.15;47.77;41.5;69.17;21.03;15.83;36.22;21.68;11.83;31.16;13.52;31.68;38.9;25.14;22.98;22.54;33.95;17.17;67.75;24.53;48.43;21.61;30.22;12.82;21.18 1996-11-04;13.75;15.13;16.65;44.99;31.21;13.42;48.25;41.62;68.73;21.09;15.96;37.31;21.25;11.77;31.16;13.72;31.99;38.35;25.4;22.86;22.42;34.58;17.25;67.3;24.53;49.1;21.38;30.36;12.76;21.62 1996-11-05;13.95;15.41;16.9;44.93;31.48;13.97;48.96;41.67;69.49;21.03;16.18;37.31;21.74;11.96;31.86;14.18;32.37;38.12;25.98;23.39;22.6;34.64;17.69;68.64;24.7;49.9;21.72;30.39;12.94;21.87 1996-11-06;13.95;15.45;17.08;44.39;31.92;14.6;49.44;42.44;70.8;21.12;16.65;37.14;22.42;12.1;32.56;14.78;33.14;37.79;26.13;24.56;23.28;36.25;18.06;71.09;25.72;51.43;21.83;30.57;13.06;21.91 1996-11-07;13.95;15.41;17.27;45.05;32.36;14.69;49.79;42.11;71.23;21.09;16.84;36.81;23.65;11.99;33.02;15.19;33.23;37.9;26.31;24.09;23.28;36.36;17.94;71.2;25.99;51.18;21.77;30.71;13;22.31 1996-11-08;13.98;15.61;17.64;45.54;32.36;15.15;50.03;41.78;70.47;21.3;16.73;37.22;23.34;12.51;32.56;15.2;33.39;37.34;26.35;24.09;23.35;36.94;17.94;71.31;25.82;51.55;21.72;30.92;13.12;22.15 1996-11-11;13.92;15.93;18.32;45.11;32.25;14.51;49.44;41.78;71.88;21.44;16.71;36.89;23.59;12.49;32.96;15.4;33.42;38.35;26.06;24.09;23.41;37.17;17.95;72.43;26.25;50.81;21.72;31.27;12.88;22.75 1996-11-12;14.27;16.05;18.93;44.51;32.47;14.69;48.84;42.39;72.97;21.21;16.69;37.24;23.65;11.74;32.96;15.05;33.11;37.9;25.76;23.8;23.41;36.53;17.72;72.54;26.18;51.18;21.83;31.32;12.21;22.92 1996-11-13;14.21;16.01;18.75;44.45;33.19;14.51;49.44;41.34;72.54;21.5;16.98;37.16;23.96;11.88;32.9;14.86;33.48;38.01;25.47;23.8;23.41;36.65;18.12;71.87;26.32;51.73;21.66;31.03;11.67;22.84 1996-11-14;14.36;16.17;18.56;44.81;32.92;14.51;49.55;40.92;72.54;21.47;17.21;37.58;24.45;11.72;33.54;14.91;34.01;37.79;26.06;23.8;24.09;37.34;18.7;72.87;27.11;52.04;21.77;30.8;11.91;22.84 1996-11-15;14.33;16.21;18.44;44.51;32.36;14.63;50.15;41.25;72.86;21.5;17.08;37.5;25.07;11.69;33.59;14.41;36.03;38.01;25.98;23.83;23.97;37.62;18.62;72.43;26.71;52.4;21.88;30.8;11.91;23.36 1996-11-18;14.45;16.21;18.32;45.24;32.42;14.63;49.67;41.14;72.54;21.74;16.94;37.58;24.51;11.63;33.06;14.35;36.47;37.79;26.28;23.77;24.03;37.45;18.8;73.43;26.78;52.65;22;30.74;12.03;23.08 1996-11-19;14.39;16.17;18.32;45.6;32.59;14.66;49.2;41.53;73.62;21.92;16.88;36.91;25.99;11.5;33.82;15.01;38.3;38.79;27.16;24.24;24.22;37.51;19.48;73.43;26.84;52.77;21.94;31.09;11.91;22.96 1996-11-20;14.79;16.17;18.32;46.75;34.68;14.72;49.08;41.2;72.86;21.74;16.84;38.6;25.81;11.28;33.94;15.03;37.93;38.57;27.09;24.12;24.09;37.85;19.16;74.32;26.88;53.38;22.39;31.25;12.09;23.2 1996-11-21;14.53;16.09;18.32;47.3;34.13;14.45;48.13;41.25;71.78;21.65;16.65;38.6;26.05;11.5;33.88;14.78;38.3;38.57;26.65;24.48;24.03;37.57;18.8;74.76;26.91;53.32;22.83;31.45;12.27;23.36 1996-11-22;14.53;16.53;18.32;47.84;35.23;14.57;48.25;41.36;71.01;22.13;16.55;38.85;26.61;11.22;34.11;15.23;39.38;38.57;26.87;24.54;23.78;37.97;18.81;76;27.01;53.44;22.94;31.63;12.39;23.32 1996-11-25;14.74;16.73;18.62;47.84;35.28;15.07;48.84;41.92;71.67;22.61;17;39.36;26.67;11.41;34.29;15.11;39.17;38.45;28;25.24;23.6;38.66;19.19;76.11;27.87;54.24;23.17;32.45;12.39;23.77 1996-11-26;14.77;16.88;18.93;48.15;34.4;14.74;48.84;42.09;71.45;22.61;16.71;39.44;26.48;11.66;34.17;15.39;39.26;38.01;27.64;25.18;23.35;38.37;19.22;75.1;27.67;53.5;23.17;32.33;12.33;24.57 1996-11-27;14.77;16.73;19.24;48.33;35.06;14.58;48.84;41.64;70.49;22.34;16.8;38.51;26.61;11.39;33.7;15.74;39.29;37.33;27.6;25.12;22.91;38.43;19.44;74.76;27.44;53.32;23.39;32.74;12.33;23.89 1996-11-29;14.82;16.65;19.36;48.21;34.84;14.54;48.72;41.92;70.93;22.49;17.04;38.93;26.55;11.47;34.11;15.78;39.6;38.12;27.75;25.01;23.22;38.08;19.61;75.1;27.27;53.2;23.44;32.86;12.39;23.89 1996-12-02;14.85;16.53;19.3;47.3;34.79;14.38;48.48;42.75;71.25;22.61;16.92;39.1;27.53;11.63;33.36;15.81;40.5;38.01;27.34;24.83;22.97;37.74;19.72;74.54;27.27;53.14;23.67;32.8;12.39;23.89 1996-12-03;14.71;16.17;18.93;46.75;34.13;14.1;47.41;43.64;71.14;22.52;16.26;39.44;26.92;11.58;32.25;15.65;40.41;37;26.72;24.3;22.73;37.17;19.34;74.54;27.24;51.24;23.05;31.98;12.64;23.24 1996-12-04;14.56;16.45;19.12;46.88;33.91;13.99;47.29;42.7;70.49;22.37;16.21;39.44;27.78;11.52;32.42;16.1;40.25;37.11;26.61;24.42;23.04;37.05;19.16;74.2;27.58;51.06;23.11;31.45;12.39;23.28 1996-12-05;15;16.45;18.99;46.75;34.24;13.82;46.93;43.53;70.82;22.64;16;39.69;27.78;11.36;32.6;15.95;39.38;38.01;26.09;24.24;23.91;36.54;19.12;73.98;28.5;50.51;23.11;31.45;12.39;23.24 1996-12-06;14.65;16.41;19.06;46.39;33.91;13.69;46.7;42.53;70.05;22.61;16.04;38.17;27.04;11.47;32.13;15.63;38.67;37.33;26.28;24.3;23.28;36.02;19.11;73.2;28.89;50.69;22.78;30.96;12.15;23.12 1996-12-09;14.71;16.57;19.36;46.75;34.13;14.26;47.89;42.59;70.16;22.64;16.14;39.86;27.65;11.66;32.54;16.18;39.76;36.66;26.39;24.59;23.91;37.06;20.44;74.76;30.18;52.16;22.78;30.9;11.97;23.64 1996-12-10;15.03;17.48;19.06;46.33;34.68;14.26;47.29;42.31;71.03;22.4;16.08;39.69;26.79;11.52;32.31;16.06;39.2;37;26.39;24.65;23.6;36.72;20.47;75.66;30.74;51.91;22.72;31.13;11.97;23.68 1996-12-11;14.82;17.04;18.99;46.27;33.91;13.9;46.93;41.2;70.27;22.52;15.89;39.02;26.42;11.33;31.96;17.02;38.79;36.44;26.02;24.3;23.22;36.49;20.84;74.54;31.37;52.04;22.22;30.75;11.81;23.32 1996-12-12;14.88;17.16;19.06;46.69;33.69;13.57;45.62;40.36;70.05;22.52;15.85;38.43;25.07;10.95;31.55;17.02;37.68;35.76;25.51;23.71;22.66;35.16;20.25;71.96;30.35;51.18;22.16;29.75;11.63;22.71 1996-12-13;14.68;17.04;19.3;46.93;33.52;13.65;45.62;40.64;69.4;22.58;15.85;38.17;25.31;10.97;31.32;16.46;37.99;35.65;25.1;23.36;22.85;35.62;20;73.08;29.75;51.43;22.16;30.11;11.63;22.71 1996-12-16;14.47;17;19.3;48.87;32.92;13.61;45.86;40.75;69.07;22.52;15.59;37.5;24.7;10.67;31.2;15.82;36.93;35.32;24.99;22.95;22.66;34.99;19.19;72.64;29.12;51.49;22.33;29.99;11.32;22.43 1996-12-17;14.3;16.88;19.3;49;32.53;13.69;46.34;40.86;68.74;22.99;16;37.75;24.76;11;31.84;16.16;37.74;35.2;25.73;22.83;22.6;35.16;19.97;71.96;29.25;51.43;21.88;30.34;11.2;22.92 1996-12-18;14.18;17.08;19.15;49.24;32.7;13.98;46.1;41.36;69.61;23.17;16.26;36.82;25.99;11.03;31.78;16.88;39.42;35.54;25.65;23.07;22.6;35.45;20.66;72.75;29.79;50.94;21.61;30.16;11.2;23.12 1996-12-19;14.65;17.4;19.55;50.03;33.03;14.34;48.72;42.75;70.49;23.74;16.84;36.74;25.68;11.17;31.61;17.1;39.29;35.99;26.65;23.77;22.79;37.47;21.22;73.76;30.35;51.39;22.16;31.39;11.39;23.4 1996-12-20;14.77;17.88;19.43;51.12;33.25;14.62;50.39;43.2;71.36;23.74;16.75;37.16;25.31;11.44;31.38;16.74;38.42;35.88;26.87;23.42;22.6;38.1;20.91;76;29.79;52.89;22.66;31.8;11.51;23.4 1996-12-23;14.42;18.12;19.67;50.45;33.8;14.7;49.91;42.59;70.49;23.89;16.55;37.58;25.13;11.22;31.43;16.44;38.33;35.99;26.9;23.42;22.85;38.27;20.94;75.77;29.92;53.02;22.83;31.75;11.45;23.32 1996-12-24;14.42;18.99;20.41;50.03;33.63;14.95;50.63;42.59;70.71;23.89;16.71;37.33;25.19;11.25;31.78;16.85;38.7;36.1;26.87;23.48;22.97;38.39;21.22;76;30.55;53.38;23.28;31.75;11.45;23.12 1996-12-26;14.5;18.12;21.21;50.57;33.8;14.99;50.75;43.2;71.58;23.89;16.92;37.84;25.5;11.19;32.19;16.99;38.7;36.1;27.16;23.54;23.16;37.7;21.38;76.67;30.19;53.32;23.89;32.04;11.69;23.08 1996-12-27;14.5;18.6;21.58;50.63;33.8;14.91;51.46;42.64;72.13;23.8;16.8;37.58;25.44;11.33;32.48;16.83;38.55;36.44;27.05;23.71;22.97;37.64;21.06;76.56;30.42;53.81;24.56;31.86;11.75;23.04 1996-12-30;14.74;18.28;21.77;51.72;33.47;15.31;50.63;42.59;72.02;23.68;16.65;37.58;25.38;11.28;32.37;16.57;38.17;36.66;26.94;24.01;22.85;37.41;20.88;76.11;30.59;53.5;23.83;32.04;11.45;22.63 1996-12-31;14.85;18.07;21.4;51.66;33.14;14.66;50.15;41.86;70.16;23.35;16.2;37.67;24.76;11.03;31.2;16.28;37.65;36.32;26.24;23.36;22.54;36.72;20.66;74.43;30.15;52.65;23.11;31.04;11.08;22.55 1997-01-02;15.17;17.47;20.66;50.39;32.14;14.38;49.44;42.48;68.96;23.44;16;39.52;24.82;10.81;31.32;16.21;38.08;37.45;26;23.36;22.42;36.83;20.41;77.34;29.75;52.16;23.44;30.75;11.2;21.78 1997-01-03;15.84;17.43;20.48;51.6;32.92;14.58;50.63;43.64;69.29;23.5;16.24;39.1;25.56;10.95;32.13;17.21;39.54;36.77;26.07;23.6;22.35;38.1;21.16;76;30.15;53.02;23.5;31.51;11.02;22.39 1997-01-06;15.81;17.63;19.55;51.54;33.08;14.66;50.15;44.03;69.83;23.83;16.22;40.03;26.61;11.06;31.96;17.27;40.07;37.22;25.82;23.77;22.29;38.21;21.09;76.11;30.22;53.38;23.39;31.39;10.78;22.31 1997-01-07;15.73;18.43;19.18;51.48;33.19;14.54;51.82;44.48;71.03;23.89;16.55;40.03;26.85;11.3;32.02;17.83;40.6;37.78;25.63;23.83;21.98;38.27;21.25;75.21;30.19;54.36;23.11;31.16;11.63;22.27 1997-01-08;15.7;18.27;19;51;33.08;14.5;50.87;45.31;70.16;23.71;16.32;39.95;26.18;11.28;31.84;17.69;39.73;37.45;25.89;24.01;21.92;37.81;20.84;75.1;30.09;53.38;22.91;31.16;11.51;21.98 1997-01-09;16.22;18.31;19.12;50.94;33.52;14.83;51.34;46.48;70.38;24.51;16.57;40.03;26.11;11.19;31.73;17.78;40.22;37.11;26.11;24.18;21.86;38.1;20.59;74.99;30.25;53.69;22.8;31.86;11.63;21.86 1997-01-10;16.6;18.35;19.18;51;34.35;14.62;51.58;47.15;72.02;25.2;16.61;41.3;26.61;11.25;32.83;17.97;40.5;37.66;25.93;24.01;21.73;38.39;21.06;75.1;30.15;53.44;22.68;32.62;11.69;21.98 1997-01-13;16.48;18.23;19.06;51.78;34.95;15.23;51.46;46.53;71.91;24.57;16.92;40.62;26.92;11.22;32.66;18.26;40.72;38.45;25.85;23.6;22.04;38.27;20.94;74.76;30.62;52.95;22.63;32.1;11.45;22.02 1997-01-14;16.57;18.59;19.18;51.6;34.46;15.67;52.89;46.7;72.35;24.69;17.14;41.21;26.61;11.28;32.54;18.29;41.5;38.23;26.48;24.07;21.98;38.73;21.34;76.45;30.85;53.93;22.91;32.21;11.45;22.43 1997-01-15;16.54;18.87;19.18;51.3;34.13;15.43;54.32;47.53;71.03;24.78;16.86;40.62;26.79;11.06;32.37;17.66;40.91;38.01;26.78;24.48;22.29;38.39;21.16;75.77;30.35;53.44;23.53;31.39;11.26;22.39 1997-01-16;16.69;18.71;18.93;51.3;34.41;15.55;54.92;48.37;74.75;24.6;16.63;40.96;26.79;11;32.77;17.7;41.12;38.23;26.85;24.24;22.17;39.08;21.5;76.78;30.49;54.6;23.25;31.51;11.26;22.31 1997-01-17;17.01;19.07;18.87;51.48;34.86;16.36;55.99;49.65;74.53;24.51;16.98;40.62;26.61;11.19;33.41;17.91;41.06;38.68;27.18;24.12;23.1;39.66;21.78;76.78;30.75;55.28;23.53;31.86;11.39;22.67 1997-01-20;16.89;19.07;18.93;51.66;34.75;16.8;55.99;49.26;76.83;24.42;17.21;41.04;26.24;11.69;33.7;18.06;41.5;38.57;27.44;23.95;23.22;39.48;22.69;76;31.29;55.09;23.7;31.75;11.14;22.83 1997-01-21;16.45;19.11;19.43;55.24;33.81;16.56;56.82;49.48;76.28;24.69;17.29;41.89;26.61;11.47;33.47;18.41;41.75;38.34;27.44;25.12;22.97;39.89;23.75;76.11;31.92;54.79;23.58;31.69;11.14;22.59 1997-01-22;16.11;19.67;19.18;54.45;33.58;17.33;56.58;48.48;76.72;25.26;17.59;41.8;26.48;11.28;33.36;18.92;39.26;38.34;27.29;26.94;22.48;40.75;24.34;75.33;31.99;54.79;24.03;31.16;11.26;22.91 1997-01-23;15.67;19.43;18.75;53.6;33.36;16.93;54.8;47.81;77.37;24.51;17.06;41.8;25.62;11.03;32.95;18.87;37.71;37.11;26.92;26.36;23.1;39.77;23.69;73.2;31.39;54.12;24.26;32.62;11.08;22.79 1997-01-24;15.79;19.55;19;53.3;33.31;16.52;54.44;45.64;74.86;23.89;16.69;42.23;25.56;10.75;32.37;18.71;37.4;37.67;26.33;25.89;23.16;39.48;23.98;72.64;30.89;53.32;23.92;32.62;11.2;23.07 1997-01-27;15.52;19.03;19.18;53.18;33.58;16.32;53.72;46.03;74.42;24.6;16.45;41.8;25.25;10.56;32.37;18.67;36.22;37.45;26.19;25.65;22.66;38.96;24.03;73.53;30.92;52.71;23.92;32.33;11.14;23.2 1997-01-28;15.84;19.03;19.06;51.3;33.53;16.44;52.89;46.42;74.75;23.95;16.49;41.04;25.01;10.62;32.02;18.78;37.46;36.77;26.15;25.53;22.85;40.12;23.91;74.76;30.52;54.05;23.81;31.86;11.14;23.52 1997-01-29;15.96;19.51;19.18;50.88;33.64;16.48;53.84;47.7;75.19;24.6;16.98;41.13;25.31;10.67;32.42;19.24;38.86;37;26.48;25.83;22.73;40.69;24.31;75.55;31.05;54.41;24.03;31.75;11.2;23.88 1997-01-30;16.13;19.75;19.43;51.3;34.19;16.97;54.68;48.92;75.84;24.81;17.31;40.62;26.36;10.92;32.89;19.91;39.07;36.77;27.11;26.71;22.42;41.67;25.28;76.78;31.99;56.44;24.26;32.74;11.32;23.44 1997-01-31;16.08;19.87;19.43;51.97;34.36;16.93;55.15;48.76;75.84;24.69;16.96;39.86;25.93;10.89;32.77;20.17;38.98;36.66;27.33;27.12;22.6;41.79;25.5;76.45;31.72;56.56;24.71;32.68;11.57;23.6 1997-02-03;16.05;19.79;19.43;52.33;33.92;17.61;56.7;48.09;75.3;24.36;17.25;39.44;25.68;11.06;33.06;20.38;38.48;37;27.7;26.88;22.48;41.62;25.59;75.89;32.66;56.75;24.43;32.33;11.39;23.6 1997-02-04;15.9;19.55;19.37;52.15;34.3;17.61;56.58;49.26;78.47;24.63;17.02;39.1;25.62;11;33.12;20.49;38.17;37.56;28.44;27.65;22.79;42.25;25.78;76.33;32.52;57.54;24.76;32.62;11.45;23.52 1997-02-05;15.72;19.51;19;51.36;34.36;17.25;55.51;48.48;76.06;24.51;16.88;39.01;25.01;11.06;32.6;19.55;36.96;37.11;28.07;26.94;22.6;41.44;24.59;75.44;31.99;57.17;24.31;32.74;11.26;23.56 1997-02-06;15.6;19.83;18.93;51.66;34.41;17.17;55.04;49.7;75.73;24.27;17.04;38.33;25.25;11.22;33.06;19.04;36.28;36.77;28.07;27.65;22.35;42.42;24.28;75.21;32.46;58.52;24.09;32.68;11.51;23.97 1997-02-07;15.81;20.91;18.87;53.12;35.19;16.97;55.51;49.98;77.92;24.07;17.21;38.67;25.56;11.61;33.3;19.44;36.96;37.67;28.92;28.06;22.54;43.11;25.09;75.66;32.32;59.8;24.2;33.33;11.63;24.29 1997-02-10;15.57;20.79;19.24;52.03;35.02;16.76;55.51;48.03;78.25;23.86;17.02;38.42;24.21;11.63;33.06;18.85;35.47;37.67;28.81;28;22.85;42.6;24.44;74.88;32.09;59.99;24.76;33.27;11.93;24.49 1997-02-11;15.6;21.43;19.12;51.97;35.02;17.05;56.46;49.09;79.01;24.21;17.14;38.67;25.01;11.36;33.12;18.87;36.09;38.01;29.14;28.17;22.73;42.88;24.62;75.44;32.22;60.6;25.04;34.67;11.93;24.29 1997-02-12;15.66;21.55;19.55;53.18;35.19;17.94;57.42;49.85;81.09;24.54;17.35;39.27;25.01;11.33;33.82;19.49;36.03;38.34;29.44;28.59;22.91;44.21;24.97;77.34;32.42;61.7;25.32;35.85;12.18;24.82 1997-02-13;15.81;21.87;19.55;52.94;36.79;18.3;58.13;50.18;80;24.78;17.57;40.38;24.94;11.44;33.7;19.52;36.37;38.12;29.8;29.09;23.1;45.94;25;77.34;33.39;62.07;25.83;35.85;12.12;25.06 1997-02-14;16.19;21.79;19.55;52.27;35.3;17.94;57.78;49.01;81.2;24.75;17.43;40.04;24.82;11.28;34.29;19.21;36.03;38.57;30.06;28.91;23.22;44.9;24.47;76.22;33.49;61.09;25.44;35.61;11.99;25.3 1997-02-18;16.42;22.31;19.92;53.36;35.35;18.82;58.61;48.95;82.4;24.81;17.62;40.21;25.71;11.3;34.46;19.23;36.09;38.57;30.03;29.56;23.28;45.77;24.34;76.78;35.02;63.35;25.6;35.96;12.12;25.1 1997-02-19;16.63;21.71;19.74;53.3;35.58;18.54;59.09;48.4;81.2;24.6;17.62;39.35;27.96;11.22;34.64;19.13;35.69;38.12;30.73;29.03;22.97;45.19;24.38;76.13;35.52;62.19;25.55;36.11;11.87;24.65 1997-02-20;16.57;21.51;19.67;52.15;34.86;17.77;58.37;47.56;78.58;24.57;17.33;39.53;27.53;11.11;34.23;18.64;35.1;37.78;30.21;28.38;22.91;44.5;23.81;75.12;34.69;61.27;25.6;36.17;11.57;24.21 1997-02-21;16.63;21.51;19.67;52.33;35.24;17.69;59.09;48.12;78.79;24.72;17.23;39.87;27.47;11.22;34.17;18.2;34.2;37.55;30.28;28.38;22.66;43.86;23.75;76.92;34.46;60.78;25.49;35.7;11.69;24.41 1997-02-24;16.6;21.15;20.29;51.18;35.8;18.02;59.92;48.79;80;24.45;17.47;40.21;27.84;11.5;34.58;18.54;35.75;38.79;30.91;28.62;22.97;45.36;25.03;78.05;36.06;61.09;25.27;35.7;11.99;24.49 1997-02-25;16.36;21.43;20.29;51.48;35.74;18.66;59.68;49.4;78.79;24.66;17.37;40.63;29.07;12.13;33.88;18.51;36.4;38.91;31.28;28.26;23.53;45.07;24.88;81.21;35.56;60.29;25.32;35.17;12.85;24.65 1997-02-26;16.01;21.11;20.11;50.51;35.69;17.94;58.13;49.01;79.12;24.33;17.41;40.04;29.01;12.32;33.88;18.2;36.5;39.24;30.51;27.67;22.29;44.9;25.06;83.92;35.62;59.56;25.16;34.76;13.03;24.45 1997-02-27;16.6;20.59;19.8;49.36;35.24;17.21;58.73;48.34;79.84;23.8;17.23;39.35;28.02;12.18;33.65;17.37;35.53;38.57;29.8;27.14;21.61;43.29;24.03;83.13;36.16;59.01;25.32;35.52;13.03;24.57 1997-02-28;16.66;20.99;19.67;49.36;34.64;17.33;58.13;47.95;78.85;23.89;16.86;39.44;27.65;12.02;33.77;17.64;35.72;37.55;29.58;27.09;21.48;42.48;24.38;83.01;36.09;58.76;25.83;35.4;12.85;24.05 1997-03-03;16.89;20.87;18.19;49.54;34.86;17.65;57.54;49.79;78.63;23.65;16.94;40.38;28.02;12.27;33.59;18.14;36.06;38.57;30.14;27.5;21.55;43.34;24.88;83.46;36.42;58.89;25.77;35.05;13.15;23.76 1997-03-04;16.92;20.87;17.76;48.63;34.58;17.01;56.46;48.56;77.75;23.83;16.61;39.01;28.33;12.16;32.89;18.2;36;37.78;30.06;27.03;21.92;42.08;24.78;81.21;35.92;58.15;25.49;34.52;12.91;23.56 1997-03-05;16.77;21.31;17.89;50.75;35.35;17.65;57.42;49.46;77.86;24.12;16.98;38.76;28.76;12.29;33.82;18.59;36.15;37.89;30.65;27.97;22.35;43.55;25.22;82.9;35.79;58.89;25.6;35.23;12.97;23.8 1997-03-06;16.77;21.07;17.89;50.63;35.58;17.65;58.01;50.02;77.97;24.04;17.14;38.25;28.52;12.43;33.82;18.08;36.43;37.89;30.36;27.85;22.23;42.73;24.44;82;35.56;58.21;25.6;35.93;13.27;24.33 1997-03-07;16.92;21.35;17.89;51.6;36.07;17.94;57.66;50.58;80.39;23.92;17.27;38.59;27.65;12.46;33.82;17.84;35.97;38.34;31.47;28.56;22.11;43.08;24.19;82.45;36.29;58.95;25.89;36.46;13.27;24.61 1997-03-10;17.5;21.63;18.13;51.48;36.13;18.3;58.25;50.74;79.95;24.54;17.35;39.01;27.84;12.46;34.35;18;36.31;38.57;32.39;28.85;22.29;44.18;25;83.46;37.02;61.03;26.05;36.34;13.33;24.86 1997-03-11;17.77;21.35;17.82;52.45;35.52;18.14;59.09;50.63;80.5;24.48;17.23;39.18;27.29;12.38;34.64;17.89;36.28;38.34;31.39;28.68;22.04;43.49;24.59;83.13;37.26;61.88;25.94;36.58;13.52;24.98 1997-03-12;17.56;21.19;17.7;51.91;35.69;17.65;58.26;50.18;80.72;24.18;17.16;39.35;26.92;12.4;34.82;17.75;36;38.91;30.69;28.09;22.04;42.73;24.69;82.11;36.82;61.15;25.16;36.23;14;24.41 1997-03-13;17.18;20.59;17.7;50.03;35.3;17.09;57.19;49.79;78.74;23.83;16.98;38.93;27.41;12.54;33.88;17.56;35.5;38.57;29.29;27.67;21.86;41.92;24.91;80.42;33.92;59.25;24.26;35.34;14.13;23.72 1997-03-14;17.44;20.63;17.58;49.97;35.91;17.21;56.83;50.41;77.64;24.1;16.88;39.53;27.29;12.79;34.17;17.14;35.69;39.13;29.66;27.26;21.92;40.94;24.75;80.98;34.76;61.51;24.99;35.76;14;24.21 1997-03-17;17.59;20.39;17.33;51.66;35.63;16.76;57.55;50.91;77.64;24.04;17.1;39.61;27.41;12.71;34.41;16.96;34.66;39.13;30.36;27.26;22.97;42.21;25.12;81.21;34.09;61.39;24.93;35.46;14.1;24.61 1997-03-18;17.27;20.31;17.45;50.33;35.47;17.01;57.67;49.63;77.2;24.12;16.88;38.67;27.59;12.84;34.17;17;34.63;39.02;29.4;27.14;23.35;41.87;24.91;80.53;33.75;60.78;24.99;34.76;14.22;24.45 1997-03-19;17.27;20.35;17.27;50.45;35.69;16.85;56.95;49.18;76.43;24.12;16.96;38.25;27.29;12.73;34.06;16.58;34.26;38.45;29.95;27.03;23.53;42.39;24.19;79.97;32.84;59.8;24.26;35.87;14.59;24.29 1997-03-20;17.09;20.55;16.96;50.94;35.69;16.32;56.35;48.4;77.53;24.1;16.82;38.25;28.09;12.68;33.94;16.57;34.01;38.23;30.06;26.91;23.41;42.04;24;79.97;31.19;58.89;24.14;35.76;14.34;24.13 1997-03-21;16.86;20.75;17.02;51.3;35.91;16.4;57.31;49.51;69.41;24.66;16.84;38.84;28.02;12.65;34.29;16.23;32.92;37.78;30.14;26.67;23.47;42.21;23.5;78.61;30.01;59.56;24.48;36.29;14.52;23.97 1997-03-24;16.83;21.19;17.27;51.3;36.9;17.21;57.07;51.08;67.1;24.9;17.35;39.44;28.02;12.73;34.93;16.24;33.98;38.68;30.54;27.26;23.6;41.63;22.53;79.97;31.16;60.35;25.27;36.87;14.52;24.29 1997-03-25;16.36;20.95;17.76;51.24;36.42;17.37;56.83;50.06;67.76;25.2;17.21;38.84;27.59;12.38;35.28;16.57;33.76;37.89;30.06;27.09;23.6;42.16;22.58;80.08;31.9;58.82;24.73;37.23;14.28;24.21 1997-03-26;16.45;20.59;17.76;51.06;35.85;16.89;56;49.07;68.75;26.06;17.02;38.08;27.47;12.27;35.28;17.49;34.85;37.1;29.51;26.91;24.09;42.1;23.56;78.84;32.17;59.19;24.57;37.34;14.46;24.37 1997-03-27;16.04;19.87;17.39;49.36;35.47;16.44;54.8;48.01;68.42;25.76;16.59;38.33;27.1;11.96;33.94;17.3;34.04;36.99;28.48;25.97;24.03;41.17;23.44;77.15;31.53;57.54;23.43;36.7;14.1;24.29 1997-03-31;15.9;19.15;17.39;47.84;35.52;15.51;53.25;47.39;66.77;25.67;16.26;37.74;26.24;11.77;33.3;17.3;34.1;35.18;27.74;24.91;23.47;39.03;22.92;76.36;30.72;56.13;23.77;35.64;13.61;23.6 1997-04-01;16.13;19.43;17.21;48.51;34.97;16.12;53.61;46.38;66.11;25.47;16.16;37.57;25.75;11.72;33.06;17.32;33.98;36.31;28.25;25.85;23.97;40.13;23.31;77.26;31.23;57.36;23.94;35.76;13.55;23.44 1997-04-02;15.93;18.78;16.9;47.66;34.69;15.27;53.25;46.05;65.45;24.96;16.02;37.05;24.94;11.69;32.95;17.03;33.23;35.97;27.47;25.61;23.6;39.55;23;75.91;30.79;56.38;23.6;35.76;13.55;23.44 1997-04-03;15.78;19.06;16.65;46.51;34.19;15.63;52.89;46.27;65.45;24.36;16.12;37.05;24.94;11.63;32.71;17.49;32.58;35.18;27.81;25.44;24.09;39.49;23.78;75.57;30.75;56.26;23.32;35.23;13.55;23.52 1997-04-04;15.81;19.1;16.84;47.54;35.02;15.51;54.8;46.72;66.11;24.27;16.53;36.8;25.99;12.02;33.18;18.03;32.12;36.09;27.92;25.73;23.97;40.24;23.55;75.12;30.52;58.21;23.26;34.82;13.61;23.88 1997-04-07;15.6;19.26;17.15;48.57;34.86;15.84;53.85;46.1;67.65;25.02;16.47;36.8;25.87;12.27;33.53;18.05;32.92;36.09;28.03;25.67;24.22;40.13;23.97;74.1;30.49;57.36;23.89;35.34;13.67;23.88 1997-04-08;15.55;19.7;17.02;49.24;34.47;15.92;54.2;47.28;68.09;24.78;16.59;37.23;26.11;12.29;33.12;18.23;33.95;36.88;28.81;25.67;24.77;39.49;24.56;76.36;30.75;56.62;23.94;35.23;13.98;23.92 1997-04-09;15.6;19.46;17.02;49.24;34.64;15.92;55.04;46.66;67.87;24.69;16.69;37.14;25.38;12.51;32.89;17.69;33.08;36.42;28.4;25.26;24.65;37.75;24.5;74.33;30.55;58.58;23.32;35.23;13.98;23.93 1997-04-10;15.6;19.1;17.02;49.54;34.41;15.84;54.44;45.77;66.33;24.66;16.63;37.14;24.7;12.51;32.6;17.07;33.05;36.99;27.99;25.61;24.4;38.74;24.19;75.23;30.72;58.52;23.55;35.05;13.85;24.01 1997-04-11;15.4;18.74;16.59;48.69;34.03;14.99;51.34;44.48;65.89;24.12;16.04;36.12;24.45;12.02;32.01;16.23;33.14;36.2;26.84;24.61;23.78;37.87;23.75;73.31;31.19;56.93;23.04;34.05;13.49;23.48 1997-04-14;15.37;18.66;16.53;48.87;35.13;15.63;53.13;44.82;64.24;24.66;16.39;36.54;24.45;12.32;31.9;16.63;33.92;35.52;26.91;24.97;24.15;38.28;24.34;73.43;31.09;58.52;22.58;34.11;13.55;23.08 1997-04-15;15.6;19.18;16.53;48.93;36.74;16.24;55.4;45.38;66.22;24.9;16.86;36.97;24.7;12.49;32.13;16.29;34.26;35.41;27.55;25.91;24.34;39.14;24.28;75;31.49;59.62;23.26;34.76;13.91;23.97 1997-04-16;16.04;19.22;16.65;48.33;37.46;16.48;56.12;46.1;68.64;24.9;17.27;38.42;24.88;12.54;33.24;16.66;34.17;36.65;26.65;26.32;25.02;39.67;24.56;75.68;34.93;60.6;23.6;34.58;13.67;24.54 1997-04-17;15.95;19.42;16.65;48.21;38.08;16.2;55.88;46.78;68.64;24.54;17.02;38.42;25.07;12.51;32.83;17.16;34.23;37.78;26.73;26.03;24.77;39.96;24.53;74.55;33.61;59.44;23.32;34.76;13.61;24.58 1997-04-18;15.98;19.26;16.59;48.33;37.41;16.16;56.95;46.89;69.41;25.5;17.16;38.33;24.58;12.57;33.12;17.05;34.73;38;26.02;26.26;24.65;40.13;26.91;75.12;35.84;60.17;23.09;34.82;13.73;24.9 1997-04-21;15.75;18.82;16.28;47.9;37.47;15.63;56;47.56;69.41;25.44;17.1;38.5;24.14;12.49;32.66;17.21;34.14;37.66;25.43;26.97;25.4;40.07;26.91;75;34.42;60.17;22.98;33.7;13.55;24.94 1997-04-22;16.25;19.5;15.85;48.93;38.69;16.2;59.1;48.4;69.84;26.33;17.78;38.5;24.88;12.57;34.41;17.52;34.79;37.89;26.06;27.79;25.58;41.34;27.66;78.95;34.02;62.92;23.77;35.46;13.55;25.39 1997-04-23;16.3;19.66;15.54;49.24;39.64;16.16;57.55;47.39;71.27;26.15;17.55;38.42;24.33;12.68;34.47;18.19;35.38;37.44;25.58;27.32;25.58;40.65;28.78;77.6;32.91;61.39;23.43;36.52;13.67;25.67 1997-04-24;16.28;20.26;15.17;49.42;38.8;15.88;57.31;45.71;70.39;25.85;17.47;37.82;24.76;12.6;32.66;18.17;38.17;37.89;25.39;27.38;25.64;40.36;28.53;77.71;33.61;60.17;22.92;35.34;13.43;25.39 1997-04-25;16.25;19.62;15.42;49.48;38.75;15.8;56.47;46.22;69.84;25.14;17.45;37.4;24.39;12.4;33.3;17.89;37.46;37.55;25.39;27.38;25.4;40.48;28.41;77.04;31.9;59.44;23.49;35.23;13.24;25.1 1997-04-28;16.01;20.59;16.16;46.27;39.25;16.24;58.38;45.88;70.94;25.67;17.57;37.65;24.27;12.49;33.12;18.2;37.37;37.89;26.1;28.03;25.71;41.11;28.72;77.94;32;60.96;24.06;34.7;13.55;25.18 1997-04-29;16.3;21.47;16.41;46.69;39.08;17.77;59.82;47.84;73.14;26.51;18.13;39.1;25.44;12.6;33.41;18.65;39.35;37.66;26.91;28.26;26.27;42.39;29.75;78.39;31.7;62.49;25.02;35.05;13.55;26.2 1997-04-30;16.39;21.11;16.53;47.84;39.58;17.94;60.77;47.45;73.03;26.98;18.19;39.44;25.87;12.76;33.77;19.04;39.88;38.12;27.4;28.79;26.58;41.87;30.38;78.5;31.8;61.52;25.13;35.58;13.73;26.52 1997-05-01;16.25;21.07;16.71;48.03;40.36;17.45;59.34;46.16;72.7;26.63;17.98;39.18;25.75;12.62;34.12;19.12;40.1;38.57;27.58;28.09;26.2;41.23;30.25;78.61;31.7;61.45;24.9;35.64;13.79;26.28 1997-05-02;16.48;21.63;16.59;48.75;41.53;17.65;61.13;48.01;71.71;26.87;18.54;38.84;26.79;12.65;34.58;19.6;40.29;38.79;28.36;28.91;26.45;42.16;30.19;79.07;32.2;62.37;25.19;35.87;13.85;26.08 1997-05-05;16.57;22.23;16.65;48.51;42.53;18.22;63.04;48.28;72.81;27.88;19.09;39.27;27.22;13.01;35.28;20.21;41.28;40.82;28.85;29.38;27.07;42.39;30.05;81.32;35.63;63.59;25.75;36.4;13.85;26.64 1997-05-06;16.98;21.95;16.47;48.87;41.97;18.38;63.52;49.29;73.36;27.94;19.13;39.95;26.73;13.06;35.17;19.65;41.12;40.94;29.22;28.97;27.07;42.62;29.33;81.43;33.72;64.69;25.64;36.93;13.85;26.68 1997-05-07;16.54;21.19;16.1;47.54;41.08;17.57;62.44;47.84;71.6;27.64;18.97;39.18;26.48;12.98;34.64;19.38;40.29;40.15;28.36;28.44;26.7;41.46;28.88;80.98;33.31;63.84;25.02;36.4;13.79;26.12 1997-05-08;16.77;21.51;16.04;47.24;41.92;18.06;61.73;47.95;71.16;27.64;19.03;38.67;26.05;12.65;34.76;19.74;41.59;40.82;28.51;28.26;26.95;41.11;29.09;82.22;33.82;63.59;25.58;36.4;14.28;26.36 1997-05-09;16.74;21.99;16.16;47.48;42.97;17.77;62.44;48.4;72.04;27.52;19.09;39.44;26.67;12.79;34.47;19.83;41.62;40.37;29.11;28.79;26.39;41.81;29.19;82.56;34.02;64.57;25.53;36.64;14.16;26.68 1997-05-12;17.1;22.31;16.22;48.27;42.8;17.98;63.52;49.46;72.92;28.18;19.62;40.04;28.02;12.9;34.76;19.79;43.11;41.39;29.44;29.21;26.33;42.91;29.53;83.35;34.22;65.43;25.81;36.87;14.52;27.41 1997-05-13;17.24;21.91;16.22;48.69;43.19;18.14;63.52;48.62;72.26;28.41;19.91;39.01;27.72;13.04;35.11;18.95;43.14;42.29;28.88;29.32;25.83;42.85;29.44;82.56;34.22;64.82;25.75;36.7;14.65;27.13 1997-05-14;16.98;21.95;16.22;48.33;42.64;18.22;63.99;49.57;72.15;28.53;19.95;38.49;27.9;12.84;35.58;18.99;43.21;42.18;29.26;28.85;25.95;42.91;28.97;83.58;34.32;63.78;25.64;37.11;14.71;27.13 1997-05-15;17.21;22.03;16.34;48.45;43.75;18.1;64.83;49.57;72.04;28.06;20.32;38.49;29.01;12.93;35.87;19.66;43.21;42.18;28.88;29.09;25.95;43.37;29.28;85.27;34.42;65.37;25.92;36.7;14.89;26.89 1997-05-16;17.18;21.63;16.53;47.9;43.81;17.86;63.88;48.67;70.28;27.7;19.83;38.15;25.99;13.12;35.76;19.29;42.24;41.84;27.84;28.48;25.83;42.27;28.86;84.03;34.22;63.9;25.98;36.46;14.59;26.24 1997-05-19;17.27;22.03;16.47;47.18;43.58;18.02;64.95;49.01;70.17;28.18;19.99;38.4;26.05;13.15;35.35;19.24;41.93;42.29;27.55;28.95;25.89;42.68;28.78;82.45;34.73;64.51;26.04;35.87;14.89;27.01 1997-05-20;17.07;22.71;16.84;48.51;43.14;18.62;65.31;49.85;71.16;28.18;20.48;39.52;26.05;13.37;35.29;20.02;43.17;42.63;28.7;28.78;25.46;43.14;29.78;82.79;34.42;65.31;26.21;36.23;14.89;27.09 1997-05-21;16.95;22.31;17.02;49.72;43.03;18.06;64.35;49.46;71.05;28.35;20.24;38.83;26.61;13.39;35.64;20.21;43.52;42.4;27.69;28.07;25.27;43.02;30.09;82.47;35.94;65.86;25.75;36.37;14.65;26.64 1997-05-22;16.89;22.11;17.45;48.69;43.36;17.94;63.52;48.95;71.6;27.88;19.99;38.92;25.87;13.48;35.17;20.07;42.86;43.19;28.14;28.13;25.27;42.33;30.16;81.91;36.14;66.84;25.3;36.73;14.52;26.64 1997-05-23;17.3;22.31;17.82;48.63;43.36;18.26;65.07;49.35;72.7;28.53;20.11;39.52;25.93;13.42;35.93;20.29;43.08;43.42;28.29;28.3;25.4;43.08;30.72;83.61;36.64;67.51;25.75;37.2;14.71;27.01 1997-05-27;17.54;22.23;18.5;49.36;43.42;18.1;65.43;50.25;74.24;28.41;19.95;39.86;26.3;13.37;35.64;21.05;44.54;43.76;27.73;28.3;25.58;43.26;31.66;82.59;35.53;67.57;26.09;37.44;14.59;27.17 1997-05-28;17.24;22.27;18.26;50.27;43.53;17.98;64.23;49.18;73.25;28;19.99;39.69;26.18;13.59;35.99;20.78;44.79;43.99;27.84;28.07;25.09;42.62;31.47;84.4;35.43;67.26;26.26;37.73;14.65;27.21 1997-05-29;17.27;22.11;17.95;51.12;43.47;17.65;64.47;48.79;73.53;28;20.03;39.01;25.75;13.89;36.11;20.36;43.61;44.1;27.62;27.83;24.77;42.16;31.47;84.06;35.63;66.77;25.98;38.26;14.71;26.89 1997-05-30;17.27;22.31;18.13;51.12;43.42;17.77;65.43;48.84;73.2;28.24;19.79;39.43;25.38;13.89;35.99;18.84;42.99;43.42;28.1;28.36;24.96;41.63;31;83.38;35.53;67.45;26.49;37.97;14.59;26.56 1997-06-02;17.24;22.15;17.58;51.12;43.47;17.73;64.59;48.5;73.2;28.59;19.87;39.18;26.11;13.83;35.58;18.62;43.3;43.99;28.1;28.07;24.22;41.69;31.09;82.47;34.52;65.37;26.43;37.38;14.83;26.24 1997-06-03;17.51;22.39;17.7;50.88;43.19;18.02;64.83;48.62;73.86;28.53;19.87;39.09;25.56;13.81;35.7;18.03;41.93;43.65;28.85;28.25;24.15;41.69;30.19;82.93;34.22;65.67;26.38;38.26;15.07;26.16 1997-06-04;17.33;21.99;17.33;51.91;43.64;17.86;63.64;48.45;73.53;28.59;19.95;38.92;25.44;13.92;35.58;17.72;41.44;42.97;28.74;28.07;23.78;41.34;29.8;81.45;33.72;65.18;25.92;38.03;15.07;25.91 1997-06-05;17.48;22.27;17.52;52.39;44.19;18.14;63.52;48.73;73.97;28.65;19.75;39.01;25.07;14.19;35.76;17.8;41.19;44.44;29;28.01;23.72;41.54;30.14;82.59;34.52;65.18;25.47;38.32;15.14;26.2 1997-06-06;17.54;23.03;17.64;53.3;44.53;18.7;64.71;49.8;75.07;29.19;20.4;38.92;25.75;14.38;36.81;18.15;42.55;44.67;29.85;28.42;23.84;42.94;31.02;83.95;34.42;66.65;26.72;38.79;15.32;26.4 1997-06-09;17.1;22.83;17.76;54.33;45.31;18.91;65.43;49.91;74.3;29.31;20.61;39.26;26.3;14.38;36.64;18.56;43.17;44.33;29.03;29.13;24.15;43.52;31.28;84.18;34.62;68;26.21;39.27;15.56;26.28 1997-06-10;17.48;22.95;17.89;55.79;46.08;19.39;65.31;49.97;74.08;29.07;20.73;39.69;25.87;14.55;37.16;18.05;42.86;45.12;29.7;29.25;24.28;43.75;31.2;85.88;34.52;68.18;26.21;39.56;15.32;26.56 1997-06-11;17.98;23.07;18.01;55.06;46.03;19.71;65.44;51.2;70.33;29.55;20.85;39.43;25.68;14.66;37.63;18.34;43.3;45.69;29.55;30.2;24.71;44.57;31.75;85.65;34.83;68.3;26.04;39.56;15.32;26.4 1997-06-12;18.24;23.47;18.32;55.79;47.03;20.32;67;51.99;71.54;30.32;21.34;39.09;25.87;14.91;38.45;17.86;43.8;46.59;29.96;30.96;24.84;45.44;31.75;89.28;36.27;70.14;26.72;40.15;15.44;26.48 1997-06-13;18.21;24.6;18.63;55.67;48.36;20.56;68.79;52.94;70.77;30.38;21.67;39.35;26.24;14.88;38.16;18;44.23;46.25;30.15;31.38;24.96;45.9;32.41;89.62;37.7;69.89;27.45;40.62;15.62;27.09 1997-06-16;18.04;24.16;18.87;56.15;47.97;20.2;68.55;53.73;71.21;30.68;21.79;39.52;26.12;14.63;38.57;18.31;44.35;46.25;30.33;31.32;24.71;45.61;32.84;88.71;37.19;69.22;27.45;40.92;16.05;27.21 1997-06-17;17.95;24.52;18.75;55.06;47.97;20.56;68.55;53.73;71.08;30.32;21.79;39.18;26.48;15.07;38.45;18.61;44.67;45.12;30.45;30.73;24.34;45.44;33.55;90.76;37.6;68.3;27.62;40.74;16.29;27.25 1997-06-18;17.83;25;18.5;54.94;47.92;20.89;68.31;53.51;69.44;30.2;21.71;39.01;26.12;14.82;38.92;18.22;44.23;44.67;30.63;30.37;24.4;44.86;32.55;90.64;37.09;67.87;27.28;40.8;16.14;26.77 1997-06-19;17.83;24.96;18.69;54.82;47.86;20.93;68.43;54.97;70.55;29.96;22;38.49;26.55;15.24;38.39;18.21;44.54;46.03;30.63;31.08;24.71;46.43;32.33;90.64;38.72;69.53;27.45;40.68;16.14;27.05 1997-06-20;17.83;25.24;18.38;55.18;47.64;21.33;68.31;54.74;69.66;30.26;22.16;38.23;27.1;15.21;39.27;18.25;44.67;45.57;30.52;31.14;24.84;46.54;32.47;92.68;37.09;68.55;27.4;41.22;16.51;26.68 1997-06-23;17.42;24.36;17.89;53;46.86;20.52;66.76;53.17;68.23;29.43;21.47;37.97;26.67;15.02;38.45;18.05;43.61;44.44;29.78;30.25;24.15;45.9;32.02;90.76;34.85;66.96;27.11;39.62;15.96;26.16 1997-06-24;17.64;24.78;18.22;53.42;48.2;20.8;67.3;55.31;68.45;29.78;21.73;39.01;27.29;15.36;39.39;18.4;45.63;46.14;29.89;31.38;24.65;48;33.02;91.66;36.02;67.32;27.51;40.15;16.42;26.77 1997-06-25;17.45;24.24;18.26;53.12;47.64;20.72;66.46;55.25;68.45;29.04;21.43;38.49;26.95;15.17;39.21;18.24;45.66;45.46;29.65;30.82;24.03;47.85;32.61;91.89;35.2;66.59;26.63;39.68;15.99;26.6 1997-06-26;17.68;24.12;17.82;52.15;46.97;20.44;66.88;54.97;68.78;29.16;21.34;38.06;26.61;14.91;38.69;17.87;45.04;45.01;29.24;30.2;24.28;47.36;32.06;92.57;34.9;66.77;27.23;39.89;16.14;26.46 1997-06-27;17.83;24.3;17.67;51.42;48.03;20.6;67.95;54.97;69.33;28.8;21.4;38.36;26.89;15.04;39.39;17.69;45.35;44.5;29.03;30.43;24.15;47.71;31.88;92.57;34.85;68.15;27.14;39.86;15.99;25.93 1997-06-30;17.68;23.92;17.3;51.48;47.75;20.38;65.08;56.54;67.79;29.19;21.3;38.32;27.59;15.18;39.39;17.63;44.85;44.04;28.87;30.43;24;47.62;31.59;92.8;36.07;69.1;28.02;39.21;16.54;26.04 1997-07-01;17.92;24.31;17.95;52.45;46.81;20.93;65.68;56.37;68.12;30.14;21.79;38.75;27.04;15.15;39.48;17.29;45.63;45.4;29.78;29.84;24.15;48.43;31.23;91.44;35.76;68.3;27.57;39.59;16.6;25.49 1997-07-02;18.36;24.51;17.73;53.18;47.7;21.61;67.42;56.15;68.78;30.08;22.14;39.09;27.25;14.93;40.47;17.78;46.44;45.69;30.68;29.99;24.03;48.7;32.09;91.44;35.87;69.28;27.59;39.8;16.88;24.94 1997-07-03;18.06;26.72;17.76;53.54;48.5;21.55;67.72;56.99;69.72;30.8;22.74;39.13;27.78;15.21;41.15;18.02;47.12;45.91;30.9;30.34;24.22;48.96;32.39;92.4;36.99;70.44;27.9;40.62;17.34;25.06 1997-07-07;18.36;25.24;18.07;53.91;48.14;21.83;66.88;56.37;70.05;30.17;22.9;38.83;28.02;15.26;40.33;18.32;46.96;46.42;30.83;30.61;24.12;48.17;32.38;91.95;36.48;70.5;28.1;40.68;17.21;24.66 1997-07-08;18.72;25.2;18.01;54.45;49.36;21.61;67.54;58.51;71.1;30.29;22.78;38.96;28.46;15.1;40.97;18.6;47.59;50.9;30.83;30.96;24.22;48.38;32.81;93.54;36.22;73.07;28.19;40.62;17.12;25.33 1997-07-09;18.27;24.99;17.58;54.57;49.23;21.33;66.4;56.77;70.21;29.52;22.43;38.36;28.58;14.69;39.8;18.98;47.8;49.83;30.49;30.11;23.87;47.1;32.69;93.19;35.41;72.98;27.37;39.83;16.45;25.04 1997-07-10;18.25;25.28;17.64;53.66;50.17;21.57;66.64;57.39;68.89;29.46;22.78;38.62;28.73;14.69;40.06;18.67;47.59;52.6;30.34;29.49;24.28;46.78;32.47;93.25;35.36;73.07;28.22;40.15;17.15;24.98 1997-07-11;18.09;25.72;17.33;54.82;51.09;21.39;66.82;56.88;68.67;29.43;23.15;37.8;30.06;14.81;40.77;19.13;47.59;52.04;30.55;29.81;24.81;47.24;32.44;93.76;35.3;72.83;27.62;40.03;17.34;24.84 1997-07-14;18.2;25.36;17.42;55.42;49.92;21.07;66.76;56.04;68.17;28.95;23.27;37.97;32.06;15.1;40.71;19.58;47.34;54.13;30.53;29.75;25.12;46.83;33.98;93.93;34.85;72.55;26.97;40.03;17.46;25.15 1997-07-15;18.68;25.82;17.27;56.33;49.36;21.41;67.12;55.42;67.9;29.66;23.66;37.29;33.63;15.22;41.41;20.12;47.71;53.06;30.7;29.19;24.74;46.81;34.62;93.02;34.69;74.63;26.8;40.68;17.49;25.33 1997-07-16;18.99;25.4;17.92;57.91;50.42;22.14;67.84;56.77;60.39;29.9;24.25;37.37;33.94;15.57;42.2;21.98;48.52;54.3;30.75;29.31;24.81;45.85;37.11;92.57;35.3;75.09;26.68;41.19;17.52;25.63 1997-07-17;19.34;25.05;17.27;55.06;50.09;21.89;66.88;58.9;58.51;29.96;23.99;37.93;32.77;15.53;41.62;21.84;49.51;54.36;30.9;29.49;24.96;49.69;37.38;90.3;34.24;74.88;25.8;40.89;17.37;25.27 1997-07-18;19.02;24.49;16.96;54.39;48.58;21.51;66.28;55.98;58.51;28.8;23.31;37.8;32.09;15.39;41.62;21.5;51.93;53.34;30.53;28.45;24.81;49.51;35.12;89.28;33.42;72.77;25.74;40.03;17.12;24.66 1997-07-21;18.97;25.05;16.9;52.76;50.7;21.25;65.38;56.65;59.62;29.22;23.15;38.49;31.97;15.22;42.61;21.31;51.56;52.09;30.53;28.69;24.9;48.7;33.98;89.45;33.01;73.13;25.8;40.06;17.49;24.43 1997-07-22;19.53;25.26;17.73;54.7;50.2;21.92;67.12;59.52;60.67;29.96;23.56;39.69;32.55;15.57;42.76;22.07;51.19;53.57;31.58;29.75;25.27;49.42;36.03;91.04;34.74;74.3;26.8;40.74;17.67;25.23 1997-07-23;19.94;25.48;17.58;57.3;49.75;22.08;66.1;60.81;60.72;29.28;23.66;40.55;32.43;15.39;43.26;22.21;52.24;54.02;31.73;29.61;25.8;48.73;35.36;89.39;34.64;74.36;26.82;40.57;17.86;25.33 1997-07-24;19.71;25.64;17.58;58.21;49.14;22.86;67.18;60.36;60.17;29.55;23.56;40.12;31.94;15.68;43.61;22.32;53.58;53.68;32.06;29.25;26.08;48.29;34.5;86.79;35.81;75.09;26.37;40.45;18.1;25.78 1997-07-25;19.78;25.62;17.7;57.12;50.76;22.52;67.12;60.25;59.23;29.93;23.7;39.09;32.27;15.66;43.93;22.18;53.18;51.81;31.74;29.1;26.45;47.94;34.62;85.88;36.43;75;26.54;40.27;18.77;25.67 1997-07-28;20.25;25.4;17.95;56.33;51.43;22.5;66.7;60.2;59.99;30.2;23.45;40.21;32.64;15.8;43.82;22.02;52.18;51.19;31.8;28.63;26.7;46.83;34.25;86.44;36.58;73.99;26.94;39.92;18.87;25.88 1997-07-29;20.19;26.54;18.23;56.82;53.38;23.07;66.7;60.48;59.62;29.9;23.25;40.85;32.61;15.96;43.84;21.92;51.13;51.92;32.59;28.87;26.67;47.82;34.98;87.64;36.78;73.56;26.97;40.21;18.47;26.04 1997-07-30;20.63;26.66;18.26;56.94;53.16;23.19;66.88;60.93;60.33;30.47;23.19;41.15;33.41;16.17;43.87;22.23;52.68;52.32;33.67;29.13;27.17;48.41;35.28;86.27;37.44;74.91;27.34;40.21;18.53;26.3 1997-07-31;20.76;26.97;18.16;56.94;50.03;23.25;66.16;60.31;59.17;30.62;22.98;42.53;34.49;16.44;43.26;22.83;52.55;50.9;33.99;29.37;26.7;48.35;35.34;85.99;36.78;74.42;27;39.95;18.35;26.26 1997-08-01;20.53;26.77;18.38;56.76;52.65;22.93;65.68;60.14;60.06;30.32;22.65;44.29;33.97;16.23;43.11;23.28;52.06;52.38;33.62;28.87;26.11;47.71;35.16;85.54;36.68;74.05;26.63;39.65;17.95;26.18 1997-08-04;20.47;26.72;18.47;56.7;52.6;22.5;65.98;60.36;60.22;30.5;22.29;43.04;34.34;16.38;43.32;24.06;52.8;51.75;33.22;28.81;26.3;48;35.39;86.39;36.43;73.01;26.8;40;18.53;26.3 1997-08-05;20.64;26.66;18.75;56.39;52.26;22.58;65.08;61.38;60;30.29;22.2;43.3;34.74;16.54;43.02;24.79;52.93;51.3;32.79;29.04;25.86;47.94;35.83;86.73;36.12;72.4;26.45;39.56;18.41;25.98 1997-08-06;20.69;27.17;19.27;56.58;52.26;22.62;65.2;61.83;60;30.92;22.72;43.82;34.68;16.5;43.46;24.88;53.61;52.21;33.48;29.43;26.02;47.47;35.86;87.01;37.14;72.77;26.57;40.12;18.77;26.26 1997-08-07;20.88;26.7;19.8;57.36;54.22;22.18;63.71;62.05;59.29;30.56;22.37;43.95;34.37;16.54;43.46;24.88;53.36;51.7;32.62;28.69;25.99;46.43;35.98;87.07;36.68;71.73;26.45;39.83;18.62;25.71 1997-08-08;20.39;25.9;19.95;56.76;52.15;21.37;60;60.7;58.84;29.55;21.98;43.13;34.03;16.01;42.2;24.32;52.31;50.45;32.16;28.04;25.61;45.99;35;86.05;36.37;70.38;26.31;38.82;18.13;25.73 1997-08-11;20.19;26.46;20.6;57.3;52.93;21.77;59.1;60.98;57.96;29.96;22.16;42.18;33.88;16.25;42.79;23.9;51.19;51.98;32.55;27.57;25.64;44.33;34.56;86.27;37.24;71.7;26.45;38.76;18.1;25.88 1997-08-12;20;26.08;20.04;55;52.32;21.29;58.32;60.08;57.3;29.78;21.69;42.1;33.57;16.19;42.15;23.7;51.41;51.58;32.62;27.21;25.4;43.58;34;85.76;37.09;69.68;26.63;38.5;17.58;25.47 1997-08-13;19.88;26.48;19.58;56.33;52.99;21.96;57.85;58.45;57.41;28.95;21.88;42.27;33.44;16.17;41.35;23.97;51.87;52.04;33.3;26.98;25.05;43.11;34.02;85.2;36.58;69.34;26.23;38.35;18.07;25.67 1997-08-14;19.72;26.62;19.64;56.21;53.1;22.06;57.49;57.15;55.75;28.77;21.88;42.23;34.43;16.03;41.3;23.84;51.5;52.15;33.32;27.89;25.55;43.43;34.06;85.99;37.75;70.66;26.14;38.26;17.52;25.63 1997-08-15;19.2;25.96;19.27;53.79;51.87;21.29;56.23;55.74;55.86;28.12;20.77;41.36;32.55;15.72;40.39;22.91;49.67;50;32.89;26.6;24.84;42.3;33.22;83.04;36.78;66.8;25.66;37.64;17.15;24.9 1997-08-18;19.69;25.92;19.98;54.33;52.15;21.57;57.79;57.6;56.3;29.64;21.59;42.27;31.44;15.84;39.89;23.52;51.69;49.09;32.92;27.55;24.9;43.4;33.47;83.27;36.63;66.1;25.77;38.14;17.46;25.55 1997-08-19;20;26.66;19.92;55.67;53.21;22.02;58.2;58.96;56.19;29.66;21.75;43.74;31.84;16.32;40.48;24.35;53.64;49.6;33.37;28.06;24.71;44.1;34.7;84.35;36.22;67.94;25.46;38.62;17.55;25.9 1997-08-20;20.01;26.89;19.86;55.54;54.44;22.26;58.86;60.54;59.73;30.2;22.24;43.96;32;16.71;40.98;24.99;53.67;50.85;34.27;28.26;24.81;44.57;35.14;85.12;37.29;68.98;25.48;38.65;18.19;26.12 1997-08-21;19.97;26.28;19.71;54.82;53.71;21.77;57.96;59.58;58.84;29.69;21.61;43.87;31.54;16.4;40.25;24.46;52.55;49.83;34.16;28.06;24.65;44.1;34.47;83.52;36.48;67.45;25.51;38.29;17.95;25.63 1997-08-22;19.95;26.38;19.86;53.97;52.93;21.59;58.08;59.29;58.95;29.9;21.26;44.91;31.47;16.17;40.57;23.92;52.87;49.03;34.12;27.85;24.71;43.93;34.31;84.43;36.12;67.75;25.26;37.82;17.73;25.39 1997-08-25;20.34;26.1;19.8;53.85;53.38;21.41;57.13;59.18;58.57;29.69;21.02;45.87;30.86;16.25;40.13;23.42;52.18;49.77;34.03;27.4;24.5;43.52;34.12;84.6;36.63;66.65;25.03;37.64;17.98;25.45 1997-08-26;20.17;25.68;19.67;52.76;52.37;20.97;56.47;58.79;57.91;29.43;20.73;45.04;30.73;15.96;39.8;23.05;51.34;49.6;33.75;27.14;24.09;42.65;33.75;83.75;36.88;67.02;24.94;37.19;17.64;25.19 1997-08-27;19.75;25.78;19.77;53.66;53.66;20.76;56.11;58.17;59.62;30.14;20.56;44.48;30.8;15.92;39.54;23.39;51.62;48.74;34.01;27.52;23.97;43.23;33.64;83.52;36.99;66.65;25.29;37.34;17.58;25.51 1997-08-28;19.8;25.22;19.54;53.48;51.65;20.68;55.75;57.09;58.4;29.49;20.48;44.18;30.09;15.74;39.33;22.97;50.26;48.92;33.6;27.05;23.22;42.82;33.02;83;35.97;65.98;24.91;37.28;17.4;25.27 1997-08-29;19.35;25.03;19.24;52.88;51.87;20.52;54.85;56.3;58.12;29.16;20.5;43.48;30.3;15.57;38.83;22.91;50.38;48.06;33.28;26.9;23.5;42.73;33.05;82.03;35.61;65.12;24.8;37.02;17.37;24.96 1997-09-02;20.04;25.78;19.98;55.3;52.21;21.61;57.31;58.62;59.9;30.5;21.69;45.22;31.1;16.05;40.45;23.64;51.72;49.43;34.05;27.7;23.47;44.54;34.3;83.57;36.94;67.51;25.46;37.99;18.44;25.67 1997-09-03;19.76;25.78;19.64;55.73;53.44;21.89;56.47;57.54;61.56;30.56;21.96;45.22;31.47;16.67;41.16;23.33;51.47;49.2;34.18;27.49;23.28;44.86;34.14;84.32;37.14;67.08;25.74;38.76;18.59;25.86 1997-09-04;19.62;25.88;19.67;54.57;50.36;21.81;57.07;57.26;61.56;30.62;21.81;45.39;31.87;16.67;41.45;23.53;51.56;49.09;34.31;27.85;22.97;44.57;34.55;84.43;36.43;66.74;26.06;38.76;18.62;25.25 1997-09-05;19.65;25.88;19.71;53.73;50.81;21.81;57.31;55.96;61.12;30.5;21.71;45.74;32.06;16.58;40.69;23.52;51.5;49.26;34.27;27.58;23.1;44.66;34.33;83.86;36.17;65.06;26;37.7;18.5;25.41 1997-09-08;19.31;26.12;19.83;53.36;50.36;21.83;56.59;56.13;61.45;30.62;21.94;45.52;32.74;16.58;40.72;23.86;51.13;48.74;34.64;27.28;23.22;43.78;34.83;84.03;35.97;65.37;26;37.76;18.74;25.31 1997-09-09;19.44;25.82;20.08;52.51;49.42;22.02;56.23;57.71;60.79;30.74;21.88;46.47;33.26;16.54;41.13;24.31;49.7;48.8;34.61;27.37;23.04;44.16;34.88;84.09;36.53;65.46;26;37.67;18.9;25.51 1997-09-10;19.12;25.44;20.69;51.3;47.74;21.37;55.15;57.04;59.9;29.99;21.61;46.52;32.98;16.42;40.01;23.75;48.21;48.74;33.84;26.66;22.91;43.23;33.78;82.21;35.61;63.32;25.91;36.96;18.41;25.27 1997-09-11;18.84;24.87;21.22;50.15;47.91;21.01;53.85;56.64;58.79;29.61;21.3;46;32.58;16.77;39.63;23.69;48.7;47.26;33.33;26.87;23.22;43.2;34.2;82.21;34.65;64.33;25.83;36.69;18.65;24.62 1997-09-12;18.5;25.01;21.12;51.36;48.24;21.41;54.75;56.81;58.23;30.05;21.71;46.08;33.01;16.75;40.22;23.44;48.58;47.09;33.82;27.28;23.22;43.4;34.48;83.75;35.07;65.31;26.31;37.08;18.96;25.06 1997-09-15;18.85;24.75;21.8;49.91;47.8;21.43;55.23;56.08;53.34;29.9;21.75;47.12;32.15;17.14;40.28;22.89;47.83;47.72;33.67;27.43;22.88;43.81;32.67;81.46;33.88;66.22;26.25;37.25;18.71;25.08 1997-09-16;19.38;26;22.14;50.69;49.75;22.68;56.85;56.3;50.67;30.8;22.47;47.73;33.44;17.64;40.98;23.83;49.51;48.35;34.59;27.88;23.35;45.21;34.09;80.67;34.65;69.89;27.54;38.23;18.71;25.69 1997-09-17;19.09;25.9;21.56;51.66;49.42;22.58;56.67;57.6;50.12;30.8;22.84;47.38;33.01;17.72;41.45;23.79;49.51;50.91;35.21;27.43;23.35;45.83;33.3;81.24;33.93;69.95;26.85;38.47;18.62;25.63 1997-09-18;19.48;25.68;21.8;51.54;50.53;22.86;56.43;58;51.23;31.45;22.98;47.6;33.11;17.7;41.45;23.62;49.08;52.9;35.21;27.4;23.72;45.48;33.06;79.87;33.47;69.59;27.14;39.3;18.56;25.78 1997-09-19;19.54;25.7;21.71;50.81;49.86;22.8;56.79;56.75;53.01;31.36;23;48.2;33.97;17.74;40.16;23.73;49.32;50.05;35.19;27.82;23.75;46.12;33.8;79.13;33.93;69.83;27.54;39.3;18.75;25.98 1997-09-22;19.32;26.12;22.67;51.24;50.53;23.37;57.42;56.84;54.95;30.59;23.04;46.84;34.31;17.69;41.16;23.97;51.62;48.63;35.39;28.59;23.97;48.11;33.33;79.35;34.94;69.46;27.37;40.01;18.82;25.86 1997-09-23;19.32;26;22.02;52.63;49.58;23.29;57.33;56.87;55.12;31.03;22.65;46.08;34.74;17.41;41.22;24.65;51.31;48.97;35.19;28.11;24.12;48.58;33.88;80.38;34.76;68.98;27.65;40.13;18.16;25.67 1997-09-24;18.98;26.16;22.23;53;48.41;22.44;58.17;56.7;54.78;30.59;22.49;45.74;35.23;17.49;40.22;23.78;50.47;48.74;35.41;27.82;24.12;47.35;33.11;79.41;34.4;67.45;27.37;39.3;17.98;25.57 1997-09-25;18.98;25.74;22.17;52.63;47.85;22.16;58.77;56.47;55.51;30.44;21.92;45.13;35.26;17.31;38.98;23.16;50.5;48.97;34.57;27.31;23.75;46.35;33.19;80.15;34.14;67.02;26.74;38.68;17.61;25.88 1997-09-26;18.9;26.28;22.42;52.94;48.3;22.36;59.43;57.04;56.9;30.62;22.39;45.74;35.11;17.43;39.04;23.14;51;49.09;35.13;27.34;23.63;46.82;33.34;82.55;34.04;67.87;26.94;39.06;17.77;25.84 1997-09-29;19.26;26.44;22.3;53.36;48.3;22.12;60.02;56.41;57.23;30.89;22.63;46.3;34.49;17.35;39.69;23.72;52.18;49.94;35.45;27.52;23.91;47.49;33.62;84.26;34.45;68.73;27.54;38.85;18.01;26 1997-09-30;19.29;26.36;21.83;52.82;48.19;22.08;58.53;55.62;57.73;30.53;22.31;46.39;34.28;17.2;39.98;22.96;52.68;50.11;35.32;27.37;23.66;46.73;33.08;84.37;34.19;67.57;28.02;38.41;17.95;26.2 1997-10-01;19.5;26.76;21.83;52.33;49.58;22.4;59.43;56.08;58.67;31.12;22.47;47.08;33.69;17.53;40.39;23.19;51.44;49.83;35.79;27.46;24.03;46.94;33.47;86.14;34.96;69.16;28.39;38.5;18.1;26.65 1997-10-02;19.51;26.92;21.49;50.94;49.08;22.6;60.32;56.19;57.23;30.95;22.78;47.25;34.77;17.47;39.45;23.16;51.96;50.4;36.24;27.79;23.81;47.38;33.3;86.83;35.27;69.77;28.11;38.2;18.07;27.24 1997-10-03;19.15;27.48;21.31;50.45;49.25;23.17;59.84;54.55;56.56;31.06;22.63;46.99;34.49;17.37;39.63;23.21;51.84;49.94;36.89;28.29;23.87;47.17;33.73;86.66;35.43;69.71;28.48;37.76;18.13;27.42 1997-10-06;19;27.93;21.68;51.06;51.15;24.06;60.32;54.44;56.12;31.81;22.9;47.47;34.55;17.47;39.63;23.25;52.09;50.11;37.59;28.38;23.78;47.29;33.78;87.63;35.63;70.44;28.88;37.34;18.07;26.97 1997-10-07;19.32;27.77;22.42;52.21;51.65;24.32;61.22;55.12;56.28;31.84;23.6;47.42;34.49;17.35;39.39;23.69;53.08;50.79;38.02;29.18;23.6;47.9;34.14;90.25;35.07;72.28;29.53;37.22;17.92;27.68 1997-10-08;18.87;27.28;22.94;52.63;51.37;24.1;60.2;55.23;55.78;31.09;23.1;47.34;34.25;17.41;39.39;23.52;52.31;51.31;37.81;28.94;23.53;47.82;34.75;89.45;34.24;71.24;29.05;36.9;17.61;27.3 1997-10-09;18.6;26.92;22.79;52.27;52.15;24.08;59.31;54.78;55.84;30.89;23.15;48.03;33.81;17.84;39.28;23.55;52;51.82;37.78;28.71;23.53;46.82;34.73;88.08;33.93;70.99;29.11;37.31;17.31;27.36 1997-10-10;18.75;26.76;22.6;52.69;52.37;24.08;59.19;55.62;56.45;30.77;22.9;48.51;33.57;17.99;38.81;23.13;52.15;51.71;36.61;28.5;23.25;46.35;34.12;87.45;34.24;71.05;29.42;36.87;17.58;27.2 1997-10-13;18.95;26.78;22.48;53.12;53.44;24.34;58.83;54.89;56.51;30.77;22.74;49.5;33.72;18.05;38.75;23.02;51.93;52.33;36.69;28.77;22.85;46.73;34.19;88.02;34.09;71.18;29.28;36.99;17.49;27.5 1997-10-14;19.06;26.94;22.7;53.18;54.27;24.38;58.29;52.46;57.51;30.77;22.74;48.77;33.54;18.3;39.51;22.83;51.34;51.93;37.06;28.68;22.91;47.47;34.17;90.02;34.09;70.5;29.37;37.79;17.64;28.09 1997-10-15;18.92;26.72;22.14;53.06;53.6;24.14;57.39;52.74;55.78;30.89;22.53;48.81;33.44;18.25;39.1;21.56;50.54;52.22;37.12;28.17;22.91;47.82;33.94;89.11;33.93;70.38;30.26;37.99;17.7;28.28 1997-10-16;18.72;26.84;21.49;50.94;53.15;23.87;56.55;52.41;55.73;30.5;22.72;48.51;32.21;18.48;39.8;21.23;49.64;52.33;37.25;27.94;22.54;45.65;33.48;87.23;33.63;69.28;29.68;37.82;17.49;27.65 1997-10-17;18.66;26.39;22.3;50.33;52.37;23.55;56.13;52.01;55.95;30.32;22.74;48.16;31.78;18.17;38.81;20.64;47.43;52.16;36.61;27.67;22.97;44.31;33.06;86.14;33.42;68.91;29.42;37.64;17;26.89 1997-10-20;18.73;26.72;23.44;51.97;52.76;23.73;56.43;51.05;55.28;30.98;22.98;48.42;32.61;17.99;39.75;20.91;48.45;51.48;36.57;28;23.72;44.28;33.16;85.63;33.47;70.26;29.42;37.88;17.37;27.2 1997-10-21;18.82;27.1;24.55;52.39;52.93;24.3;57.57;52.57;56.12;31.03;23.15;49.42;32.98;18.4;40.92;21.17;52.28;52.33;37.21;28.38;24.15;45.42;34.62;86.37;34.29;71.42;29.85;37.52;17.67;27.24 1997-10-22;19;26.94;24.39;48.39;53.94;24.68;56.91;53.87;55.12;30.92;22.76;49.46;32.95;18.5;37.86;20.87;52.24;52.22;37.44;28.44;24.09;45.48;33.92;91.62;34.35;70.63;30;37.85;17.46;27.04 1997-10-23;18.17;26.52;24.21;47.6;53.04;24.18;55.35;54.27;54.51;30.08;22.08;48.68;32.06;18.15;37.04;20.36;49.88;50.68;36.89;27.76;23.44;44.19;33.91;90.71;33.78;69.22;29.62;36.33;17.21;26.79 1997-10-24;17.98;25.85;24.82;46.99;51.98;23.57;53.25;52.46;54.01;29.84;21.61;47.16;31.47;18.13;36.22;19.89;48.7;48.46;37.19;27.67;23.41;43.67;33.84;87.4;32.55;69.16;29.88;35.21;16.69;26.81 1997-10-27;16.23;24.13;22.33;41.72;47.38;21.01;51.39;48.34;51.62;27.64;20.3;44.35;29.32;16.83;31.63;18.59;44.73;43.39;35.18;26.1;21.89;39.75;32.22;84.2;30.64;64.27;28.99;33.07;15.78;25.31 1997-10-28;16.44;25.1;23.99;46.57;48.67;22.56;55.41;50.71;53.12;29.28;21.79;46.34;31.17;17.59;34.81;21.14;49.39;42.82;36.05;26.57;22.85;41.09;33.34;85.74;32.55;68.61;29.22;32.93;16.94;26.79 1997-10-29;16.81;25.59;23.87;46.02;47.55;22.78;54.81;51.28;53.84;28.74;21.26;47.12;30.36;17.94;34.34;19.96;48.83;43.51;36.18;27.11;22.69;41.47;32.72;85.29;32.49;66.65;29.19;34.14;17.03;26.99 1997-10-30;16.95;24.78;23.75;45.65;46.76;22.44;53.73;50.82;53.06;28.92;20.73;45.74;29.9;17.9;33.57;18.84;47.62;42.25;34.82;26.81;22.17;40.92;32.16;84.09;31.98;65.92;29.34;33.16;17.03;26.24 1997-10-31;17.17;25.18;24.12;46.57;45.98;22.62;54.33;51.39;53.23;29.28;21.18;44.48;30.36;18.4;33.87;19.15;48.95;41;34.73;27.22;22.26;41.74;32.5;83.52;32.6;66.53;29.22;33.19;17.15;26.81 1997-11-03;17.41;25.79;24.64;46.27;46.87;23.07;55.89;54.1;56.23;29.66;22;46.52;31.29;18.98;33.93;19.52;50.5;43.9;35.71;28;22.66;42.32;33.53;84.15;34.19;69.4;29.82;33.64;17.8;27.83 1997-11-04;17.15;25.81;24.3;45.6;46.76;23.57;55.71;52.41;56.01;29.81;22.43;46.21;31.75;18.93;34.63;18.88;50.66;42.59;35.78;28.53;22.88;41.24;33.56;84.77;34.6;70.2;29.91;33.99;17.83;28.07 1997-11-05;17.47;25.91;23.68;44.75;47.72;24.1;55.29;52.35;55.62;29.49;22.65;46.26;32;18.93;34.45;18.56;51.06;42.37;36.01;28.56;23.16;41.09;33.39;84.89;34.14;70.69;29.62;35.09;17.67;27.71 1997-11-06;17.06;25.93;23.65;44.69;46.65;24.32;55.53;52.97;58.06;29.19;22.53;46.08;31.35;18.89;34.87;18.28;50.23;43.45;36.12;28.56;22.85;41.5;33.02;85.12;34.04;70.08;29.14;34.88;18.07;28.11 1997-11-07;16.56;25.51;23.68;44.39;45.7;23.98;54.69;52.52;58.23;28.65;22.2;44.87;30.52;18.77;33.51;19.26;49.45;43.05;35.33;28.38;22.23;41.5;32.89;84.89;33.99;69.4;29.31;34.14;17.77;28.09 1997-11-10;16.53;25.31;23.84;45.24;45.02;23.61;53.49;52.86;58.9;28.44;21.96;45.7;29.81;18.38;33.63;18.68;48.55;43.51;34.32;28.32;22.23;41.39;32.55;85.8;33.78;69.4;29.85;33.79;17.95;27.81 1997-11-11;16.29;25.2;23.81;44.87;43.23;23.33;54.27;54.66;55.28;28.5;22.08;44.43;29.35;18.3;33.81;18.96;49.2;43.22;33.81;28.74;22.69;41.44;32.66;87.85;34.19;70.75;30.86;33.43;18.19;27.99 1997-11-12;15.6;24.98;23.07;45.05;40.15;22.28;54.15;53.59;54.73;28.06;21.55;43.87;28.95;17.97;32.81;18.64;48.02;42.65;32.12;27.7;23.04;40.66;32.3;87.11;33.21;70.14;30.86;32.96;18.59;27.04 1997-11-13;16.07;25.1;24.05;45.9;40.65;22.5;55.11;51.77;53.34;28.53;22.41;43.47;29.6;17.99;33.04;19.38;49.26;42.82;32.27;28.44;23.44;41.12;32.89;86.77;34.4;71.61;30.94;33.9;18.81;27.56 1997-11-14;16.53;24.9;23.68;46.57;41.21;22.82;55.23;52.23;53.28;29.04;22.72;42.77;30.36;18.56;33.87;19.58;50.44;42.88;31.18;29.71;23.25;42.23;33.33;86.48;34.09;73.26;31.32;34.29;19.36;28.21 1997-11-17;16.29;25.26;23.99;48.21;42.28;23.75;57.21;53.59;54.17;29.52;23.33;43.69;30.67;19.1;33.63;20;51.44;43.16;32.76;30.21;23.41;42.73;33.72;86.6;35.12;72.4;31.63;35.18;19.51;28.97 1997-11-18;16.35;24.72;25.9;48.09;41.83;23.33;57.33;54.89;53.78;29.64;22.8;42.86;30.36;18.58;34.05;19.58;50.75;43.16;32.27;30;23.25;42.38;33.5;85.91;34.6;71.67;32.09;34.94;19.24;29.05 1997-11-19;16.32;25.51;26.06;48.51;41.83;23.73;59.61;54.61;53.4;29.58;23.17;42.73;30.12;18.69;35.29;19.66;51.22;43.05;33.51;30.06;23.84;43.4;33.77;86.57;34.81;72.95;32.35;34.88;19.33;29.74 1997-11-20;16.6;25.67;26.92;48.45;41.94;24.72;60.92;55.63;53.84;29.87;23.58;42.99;30.98;18.71;35.76;20.11;52.06;42.82;33.81;30.6;24.15;43.29;34.22;88.92;35.12;74.42;33.15;35.56;19.57;29.52 1997-11-21;16.47;25.45;27.48;48.63;42.78;24.45;61.16;56.77;54.4;30.47;23.84;43.34;31.35;18.89;35.64;19.96;52.46;42.99;34.09;30.93;24.22;44.22;34.47;88.81;35.07;75.09;32.7;35.83;19.6;30.84 1997-11-24;16.29;25.14;26.71;48.15;42.5;24;60.02;55.29;54.17;29.96;23.47;42.6;30.46;18.6;34.64;19.43;51.25;42.59;33.09;30.54;24.34;43.26;33.88;87.83;35.63;74.91;32.06;35.39;19.39;30.47 1997-11-25;16.1;25.08;27.38;49.84;42.67;23.94;61.52;55.4;54.17;29.13;23.84;42.38;30.4;18.65;34.58;19.01;53.36;43.22;32.93;30.48;24.59;43.93;34.75;89.27;35.94;76.07;31.83;35.09;19.39;30.47 1997-11-26;15.88;25.22;27.57;50.33;42.45;23.87;59.98;55.18;54.18;29.16;24.07;41.99;29.9;18.42;35.17;19.06;54.54;43.39;32.57;29.86;24.12;44.02;35.39;89.27;35.84;74.05;33.53;35.45;19.54;30.76 1997-11-28;15.88;25.47;27.57;51.54;43.01;24.66;60.1;55.01;54.29;29.07;24.21;42.56;30.12;18.5;35.05;19.3;54.42;43.51;32.72;29.97;24.09;44.35;35.38;89.44;35.79;74.54;33.36;35.68;19.63;30.9 1997-12-01;15.83;26.7;27.97;52.33;44.13;26.21;62.08;55.86;55.02;29.34;24.25;43.12;30.92;19.31;36.82;20.27;55.94;44.14;34.6;30.81;24.28;44.57;35.95;90.53;36.4;76.25;34.19;36.9;20.03;31.77 1997-12-02;16.08;26.78;27.78;52.39;45.7;26.6;63.34;56.48;54.51;29.16;24.13;43.3;30.4;19.39;36.82;19.41;55.04;45.11;34.3;30.66;24.25;44.48;35.56;90.24;36.51;77.35;33.27;37.14;19.97;31.43 1997-12-03;16.14;27.44;28.19;52.27;45.08;27.39;63.28;57.33;53.84;29.75;23.92;42.6;31.23;19.76;36.53;19.52;54.85;43.05;34.52;30.72;23.97;46.05;36.17;88.41;37.33;77.9;34.42;37.26;20.03;30.98 1997-12-04;16.36;27.75;28.56;50.88;45.53;27.18;62.32;56.65;53.28;29.69;23.76;42.99;31.17;19.47;36.53;19.07;54.29;42.42;35.13;30.66;23.66;49.16;35.64;88.98;37.02;77.54;33.59;37.65;20.12;30.45 1997-12-05;16.48;28.09;28.31;50.81;46.43;27.15;63.52;58.53;52.72;30.5;24.07;44.17;33.38;19.74;37.35;19.29;55.79;41.33;35.26;31.05;23.63;49.1;35.78;88.64;37.38;78.88;32.84;37.38;20.06;30.6 1997-12-08;16.64;28.31;28.52;49.91;46.37;26.96;61.12;58.36;52.27;30.11;24.11;44.56;32.77;19.78;36.59;19.51;56.1;41.27;35.31;31.05;23.6;49.22;36.53;88.12;36.92;78.45;33.21;36.7;19.79;30.72 1997-12-09;16.79;28.35;28.62;49.24;45.36;26.39;61.18;58.19;51.99;29.72;24.46;44.21;31.81;19.57;36.53;18.81;54.85;40.76;34.86;30.96;23.66;49.36;36.08;86.74;36.66;78.21;33.13;36.1;19.63;30.7 1997-12-10;16.88;28.17;28.52;48.45;44.8;26.03;61.42;57.73;51.04;29.9;24.17;44.96;31.41;19.43;35.52;18.57;52.93;38.76;33.77;31.43;23.44;49.28;35.56;86.17;37.02;77.9;33.04;35.51;19.73;30.53 1997-12-11;16.27;27.77;28.19;47.18;44.8;25.39;61.18;56.71;49.81;29.72;23.76;44.17;30.09;19.53;34.23;17.86;50.51;39.33;33.19;31.05;22.85;49.16;34.77;85.25;36.63;78.27;32.09;34.76;19.51;30.21 1997-12-12;15.99;27.97;28.46;47.54;45.53;25.54;62.44;55.35;48.58;29.55;23.68;43.65;30.03;19.72;34.52;17.53;49.88;38.87;33.41;30.48;23.04;49.22;34.19;84.79;37.4;78.88;33.36;34.76;19.57;30.47 1997-12-15;16.38;28.59;28.25;47.48;45.47;26.12;63.34;55.4;48.47;29.93;24.46;44.56;30.18;19.37;33.99;17.94;50.13;40.13;33.77;30.96;22.85;49.57;34.03;85.08;37.09;79;33.96;34.7;20.16;31.61 1997-12-16;16.45;28.92;28.06;49.12;43.79;26.6;63.16;56.43;48.8;30.29;24.7;45.17;31.13;19.41;34.88;17.7;51.56;39.9;33.36;31.11;22.7;50.13;34.77;86.17;37.56;81.57;34.04;34.94;19.97;31.25 1997-12-17;16.97;28.8;28.56;49.06;45.47;27.12;63.34;55.29;50.59;29.9;24.58;44.96;31.13;19.16;34.64;17.28;50.69;40.76;33.7;31.61;22.54;50.42;33.91;77.91;37.2;79.55;34.45;34.79;19.67;31.51 1997-12-18;16.61;28.66;29.17;48.33;43.68;26.72;61.78;52.91;51.94;29.4;24.25;44.39;30.55;19.04;34.28;17.19;49.7;39.16;32.83;31.82;22.35;49.39;32.72;78.88;37.35;77.66;34.88;33.87;19.42;31.67 1997-12-19;16.47;28.07;30.25;47.12;43.17;25.69;62.92;50.98;51.94;28.71;23.92;43.35;30.21;18.65;33.4;17.41;50.75;39.04;32.53;31.55;22.82;48.22;32.17;76.76;37.09;78.15;34.82;33.12;18.96;31.18 1997-12-22;16.51;28.33;31.55;47.3;43.34;25.21;63.52;51.94;51.88;28.74;24.21;44.32;31.1;18.44;33.75;17.77;50.97;38.93;32.14;31.88;23.04;49.78;31.75;77.34;37.35;78.15;34.91;33.45;18.72;31.69 1997-12-23;16.41;27.52;30.47;46.69;42.22;25.42;62.5;51.88;51.6;28.68;23.29;43.95;29.87;18.32;33.52;17.45;49.01;38.99;31.72;31.46;23.04;49.07;30.83;76.65;36.88;76.07;34.04;33.01;18.26;31.73 1997-12-24;16.26;27.61;30.65;46.39;41.77;24.97;62.14;52.91;51.83;28.65;23.29;43.62;29.53;17.97;33.75;17.47;49.26;39.04;31.4;30.99;22.82;47.57;29.73;77.34;36.78;76.37;33.79;32.86;18.26;30.92 1997-12-26;16.17;27.85;31.12;46.39;41.27;25;61.9;52.57;51.27;28.92;23.21;43.9;29.75;17.9;33.81;17.63;50.54;39.16;32.1;30.9;22.45;48.63;30.19;76.7;36.42;75.95;33.13;32.95;18.44;30.94 1997-12-29;16.32;28.01;31.15;46.75;42.28;25.27;63.76;53.42;51.99;29.34;23.74;44.27;30.03;17.94;36.11;17.61;51.06;39.33;32.7;31.11;22.97;49.22;31.58;76.25;36.99;78.09;33.73;33.06;18.62;31.57 1997-12-30;16.5;28.37;30.9;46.93;43.57;26.06;64.48;54.38;53.5;29.69;24.37;45.33;30.33;18.79;36.41;17.83;51.25;40.02;32.98;31.55;23.47;50.13;32.56;76.3;37.4;79;33.99;34.4;19.45;32.22 1997-12-31;16.61;28.89;30.25;47.48;43.51;26.12;64.12;54.55;54.23;29.16;24.05;44.96;30.73;19.43;36.65;17.47;52;39.5;32.94;31.37;23.72;49.81;32.31;75.33;37.56;78.09;33.64;34.67;19.36;32.22 1998-01-02;16.82;28.71;29.02;47.42;43.96;25.93;64.36;55.18;56.97;29.49;24.25;45.15;31.81;19.31;37.29;18.06;52.49;41.39;33.47;30.99;23.66;50.57;32.78;76.65;37.61;79.19;34.42;34.82;19.33;32.43 1998-01-05;17.12;28.77;29.3;47.18;44.58;25.75;63.88;54.84;56.41;29.16;24.68;44.83;31.6;19.04;36.82;18.53;52.9;42.25;34.02;30.96;23.6;50.86;32.59;76.53;38.08;80.78;33.44;34.79;19.51;32.16 1998-01-06;16.73;28.18;29.6;46.45;44.24;25.87;63.58;53.59;57.7;28.12;24.35;43.95;31.69;19.16;37;18.19;52.31;42.42;32.43;30.48;23.66;50.16;32.78;76.76;37.97;80.53;33.3;34.4;19.64;32.04 1998-01-07;16.76;27.92;29.6;46.69;43.45;25.03;63.64;52.17;57.98;29.01;24.56;43.9;31.97;19.37;36.82;18.09;51.81;42.13;32.79;30.78;23.47;49.39;32.39;77.39;38.91;79.68;33.71;34.29;19.58;32.1 1998-01-08;16.05;27.35;30.9;44.99;42;24.36;64.06;51.77;56.75;28.38;24.33;42.28;32.12;19.29;36.35;18.48;51.78;40.99;31.52;31.14;23.04;49.89;32.62;76.48;38.65;78.76;33.39;33.99;19.3;31.84 1998-01-09;15.64;26.54;30.01;43.78;40.76;23.12;61.66;49.39;55.91;27.7;23.74;41.68;30.55;18.6;35.11;17.87;49.73;39.1;30.82;30.78;22.54;48.34;31.75;75.84;37.35;77.17;33.07;32.62;18.75;31.29 1998-01-12;15.61;26.46;30.78;44.02;41.66;22.91;63.52;49.61;56.13;28;24.4;42;30.64;19.18;34.23;18.81;49.76;38.41;31.05;31.4;23.04;49.89;32.38;76.02;38.49;80.53;33.56;33.18;19.39;30.78 1998-01-13;15.58;26.81;32.16;43.72;41.32;24.06;62.86;49.44;54.9;28.62;24.48;42.93;31.47;19.51;34.7;19.13;50.75;39.04;31.35;31.61;23.41;49.92;33.03;77.22;39.74;79.37;33.88;33.78;19.39;30.96 1998-01-14;15.63;26.99;32.38;44.87;41.6;24.36;62.14;50.41;53.28;28.98;24.37;43.39;31.04;19.7;35.76;18.76;51;39.33;31.58;31.67;23.38;51.63;32.78;77.16;39.01;78.82;34.03;34.46;19.48;31.45 1998-01-15;15.57;26.34;31.98;42.81;41.04;24.12;61.3;49.33;52.38;28.35;23.82;43.3;31.54;19.57;34.58;18.73;51.41;38.47;31.24;31.28;23.25;51.07;33.08;75.73;37.35;78.21;34.17;33.75;19.61;31.19 1998-01-16;15.7;26.54;32.07;42.14;40.87;24.57;62.5;50.12;52.78;28.98;24.05;42.56;31.41;19.57;34.28;18.6;52.18;39.96;31.92;32.27;23.63;51.57;33.81;76.42;37.61;77.6;34.31;33.93;19.7;31.33 1998-01-20;16.13;26.69;32.23;42.2;40.59;24.6;63.4;51.32;54.01;29.01;24.76;43.67;31.57;20.05;33.69;18.96;53.86;42.08;32.43;33.01;23.84;54.27;34.45;76.42;36.21;79;34.92;33.99;20.5;32.39 1998-01-21;16.2;26.42;32.13;42.69;42.28;24.24;62.98;51.09;54.01;29.1;24.76;43.35;31.07;20.03;34.28;19.07;49.76;41.62;31.81;32.44;23.53;53.56;34.25;75.61;36.73;79.25;34.69;34.11;19.97;32.23 1998-01-22;15.96;25.92;32.38;43.9;41.1;23.42;62.92;50.81;55.18;28.38;24.64;42.47;30.61;19.64;34.76;19.02;49.39;41.79;31.54;32.03;23.78;52.92;34.66;74.12;34.81;78.15;35.56;35.54;19.64;31.45 1998-01-23;16.32;25.59;32.32;42.99;41.04;23.27;61.36;50.86;55.74;28.15;24.27;42.24;30.37;19.76;34.46;19.2;49.29;40.93;31.24;31.85;23.38;53.06;34.56;74.87;35.43;76.68;34.95;35.56;19.39;32.14 1998-01-26;16.41;25.69;30.44;43.11;41.15;22.81;60.64;52.57;55.85;28.71;24.48;42.28;30.3;19.41;35.05;19.32;48.77;41.79;30.9;32;23.35;53.56;35.44;75.27;34.97;76.8;35.09;37.29;18.99;31.74 1998-01-27;16.51;27.03;31.15;43.66;41.83;23.94;60.82;50.86;57.25;28.77;24.99;42.47;31.23;19.9;34.76;19.69;47.96;41.85;31.85;32.12;23.5;53.8;36.3;73.95;35.02;79.13;35.96;37.59;19.3;33.49 1998-01-28;17.03;26.85;30.62;45.66;43.41;24.3;61.66;52.57;58.71;28.21;24.99;43.85;31.23;19.99;37.12;20.11;48.21;43.51;32.07;31.85;23.66;55.27;37.25;77.57;33.98;77.54;35.58;38.72;19.94;34.22 1998-01-29;17.88;27.11;31.02;46.08;43.75;24.3;62.26;52.57;58.6;28.95;25.28;44.5;29.81;19.99;37.35;20.39;48.8;43.68;32.32;31.85;23.81;55.38;37.06;78.31;34.55;76.31;36.16;39.34;19.73;34.63 1998-01-30;18.03;27.09;30.9;46.21;43.3;24.03;62.26;51.43;58.43;28.27;25.4;42.88;29.63;19.97;36.76;20.14;49.08;41.85;32.43;31.88;23.41;55.15;37.3;76.65;34.45;76.68;35.93;38.69;19.54;34.83 1998-02-02;18.43;28.04;30.99;46.87;45.32;25.27;64.12;53.81;58.43;28.83;25.75;44.78;30.43;20.4;38.24;20.66;49.98;43.62;33.64;32.77;23.66;55.33;38.72;79.75;35.33;77.78;36.34;40.24;20.04;35.46 1998-02-03;18.19;28.14;31.08;46.87;45.55;25.81;64.9;54.44;59.1;28.98;25.42;45.1;29.69;20.71;38.3;21.46;49.39;44.82;34.57;33.1;24.12;54.62;38.97;81.12;35.74;79.55;36.31;40.62;20.62;35.2 1998-02-04;18.06;28.26;31.58;46.02;44.99;25.78;64.48;54.1;58.6;29.34;25.19;45.8;29.81;20.79;38.59;21.78;48.86;43.62;34.64;32.74;24.12;54.03;39.2;80.61;35.17;78.64;36.28;40.3;21.11;35.3 1998-02-05;17.93;28.08;31.39;45.42;44.08;25.69;64.96;54.38;58.04;29.52;25.13;44.41;30.4;20.81;38.71;21.51;49.48;43.05;34.66;32.8;24.09;53.21;38.86;80.32;36.16;77.9;35.56;40.3;21.02;35.3 1998-02-06;18.02;28.04;31.49;45.05;45.78;25.66;64.6;55.18;58.32;29.55;25.46;44.83;30.61;21;38.95;21.77;48.7;43.74;35.38;33.22;24.25;53.68;39.53;80.38;36.78;80.23;35.9;40.39;21.14;35.38 1998-02-09;17.85;27.64;31.18;44.99;47.35;25.75;64.78;55.12;57.98;29.55;25.26;46.58;30.21;20.81;38.89;21.34;48.7;43.74;36.61;32.8;24.37;54.39;39.3;79.97;36.31;79.74;35.7;40.18;20.86;35.1 1998-02-10;18.03;28.08;30.68;47.18;46.57;26.36;65.32;56.88;58.88;29.58;25.4;46.72;31.23;21.12;40.48;21.45;50.13;43.56;36.27;33.22;24.84;55.18;39.81;78.94;36;81.02;35.76;41.43;21.17;35.36 1998-02-11;17.96;28.28;30.38;47.72;46.34;26.24;66.23;56.88;59.72;29.87;25.71;46.95;30.8;21.1;39.83;21.15;51.03;44.14;36.25;32.95;24.93;55.21;39.73;80.66;35.33;81.94;35.3;41.16;21.08;36.12 1998-02-12;18.25;28.69;30.96;47.78;46.9;26.6;66.59;56.88;59.88;30.05;25.73;46.82;30.73;21.49;39.66;21.14;51.13;44.02;36.12;33.23;25.43;55.36;39.69;81.41;35.38;82.12;35.38;41.55;21.94;35.89 1998-02-13;18.24;28.59;31.21;48.87;48.31;26.48;65.93;56.37;59.94;30.08;25.5;46.95;30.49;21.62;40.07;20.84;50.88;44.08;35.76;33;26.33;55.3;39.38;80.78;34.76;82.86;35.35;40.89;21.69;36.32 1998-02-17;18.02;28.81;31.39;50.94;48.59;26.78;65.87;55.91;59.77;29.61;25.58;48.4;30.37;22.03;39.77;21.04;50.69;44.42;36.54;33.21;25.92;56.32;38.59;80.89;35.54;81.45;35.5;41.22;21.97;36.83 1998-02-18;17.67;28.69;31.64;50.21;47.58;27.03;66.47;55.46;59.21;30.41;25.71;48.91;31.1;22.07;40.15;21.62;51.06;44.6;36.86;33.68;26.08;58.38;38.66;81.17;35.02;82.55;35.87;41.22;22.34;37.44 1998-02-19;17.44;28.06;31.39;49.3;46.79;26.72;66.11;54.71;58.21;30.32;25.5;49.01;32;22.15;39.97;22.52;51.06;43.96;36.2;33.71;25.83;57.44;38.72;80.82;34.34;80.72;35.56;40.83;22.21;37.22 1998-02-20;17.14;28.49;30.59;48.63;47.47;27.18;66.89;54.54;59.04;30.65;25.62;49.33;32;22.11;39.92;22.83;51;44.31;36.25;33.47;26.3;58.59;38.78;81.23;34.71;81.57;35.53;41.19;22.28;37.28 1998-02-23;16.78;28.73;30.96;49.18;46.96;26.96;66.53;54.2;58.54;29.78;25.46;49.47;31.72;22.63;39.86;23.42;51.13;43.73;36.67;34.4;26.27;61.38;40.81;79.44;34.29;81.88;35.38;41.01;22.67;37.17 1998-02-24;16.8;28.28;30.59;48.81;47.41;26.69;65.69;53.52;58.21;29.9;25.15;51.1;30.83;21.49;39.26;22.97;50.94;43.27;36.23;34.94;25.77;60.11;41.06;78.28;34.19;81.14;34.72;40.53;23.01;36.48 1998-02-25;17.04;28.81;30.5;49.72;47.92;27.15;65.99;54.6;58.76;29.93;25.28;51.15;31.84;21.97;39.92;23.38;52.31;43.62;37.03;35.47;26.02;59.61;42.47;78.75;34.03;81.63;35.3;41.82;23.41;36.26 1998-02-26;17.14;28.85;30.78;52.33;47.97;27.15;66.23;56.31;57.08;30.05;25.24;50.92;32.03;21.55;40.57;22.96;52.43;43.22;37.44;35.53;26.76;59.2;42.75;79.67;35.38;81.69;35.27;42.98;23.2;35.85 1998-02-27;17.41;29.15;30.1;52.63;49.21;26.96;65.99;55.97;59.16;30.38;25.48;51.43;33.01;21.08;40.33;22.3;51.9;42.93;37.54;36.01;27.1;59.94;42.38;78.8;36.11;83.04;34.95;42.68;22.74;36.48 1998-03-02;16.81;29.66;30.04;51.18;48.31;26.6;65.38;57.11;60.85;30.26;25.09;52.88;32.15;21.33;40.15;21.79;50.66;44.31;37.44;35.71;26.42;59.58;41.66;82.21;36;80.72;35.56;43.07;23.01;35.65 1998-03-03;17.16;30.06;30.62;50.81;47.41;26.96;65.56;57.34;60.85;30.62;25.32;52.64;31.78;21.25;40.15;21.22;50.75;44.19;37.92;35.59;26.61;59.58;42.25;81.98;36.37;80.47;35.38;43.1;23.78;35.85 1998-03-04;17.01;29.74;30.41;51.72;46.96;26.72;66.11;56.77;59.95;30.23;25.01;54.46;30.8;21.27;39.97;21.5;49.2;44.65;37.05;35.03;26.76;58.88;41.16;83.02;35.8;80.35;35.06;42.65;23.78;34.83 1998-03-05;16.8;29.66;29.94;50.69;46.17;26.96;66.65;56.08;58.32;29.99;25.03;53.95;30.52;21.22;39.32;18.79;49.17;44.08;36.46;34.52;26.54;58.32;40.03;82.15;35.33;78.94;34.72;42.41;23.99;34.28 1998-03-06;16.99;30.21;30.1;50.88;48.09;27.03;67.79;57.51;58.2;29.9;25.64;55.39;30.33;21.78;39.5;19.43;48.77;45;36.8;35.3;26.73;60.06;41.38;82.73;37.09;81.82;35.87;42.95;24.64;34.42 1998-03-09;16.95;29.88;30.22;51;47.81;26.9;69.77;58.14;57.47;29.78;25.73;54.23;29.69;21.91;39.92;18.67;47.77;46.09;35.87;35.44;26.89;60.68;39.8;83.02;36.73;83.41;35.99;43.28;25.19;34.49 1998-03-10;17.38;29.86;30.93;50.81;48.71;28;69.83;58.37;56.85;30.23;25.81;54.32;30.3;22.42;39.97;18.78;48.46;46.44;36.78;35.83;27.23;61.68;40.75;83.25;36.47;84.2;35.73;43.31;25.04;34.51 1998-03-11;17.16;30.31;31.67;50.63;48.76;28.6;69.8;58.14;56.8;30.47;25.89;54.55;29.87;22.94;39.92;18.87;49.26;47.76;37.73;36.28;27.76;61.18;40.34;83.65;36.99;84.69;36.28;43.22;25.01;34.16 1998-03-12;16.93;30.09;31.7;49.97;50.51;29.09;69.01;57.57;56.63;30.44;25.95;53.72;30.49;22.94;39.44;18.99;49.82;47.53;37.9;36.31;27.79;60.86;40.94;83.31;36.43;82.37;36.68;42.95;25.19;34.53 1998-03-13;16.59;29.86;31.92;50.27;50.68;29.27;67.99;57.34;54.77;30.65;25.67;53.62;30.43;22.85;38.49;19.06;49.51;46.96;37.9;35.89;27.13;60.47;41.19;82.9;36.43;80.66;36.8;43.13;25.22;34.55 1998-03-16;17.1;30.41;32.16;49.91;52.15;29.21;69.13;58.54;56.4;30.59;26.01;53.2;30.64;22.94;38.91;19.32;50.32;48.39;38.82;35.77;26.33;61.06;41;84.52;36.07;80.41;37.49;43.46;25.28;35.73 1998-03-17;17.27;31;32.38;50.45;51.86;29.57;69.8;60.36;54.94;29.99;26.22;53.72;30.27;22.94;39.44;19.09;50.13;47.65;40.77;35.86;26.08;62.3;40.19;86.19;35.75;81.69;37.06;43.43;25.25;35.1 1998-03-18;17.23;31.42;32.16;49.36;52.37;29.39;72.08;60.99;55.95;30.8;26.12;53.2;30.86;22.57;39.86;19.15;50.47;46.03;41.79;35.74;26.05;62.01;40.88;86.6;35.54;82.86;37.81;43.79;24.95;34.97 1998-03-19;17.61;31.48;32.56;49.91;50.57;29.48;72.2;62.64;56.29;30.89;26.24;52.27;30.95;22.46;40.03;19.23;51.13;46.03;40.92;35.59;25.58;61.77;41;87;34.65;83.41;38.7;44.09;24.77;34.65 1998-03-20;17.36;31.52;32.53;51.85;50.57;30.06;74.67;64.01;56.57;31.99;26.75;52.83;30.95;22.69;40.15;18.84;50.72;45.92;40.73;36.19;25.58;62.18;40.91;86.54;36.07;83.47;40.55;44.44;24.61;34.87 1998-03-23;17.13;30.79;32.53;50.09;50.74;29.36;73.11;62.76;57.02;32.41;26.36;52.08;31.17;22.01;40.03;18.67;50.38;45.69;40.15;35.44;25.58;61.8;41.94;86.89;35.86;84.45;41.59;44.27;24.43;33.57 1998-03-24;16.99;31.06;33.3;50.81;51.02;30.06;73.23;63.73;58.03;32.58;27.08;52.6;31.29;21.91;40.63;18.51;51.44;45.23;40.6;35.3;26.08;62.18;42.47;87.69;36.64;84.51;42.52;44.27;24.83;34.85 1998-03-25;17.13;30.79;33.55;51.3;50;30.3;73.41;63.04;57.41;32.29;26.87;51.76;31.91;21.57;40.57;18.92;52.68;45.17;40.24;34.97;26.33;61.3;44.41;88.21;36.54;83.47;41.3;44.15;24.4;34.83 1998-03-26;17.02;30.11;33.24;50.57;49.38;30.6;73.65;63.04;57.08;32.49;27.02;51.01;31.47;22.15;39.97;19.44;52.21;45.06;40.6;34.73;27.51;60.59;44.12;88.27;35.7;84.14;40.15;43.73;24.46;35.1 1998-03-27;16.78;29.94;32.56;49.72;50.06;30.06;72.32;62.99;57.64;32.23;27.37;50.96;30.95;21.86;39.92;19.61;51.87;44.71;40.58;34.16;28.5;60.24;43.91;87.4;35.7;82.31;39.98;43.67;24.55;34.95 1998-03-30;16.21;29.46;33.03;49;49.61;29.33;75.52;62.76;57.7;32.38;27.96;50.92;31.1;21.82;39.32;19.24;51.31;44.88;40.47;34.25;29.49;59.53;43.97;86.6;36.01;83.53;39.98;43.46;24.8;34.4 1998-03-31;16.32;29.72;32.44;50.57;49.67;29.09;74.61;62.07;58.49;32.23;28.25;50.54;31.23;22.32;39.8;19.41;51.62;43.16;40.81;35.09;29.8;60.44;44.75;84.06;34.92;82.55;40.08;44.12;24.98;34.79 1998-04-01;16.25;29.9;32.75;51.18;48.76;28.9;77.68;61.9;59.39;32.85;28.33;50.26;30.83;22.94;40.21;19.27;51.9;44.71;41.15;35.06;30.52;61.24;45.19;85.1;33.45;85.67;39.74;44.98;25.32;34.55 1998-04-02;16.5;30.59;32.81;53.3;48.65;29.69;78.17;62.76;59.84;33.3;28.76;50.31;30.98;22.77;41.87;18.99;52.59;45.98;42.38;36.43;31.23;62.42;45.66;85.44;33.45;87.63;40.55;45.49;24.98;35.48 1998-04-03;16.37;32.05;32.66;53.3;48.93;29.9;77.5;62.93;58.2;32.97;28.64;50.36;30.83;23;42.4;19.09;52.03;45.4;42.62;36.79;31.54;61.98;46.5;85.1;33.5;86.22;40.9;45.16;25.32;36.16 1998-04-06;16.5;33.91;32.47;54.39;49.16;35.39;76.36;61.79;57.81;32.61;28.45;50.17;30.49;23.15;42.99;18.37;52.68;45.11;44.72;36.4;30.7;62.21;44.97;84.81;32.98;85.06;40.67;46.53;24.4;35.32 1998-04-07;16.07;33.5;32.29;53.97;49.21;33.15;76.12;66.18;57.25;32.29;28.55;49.84;29.93;22.73;43.47;18.06;52.03;44.37;43.69;35.95;30.24;61.65;43.62;85.44;31.46;85.12;39.95;45.79;24.95;35.21 1998-04-08;16.28;33.68;32.41;53.6;48.93;32.6;75.22;64.87;57.7;31.51;28.23;49.66;29.69;22.5;43.05;18.05;51.93;44.19;42.66;35.21;30.3;60.27;44.47;85.56;33.34;84.45;38.5;45.52;24.58;34.92 1998-04-09;16.62;34.73;32.56;53.54;49.44;32.63;75.7;67.44;57.75;31.81;28.35;50.31;30.09;23.37;42.94;18.34;52.87;44.37;43.08;35.56;30.89;59.53;44.5;86.89;33.87;84.39;38.62;45.55;24.98;35.6 1998-04-13;16.92;34.37;31.73;52.03;49.05;32.24;74.91;69.26;60.4;32.26;28.45;50.4;30.06;23.37;43.47;18.96;51.78;46.96;44.53;35.24;30.67;59.06;44.31;87.52;33.45;83.16;37.28;45.79;25.17;35.98 1998-04-14;18.03;34.02;32.01;51.54;50.68;32.42;74.97;70.18;63.84;32.02;28.39;52.22;30.03;23.84;44.65;18.9;52.8;50.06;43.42;34.67;30.83;58.94;44.22;86.83;33.71;82.12;37.28;46.51;26.18;36.94 1998-04-15;18.62;33.66;32.53;51;51.08;31.39;73.89;70.97;64.85;32.73;28.37;53.06;31.41;23.84;44.06;18.62;54.54;49.31;42.61;34.19;30.77;58.23;45.69;89.54;33.61;81.21;37.11;45.79;26.49;37.07 1998-04-16;18.27;33.21;32.69;51.42;50.91;30.69;72.08;69.15;64.63;33.51;28.06;52.32;30.64;23.41;43.65;18.5;53.58;49.6;41.14;33.44;30.61;56.32;45.84;89.02;33.45;81.08;37.17;46.27;25.84;36.56 1998-04-17;18.18;34.71;33.12;52.09;51.41;31.39;74.01;70.29;63.67;34.34;28.59;51.43;31.26;23.23;44;18.7;53.55;50.24;41.75;34.67;30.7;56.76;46.06;90;33.34;83.28;38.62;46;26.18;37 1998-04-20;18.33;33.66;32.16;51.66;51.53;31.21;72.57;68.29;66.2;34.76;28.23;52.04;31.72;23.31;43.29;19.02;55.26;49.08;40.97;34.1;31.08;57.64;47.31;89.25;33.5;82.18;37.98;46.36;25.69;37.66 1998-04-21;18.59;33.41;31.27;51.48;51.53;31.51;71.96;68.58;64.8;34.94;28.21;52.04;32.98;23.47;44.48;19.63;58.64;50.81;42.32;33.8;30.8;56.64;47.44;89.71;33.03;81.57;38.15;46.77;25.72;38.11 1998-04-22;18.67;34.39;31.24;51.42;52.15;31.63;72.99;69.15;66.32;34.76;27.92;52.13;32.92;23.41;43.59;20.91;57.03;50.12;42.62;34.1;30.33;56.41;49.44;88.21;32.51;82.18;39.08;46.59;25.72;39.82 1998-04-23;18.74;33.43;30.44;49.97;52.6;30.9;72.02;69.49;65.58;35.15;27.67;50.96;32.83;23.18;43.05;20.7;58.39;49.6;41.52;33.86;29;56.76;47.25;87.06;32.19;84.14;38.56;46.83;25.26;40.37 1998-04-24;18.52;33.05;30.75;49.18;51.58;30.48;70.94;68.01;65.08;35.03;27.49;50.36;36.77;22.65;41.93;20.41;58.33;48.85;40.78;33.74;28.87;54.93;46.06;85.27;31.93;83.65;37.86;46.86;24.71;39.86 1998-04-27;18.3;32.97;29.85;48.75;50.17;29.69;69.74;66.47;64.12;35.41;27.02;50.68;36.09;22.03;40.92;19.89;57.31;47.24;40.34;33.15;29.18;53.19;45.16;83.31;31.57;81.63;37.23;46.53;24.37;39.47 1998-04-28;18.09;32.81;29.39;48.21;50.17;29.45;69.8;65.44;63.11;34.97;26.59;50.45;35.63;22.03;40.51;19.72;57.49;47.88;40.65;32.97;28.87;54.46;44.94;85.44;31.41;79;37.11;46.21;24.15;40.31 1998-04-29;18.21;32.89;29.23;48.57;50;29.42;71;66.13;64.51;34.76;26.98;50.64;36.96;22.21;41.1;19.93;57.43;47.7;41.1;33.06;29.46;54.7;45.25;85.85;31.36;79.74;37.46;46.27;24.25;40.43 1998-04-30;18.39;33.15;29.67;48.57;51.58;29.66;73.11;66.47;65.08;34.82;27.92;50.26;37.14;23;41.51;20.1;57.59;48.05;42.15;34.16;30.74;56.82;45.06;87.17;31.09;80.41;38.5;47.04;24.86;40.66 1998-05-01;18.46;34.23;29.97;50.21;51.75;30.15;73.41;68.64;66.15;36.04;27.86;51.15;36.46;22.9;41.75;20.42;58.08;48.39;42.85;33.53;31.08;54.85;44.81;87.58;31.51;81.63;39.03;47.25;24.89;41.02 1998-05-04;18.55;33.88;30.62;49.6;51.41;29.99;73.47;68.81;68.68;35.62;27.65;52.13;37.02;23.25;42.28;20.39;57.96;49.26;42.3;33.8;31.08;54.79;44.03;89.31;32.77;82.37;40.07;47.58;25.01;41.49 1998-05-05;18.33;33.23;30.19;49.42;50.68;29.63;73.29;69.09;67.39;35.26;27.3;51.06;37.11;23.33;41.93;20.36;58.55;48.22;41.67;33.62;30.64;54.67;43.88;88.96;33.03;81.88;39.61;46.89;24.83;41.35 1998-05-06;18.1;32.28;29.39;48.81;50.17;29.03;73.23;69.15;66.2;35.47;27.22;50.68;36.65;22.9;41.81;20.24;58.27;48.74;41.08;33.12;30.52;54.46;43.19;86.71;32.87;80.47;39.72;46.42;24.55;40.53 1998-05-07;17.84;32.32;28.56;48.39;50.11;29.21;72.93;67.32;64.85;34.91;26.83;49.89;37.76;22.4;41.81;20.14;58.21;47.93;41.45;33.23;30.49;54.23;41.69;85.38;32.4;79.07;39.37;45.73;24.89;38.9 1998-05-08;17.97;32.99;28.43;49;50.57;28.9;73.65;67.61;64.51;34.88;27.26;51.24;37.91;22.73;41.63;20.91;59.64;48.22;41.64;33.98;30.89;55.58;42.88;86.77;32.35;79.25;39.37;45.97;24.83;39 1998-05-11;18.18;32.85;28.37;48.15;50.34;29.42;74.61;72.57;64.85;34.76;27.26;53.25;37.79;23;41.34;20.52;59.3;48.8;42.15;33.5;30.52;55.67;42.12;86.71;32.04;79.19;36.06;46.36;25.14;39.45 1998-05-12;18.3;33.54;28.53;48.03;51.58;30.02;74.91;72.97;64.18;35.17;27.34;54.94;39.36;23.1;41.75;21.03;59.45;49.95;42.74;33.86;31.26;55.38;42.84;86.13;31.72;79.55;36.64;46.53;25.94;38.78 1998-05-13;18.27;34.21;28.74;48.27;51.53;29.87;74.43;75.07;64.63;35.09;27.73;56.39;40.22;23.45;42.11;21.09;60.57;50.06;42.43;34.61;31.57;55.35;43.47;87.23;31.15;81.08;35.37;46.06;26.61;38.68 1998-05-14;18.12;34.1;28.28;48.39;53.34;29.45;74.91;74.9;63.61;35.09;27.57;56.39;34.65;23.74;41.4;21.03;62.53;50.64;42.38;34.49;31.82;55.67;44.47;88.39;30.36;81.33;35.19;46.09;26.64;37.88 1998-05-15;17.61;33.76;28.12;48.15;52.38;30.36;74.07;73.81;62.77;35.12;27.08;55.5;34.21;23.41;40.86;19.97;62.09;49.03;43.19;33.74;31.64;55.05;44.72;88.56;29.52;80.17;34.73;45.7;26.58;36.11 1998-05-18;17.42;33.62;27.91;47.18;52.89;30.36;74.55;74.04;63.56;34.58;27.04;55.31;32.58;23.14;40.53;19.74;61.94;48.51;43.27;34.04;31.26;56.41;43.03;88.56;29.47;82.67;35.31;44.92;26.73;35.8 1998-05-19;17.02;33.25;27.85;46.93;53.06;30.81;75.22;75.36;63.33;34.46;27.16;54.61;32.77;24.09;40.83;19.79;62.12;48.16;44.07;33.89;31.2;56.05;43.25;89.54;29.99;81.82;34.9;45.4;26.7;36.21 1998-05-20;17.02;34.43;29.05;46.57;54.13;31.45;76.9;75.87;63.73;33.95;28.08;55.13;32.46;24.05;41.96;19.15;61.38;48.92;43.86;34.13;32.72;56.85;42.88;89.18;30.26;83.16;36.76;46.29;26.98;37.41 1998-05-21;17;34.14;28.93;46.75;54.98;30.75;76.54;74.72;63.22;33.54;28.16;55.83;31.97;24.61;41.54;18.43;61.44;47.93;43.73;34.01;32.75;55.97;43.19;88.19;31.3;82.06;36.93;46.08;27.41;37.84 1998-05-22;16.97;33.7;29.08;46.93;53.06;30.6;75.94;75.58;63.61;33.63;27.86;57.1;32.34;24.55;40.59;18.48;60.6;46.95;43.94;33.8;32.6;55.64;42.78;88.95;31.25;82.06;36.24;46.17;27.29;37.96 1998-05-26;16.82;33.09;29.45;45.84;51.3;30.42;74.55;72.89;63.39;33.15;27.14;55.74;32.21;24.59;39.7;18.57;60.13;45.97;42.38;33.5;32.66;54.93;41.81;88.72;30.94;80.35;35.42;45.6;26.43;36.47 1998-05-27;16.9;32.89;29.82;45.11;51.41;29.6;75.4;73.75;63.44;33.54;27.45;55.22;32.24;24.5;38.27;18.48;59.76;44.52;41.39;33.29;32.66;56.02;43;89.06;30.88;81.02;35.31;44.49;26.73;37.31 1998-05-28;16.7;33.54;29.94;45.48;51.19;29.87;76.06;72.83;64.13;33.8;27.65;54.99;31.47;25.41;39.1;18.28;59.67;43.42;41.5;33.56;33.22;56.08;43.16;88.25;31.3;82.25;36.24;44.88;27.26;37 1998-05-29;16.51;33.29;30.04;46.33;49.77;29.69;75.52;70.77;64.75;33.6;27.32;54;30.7;25.93;40.65;17.77;58.39;42.56;41.35;33.11;32.6;55.17;42.41;86.05;31.3;82.06;36.12;45.09;27.1;36.96 1998-06-01;16.33;33.68;29.14;46.21;50.06;30.54;76.6;69.22;65.83;33.66;27.16;53.44;30.24;26.09;41.54;16.91;58.24;43.42;40.78;33.05;33.38;54.93;41.88;87.44;31.57;83.65;36.24;45.12;27.78;36.17 1998-06-02;16.47;33.54;28.96;44.51;49.6;30.96;76.72;69.51;64.64;33.33;27.12;54.85;30.43;25.64;41.48;17.22;57.43;43.48;41.65;32.81;33.28;54.29;42.75;86.68;31.46;83.84;37.23;44.82;27.99;35.94 1998-06-03;16.29;33.31;29.42;44.51;49.43;30.3;76.54;70.08;63.33;32.88;26.65;56.44;29.9;25.41;40.53;16.4;56.59;43.48;41.26;32.48;32.72;53.29;42.16;85.23;30.68;83.96;36.01;44.13;27.53;35.76 1998-06-04;16.18;33.72;30.04;43.72;50.11;30.6;77.26;70.37;62.6;33.51;27.34;56.68;30.4;25.51;40.11;16.96;57.68;44.06;41.83;33.26;33.22;54.76;43.03;86.39;30.36;84.57;36.47;43.5;27.84;35.76 1998-06-05;16.35;33.9;30.53;44.14;51.19;31.21;79.07;73.01;63.11;34.22;27.78;56.54;31.01;26.05;41.42;17.36;59.08;43.89;42.66;34.28;33.38;56.6;43.12;86.97;32.35;85.98;38.27;44.01;28.42;37.43 1998-06-08;16.42;35.36;30.53;44.39;50.68;31.45;78.11;72.66;63.79;33.92;27.67;55.6;31.35;26.57;41.36;17.24;59.05;44.17;43.59;33.92;33.44;57.52;42.84;87.5;33.14;85.98;37.28;43.83;28.52;37.82 1998-06-09;16.33;34.75;30.28;44.63;51.02;31.33;78.65;71.69;65.15;33.33;27.8;54.99;31.29;26.65;41.24;17.45;59.26;43.42;43.06;34.55;32.79;58.23;43.53;86.28;33.71;86.34;37.17;43.62;28.55;38.02 1998-06-10;15.89;34.94;31.27;44.08;48.81;30.84;78.29;70.71;63.73;32.79;27.94;54.61;30.77;27.19;40.89;17.05;58.27;42.73;43.19;34.91;32.79;59.71;43;82.1;32.14;84.94;37.4;41.85;29.13;38.62 1998-06-11;15.54;33.76;30.59;43.72;47.39;30.06;76.92;68.77;62.99;32.43;27.59;52.78;29.87;27.04;39.94;17.05;57.65;41.46;42.61;34.94;31.92;59.88;42.66;81.69;31.1;82.73;36.82;40.72;29.01;37.92 1998-06-12;15.47;33.33;31.05;43.6;47.11;30.18;77.89;68.54;63.39;33.03;27.94;52.5;29.93;26.77;40.11;17.02;57.77;41.57;42.24;35;32.1;59.85;42.88;80.65;31.58;83.41;37.75;41.7;28.92;37.56 1998-06-15;15.17;32.87;29.76;42.2;47.45;29.03;76.56;65.61;61.63;32.64;27.49;51.37;29.56;25.99;39.04;16.63;55.79;40.65;41.48;34.22;31.64;58.7;42.97;75.25;31.21;82.98;36.24;41.26;27.81;36.62 1998-06-16;15.02;32.89;30.56;42.14;47.56;29.09;76.26;66.3;61.06;33.15;27.94;51.75;29.29;26.3;38.51;17.36;54.67;40.36;41.22;35;31.85;59.94;44.94;75.48;31.05;85.49;36.35;41.08;28.21;36.84 1998-06-17;15.4;34.04;31.08;42.45;49.21;30.06;77.53;68.59;61.8;33.83;28.7;52.4;28.83;27.16;39.58;17.22;55.16;41.23;42.36;35.6;32.51;60.47;45.53;76.58;32.53;87.26;36.93;42.63;28.77;37.31 1998-06-18;15.2;34.18;30.71;42.63;49.38;29.87;78.55;69.68;61.63;33.72;28.82;52.26;27.93;27.76;40.47;17.33;54.08;40.88;42.24;35.9;33.72;61.01;45.59;76.52;33.48;87.93;36.76;42.21;28.56;36.56 1998-06-19;15.34;34.55;31.12;41.66;46.77;29.72;77.59;67.96;60.89;33.39;28.51;50.71;27.75;27.1;40.17;17.41;52.74;40.71;42.81;36.26;33.81;60.06;47.34;77.57;32.74;86.46;37.34;41.26;28.49;35.11 1998-06-22;15.23;34.23;31.12;41.48;47.9;29.42;78.31;67.28;61.01;33.66;28.23;51.14;28.21;27.76;40.05;18.37;53.74;40.36;42.17;35.84;33.75;59.56;47.91;77.16;33.59;84.81;37.4;41.35;28.22;35.5 1998-06-23;15.35;34.35;32.26;42.08;47.85;29.54;79.7;67.91;60.72;34.22;28.88;51.09;29.2;28.01;40.65;18.71;55.54;40.18;42.7;36.62;33.5;60.27;50.38;76.41;33.54;86.34;38.33;42.27;29.14;35.82 1998-06-24;15.11;35.24;29.6;43.36;48.92;30.39;81.21;69.57;62.26;34.52;29.43;50.95;29.44;28.03;41.42;19.24;55.66;40.3;44.49;37.28;33.53;62.13;52.47;76.58;33.11;88.91;36.93;42.75;29.6;36.78 1998-06-25;15.07;35.4;28.8;43.3;47.68;30.06;81.93;69.05;62.99;34.55;29.41;50.99;29.81;28.01;41.36;18.81;55.88;40.01;44.03;36.89;33.75;61.84;50.78;77.86;33.06;88.36;37.28;42.93;29.54;36.72 1998-06-26;15.65;35.85;28;44.33;48.02;29.81;82.84;68.77;63.62;34.43;29.52;50.24;29.87;28.03;41.72;18.99;56.16;40.59;44.56;36.89;34.24;62.22;52.22;76.99;33.54;88.42;37.46;43.38;29.39;36.07 1998-06-29;15.72;36.23;28.09;43.3;47.45;29.78;83.02;68.42;64.07;34.07;29.78;51.28;30.43;27.93;41.42;18.85;56.72;39.66;46.01;36.92;34.37;62.84;53.72;77.16;33.17;90.19;36.99;43.92;30.56;36.94 1998-06-30;15.69;36.98;28.19;43.23;47.93;29.39;82.53;68.48;66.28;34.01;29.78;50.2;29.5;27.41;42.19;18.43;57.06;39.78;45.93;35.48;34.28;63.31;54.19;76.35;33.33;89.09;37.17;44.37;29.91;34.29 1998-07-01;15.95;36.41;28;46.02;48.87;30.6;82.78;70.6;66.39;34.76;29.88;51.46;28.67;28.05;41.6;18.7;58.02;40.07;46.15;35.12;35.39;63.03;54.69;77.92;34.28;90.32;36.82;45.03;29.79;34.68 1998-07-02;15.77;36.29;27.08;46.99;49.04;30.84;82.41;69.85;66.51;34.73;29.8;51.75;28.24;28.34;42.13;18.22;57.25;40.13;46.11;35.33;35.27;62.84;53.62;76.41;33.96;90.56;37.05;45.15;29.88;34.74 1998-07-06;15.47;36.81;27.29;47.18;49.21;30.93;83.74;71.69;66.68;34.94;30.11;53.25;28.15;30.49;42.19;18.27;56.5;40.47;47.07;34.7;36.51;63.85;53.91;76.58;33.75;91.97;37.23;45.6;30.16;34.54 1998-07-07;15.63;37.06;27.72;46.39;48.92;31.3;82.96;70.31;66.39;34.67;30.36;52.45;28.76;30.49;42.55;18.68;56.59;40.3;45.85;35.75;36.82;63.14;53.97;76.29;33.48;90.26;36.99;45.51;30.09;34.78 1998-07-08;15.8;37.22;28.19;47.24;48.81;33.57;84.16;70.71;67.42;34.88;30.58;54.99;30.03;31.6;42.73;19.48;57.15;40.47;45.01;35.03;36.26;63.26;54.94;76.06;32.37;89.95;36.92;45.99;30.92;35.35 1998-07-09;15.65;37.16;28.37;46.63;47.22;33.15;83.68;64.3;67.47;34.19;30.85;53.48;29.35;31.02;42.13;19.83;58.18;40.13;45.01;34.73;35.77;62.46;55.5;76.12;33.22;88.42;36.86;45.81;31.08;36.23 1998-07-10;15.32;37.97;28.12;46.45;47.62;33.45;84.16;62.46;66.73;34.16;30.75;53.48;28.86;32.01;41.72;19.83;58.89;40.07;45.54;34.46;36.29;62.72;56.59;74.96;33.85;90.44;37.5;45.39;31.6;37.33 1998-07-13;15.56;37.87;28;46.15;47.22;33.96;83.86;62.63;66.34;33.6;30.66;51.75;29.63;31.52;41.01;20.49;59.33;39.66;45.46;34.43;36.57;63.85;58.78;74.55;33.64;89.22;37.21;45.51;31.54;38.56 1998-07-14;16.33;38.32;28.37;47.06;50.96;34.45;84.89;62.92;66.9;34.34;31.15;52.31;29.2;32.14;41.84;20.07;59.45;40.3;46.15;35.6;36.17;65.03;58.25;75.48;33.85;91.36;37.15;45.78;32.68;39.04 1998-07-15;17.23;37.24;29.39;47.84;47.11;34.12;84.77;62.46;74.84;34.13;30.83;52.45;29.13;31.15;43.14;20.95;58.15;39.78;45.96;36.38;35.33;64.68;58.69;75.77;33.22;89.34;37.03;46.11;32.43;38.56 1998-07-16;17.4;37.46;29.39;47.3;48.47;34.39;84.16;62.52;78.92;34.01;31.38;52.69;29.29;31.23;43.26;20.95;58.83;41.46;45.85;37.1;35.7;65.5;58.69;76.7;33.48;90.38;38.09;46.32;33.85;38.49 1998-07-17;17.27;37.65;29.14;48.51;48.47;34.75;83.14;62.4;78.24;34.49;31.69;52.5;29.53;31.02;43.5;20.67;59.73;41.86;45.81;37.19;36.39;65.33;58.97;77.39;33.43;88.54;38.09;45.39;33.97;38.56 1998-07-20;17.09;37.24;29.3;47.78;48.75;35.21;81.63;61.43;80;33.63;31.3;51.93;30.37;31.1;43.62;20.33;60.63;41.98;45.85;36.98;35.05;65.5;58.5;77.16;33.96;88.05;38.26;44.55;33.88;37.76 1998-07-21;17.08;36.55;28.9;46.75;48.3;33.45;81.33;61.09;78.7;33.45;30.46;52.26;28.52;30.36;43.68;20.3;63.68;41.98;43.71;36.56;34.4;60.86;56.41;76.18;33.96;86.34;38.96;45.21;33.48;36.96 1998-07-22;17.11;36.29;28.46;46.33;47.16;33.57;80.97;58.16;79.83;34.22;29.95;54;27.29;30.49;44.33;20.49;63.33;41.98;44.59;37.22;33.41;59.23;58.38;74.72;35.23;85.24;39.6;46.2;33.02;36.46 1998-07-23;16.96;35.37;28.93;39.96;45.68;32.54;80.12;55.87;77.11;33.42;29.5;52.92;28.3;29.83;43.32;20.53;61.56;40.71;44.7;35.96;33.96;58.43;56.5;72.69;35.49;84.45;38.67;45.99;31.26;35.54 1998-07-24;16.81;34.8;29.57;39.11;44.82;32.24;80.54;55.99;76.88;33.54;30.05;53.39;28.18;29.87;42.73;20.66;61.75;40.24;45.01;36.71;33.56;59.53;56.91;71.76;35.07;85.85;39.43;45.42;31.42;36.1 1998-07-27;16.7;36.67;29.6;37.84;44.54;32.72;81.99;56.96;76.2;34.04;30.15;54.94;28.3;28.96;43.38;21.4;62.37;40.65;45.08;36.92;33.65;59.2;58.38;72.81;35.81;87.5;38.9;46.68;31.45;35.91 1998-07-28;16.54;36.49;29.14;37.84;44.48;31.99;80.48;56.04;75.3;33.18;29.76;55.78;28.21;28.63;43.09;21.29;62.34;39.72;44.85;37.01;33.34;58.94;56.12;71.41;36.24;87.08;38.2;45.39;31.23;34.69 1998-07-29;16.59;36.65;29.05;37.6;44.71;32.12;79.03;57.19;75.35;33.69;29.33;55.69;27.84;27.93;43.09;21.04;63.55;39.14;44.36;37.61;33.03;58.37;55.34;70.43;37.13;86.22;38.79;44.88;29.97;34.69 1998-07-30;16.79;37.02;29.57;37.96;45.62;33.12;79.88;57.36;77.56;34.37;29.93;54.99;28.21;27.89;43.2;21.79;66.28;40.36;45.62;38.05;33.41;59.74;56.72;70.19;37.24;81.82;38.96;46.23;31.32;34.62 1998-07-31;16.5;35.88;29.91;37.66;44.2;32.6;77.71;56.85;76.09;33.48;29.31;54.33;27.35;27.64;41.36;21;65.85;41.28;46.23;37.04;33.19;58.49;54.97;69.79;37.08;77.66;38.26;45.99;31.08;33.77 1998-08-03;16.15;35.68;29.36;36.75;44.94;31.66;79.28;56.9;73.94;32.64;29.33;53.44;26.92;27.02;41.42;21.09;65.97;41.63;45.73;36.26;32.1;57.52;54.22;69.44;37.35;74.6;38.67;46.41;30.34;34.01 1998-08-04;15.62;34.6;28;35.78;43.06;29.96;75.9;55.7;73.54;31.99;28;52.22;25.62;26.4;38.03;20.38;63.02;39.78;42.56;35.24;31.05;56.39;52.25;68.4;35.97;76.07;37.27;44.73;28.74;32.17 1998-08-05;15.53;35.25;28.43;35.41;42.94;30.42;77.59;56.62;73.71;31.54;28.43;51.37;26.02;26.81;35.18;20.92;63.99;39.78;43.63;35.93;30.61;57.34;52.16;70.37;36.61;79.8;36.8;44.13;30.03;32.91 1998-08-06;15.56;32.85;28.74;35.96;42.83;30.6;78.79;57.99;75.3;30.95;29.11;52.78;25.87;27.72;35.06;21.64;64.48;39.43;43.71;36.2;30.7;57.87;53.44;71.88;36.61;77.23;37.38;44.1;31.51;32.66 1998-08-07;15.95;32.83;28.77;38.08;43.28;29.66;77.65;57.76;75.81;31.9;28.88;53.39;25.38;29.04;35.3;21.56;64.17;40.01;42.29;36.41;30.36;58.64;52.94;72.69;36.39;77.11;36.51;43.32;30.96;32.73 1998-08-10;16.05;32.77;28.65;38.08;43.11;29.84;77.35;56.5;76.09;32.23;28.78;53.39;25.25;28.42;34.47;21.54;64.54;40.76;41.87;35.66;31.51;59.71;52.22;71.01;36.24;78.09;36.28;43.47;31.05;32.23 1998-08-11;15.63;32.02;28.09;36.87;43.34;28.48;76.74;54.95;74.84;32.41;28.61;52.21;24.7;27.6;33.7;21.03;63.86;39.43;40.19;35.48;32.04;58.7;51.72;71.07;35.39;77.42;36.04;42.06;31.51;31.5 1998-08-12;15.65;32.06;28.12;37.72;44.08;28.69;76.92;55.8;74.11;31.96;29.29;52.68;25.62;28.71;34.35;21.29;63.61;39.9;40.46;35.99;32.69;59.29;52.53;72.52;35.6;77.9;36.28;42.72;32.49;31.81 1998-08-13;15.31;30.96;28.28;36.08;44.42;27.51;76.02;50.72;74.45;32.49;28.8;52.25;25.38;28.75;35.06;21.2;62.71;39.9;39.2;36.32;32.47;60;51.97;71.12;35.07;76.74;36.92;42.69;31.66;31.19 1998-08-14;15.1;30.45;27.32;35.72;44.08;27.15;74.15;49.11;74.84;32.58;28.66;51.31;25.99;27.72;35.24;21.43;62.31;38.62;39.35;36.08;32.23;60.3;52.12;70.19;35.76;76.8;36.33;41.8;30.71;31.13 1998-08-17;15.44;31.25;27.6;35.84;44.88;28.21;76.32;50.78;77.62;33.18;29.27;51.45;27.22;28.26;36.49;22.27;62.18;38.62;40.65;36.77;32.26;62.13;53.66;70.66;36.34;78.58;37.62;42.9;30.92;31.56 1998-08-18;16.01;32.63;27.97;36.44;46.02;28.87;76.32;51.82;78.81;33.45;29.74;52.02;28.09;29.58;36.75;22.74;64.05;39.61;42.29;36.65;32.66;62.25;55.62;71.99;36.5;79.25;37.44;43.08;31.63;32.85 1998-08-19;16.25;32.83;27.94;35.66;45.45;28.21;75.96;51.53;78.98;33.72;29.91;51.88;27.53;28.92;36.99;22.27;64.58;39.84;41.49;36.53;32.91;61.98;55.28;72.45;36.18;78.52;37.38;42.72;31.51;32.48 1998-08-20;16.41;31.57;27.79;35.23;44.14;27.24;76.68;53.95;78.07;33.98;29.64;50.32;27.59;28.55;37.35;21.39;63.64;39.43;39.96;36.32;32.69;60.92;56.28;71.57;36.5;76.74;37.56;42.66;31.88;32.97 1998-08-21;15.87;30.9;27.6;35.29;43.17;26.48;76.56;54.93;76.88;33.77;29.37;49.28;27.04;28.3;35.74;21.12;63.55;38.62;38.93;36.62;32.79;61.07;55.31;70.29;37.03;77.29;37.5;41.69;32.09;32.6 1998-08-24;15.53;31.59;28.16;34.62;44.59;26.12;76.86;56.2;77.68;33.63;29.41;48.14;26.67;29.04;33.41;21.04;63.89;39.9;39.16;36.83;32.51;62.19;55.19;70.17;37.45;79.07;37.85;41.54;33.11;32.73 1998-08-25;15.23;31.49;28.4;34.32;43.63;26.72;77.35;55.22;77.56;33.54;29.6;48.8;27.07;29.95;34.42;20.99;63.83;39.96;39.2;36.56;32.88;63.2;56.41;70.58;37.03;81.02;37.38;41.45;33.72;33.4 1998-08-26;14.93;31.59;27.91;34.44;42.43;26.48;76.44;54.87;78.36;33.54;29.64;48.33;26.98;30.11;34.72;20.64;65.04;38.15;39.28;36.98;31.92;63.14;56.28;69.35;37.4;81.08;37.68;39.92;34;32.36 1998-08-27;14.17;29.58;27.23;33.96;40.66;24.48;72.16;54.07;76.6;33;28.37;45.97;25.53;29.66;34.36;19.83;62.25;36.7;35.53;35.57;31.02;61.13;54.62;69.06;36.61;78.82;35.98;37.48;33.42;31.13 1998-08-28;14.48;28.44;27.54;32.93;40.09;23.42;70.23;53.55;74.38;32.2;28.14;46.2;25.38;28.01;34.36;19.15;60.91;36.29;34.54;35.69;31.14;60.3;52.62;67.95;36.24;80.04;37.03;37.81;32.19;30.03 1998-08-31;14.31;25.36;24.73;30.02;38.27;21.51;62.87;53.38;71.24;31.18;26.22;43.98;23.93;25.16;32.75;17.7;55.97;34.43;32.09;33.19;28;54.88;47.97;64.09;35.18;74.85;35.57;34.95;29.05;26.9 1998-09-01;15.08;26.66;26.46;32.08;41.8;21.03;65.88;52.4;72.9;31.63;27.1;44.64;24.7;27.23;33.59;18.9;58.61;35.19;33.54;34.81;29.8;57.99;50.62;63.68;35.92;78.27;36.39;36.79;30.4;29.78 1998-09-02;14.86;27.22;25.81;32.99;41.69;21.57;62.02;52.51;75.35;30.5;26.34;44.69;24.7;26.15;32.75;18.62;59.89;35.59;33.54;34.96;29.21;57.06;50.28;64.67;35.87;77.11;34.76;37.9;29.51;29.29 1998-09-03;15.45;25.11;25.56;33.53;40.89;19.94;59.79;51.76;74.78;30.47;25.48;43.27;24.64;25.54;31.5;19.09;60.51;36;30.11;36.02;28.78;58.72;49.62;66.14;36.34;75.15;34.7;36.36;29.6;27.76 1998-09-04;15.23;23.93;26.27;32.93;41.86;18.94;59.97;51.93;73.87;31.48;24.87;42.61;24.85;25.29;32.46;19.46;59.33;36.87;27.74;36.62;28.87;58.07;48.31;65.73;35.55;73.99;35.11;36.67;28.8;27.7 1998-09-08;16.07;26.01;27.51;35.11;44.82;20.45;61.3;52.74;74.09;32.14;26.83;44.45;25.93;27.52;33.83;20.37;62.59;39.37;28.81;37.97;32.01;59.67;50.98;69.18;36.34;77.9;36.22;38.5;30.89;28.56 1998-09-09;15.86;24.93;27.51;34.2;43.91;19.42;60.45;53.72;74.44;32.73;26.28;43.55;25.96;27.06;33.89;20.21;61.38;39.32;27.28;36.86;30.83;60.12;51.12;68.88;36.55;70.32;36.16;37.69;30.06;27.27 1998-09-10;15.51;22.59;27.26;32.87;41.92;19.15;58.76;51.19;72.04;33.21;25.26;41.99;24.14;26.03;31.92;19.66;60.88;38.62;26.13;36.38;29.68;58.87;50.38;65.32;36.39;67.51;35.46;36.18;28.77;26.54 1998-09-11;16.26;25.48;27.6;32.99;41.23;19.81;60.42;52.22;71.13;33.63;25.97;42.7;24.64;26.57;32.04;21.12;62.9;38.79;28.12;36.74;29.4;60.86;52.12;66.95;36.77;65.92;37.38;36.94;29.85;25.31 1998-09-14;16.74;26.55;28.46;33.35;41.35;20.12;61.27;54.87;73.24;33.6;25.93;44.97;25.04;26.65;34.36;21.34;64.17;39.43;28.27;38;29.15;62.76;53;66.08;37.63;67.63;37.74;38.23;30.12;23.96 1998-09-15;16.78;27.59;28.25;33.23;41.92;20.81;59.21;54.59;74.61;33.95;25.58;44.55;25.5;27.31;34.84;21.37;64.61;41.23;30.03;37.55;28.9;64.43;54.16;66.49;38.21;68.18;37.74;38.5;30.77;25 1998-09-16;16.96;28.3;28.77;33.47;41.23;20.91;60.42;55.91;77.29;33.27;26.18;44.5;25.5;27.97;35.02;21.15;64.86;41.41;30.53;36.98;29.28;64.31;54.09;68.65;39.02;68.49;37.79;39.04;31.02;25.25 1998-09-17;16.22;27.26;28.28;33.05;38.96;19.72;58.85;53.84;76.37;32.67;25.64;43.46;24.88;27.31;34.42;20.64;62.99;40.6;29.27;36.68;27.97;63.63;52.47;66.31;38.11;65.37;36.63;38.86;30.01;25.19 1998-09-18;16.2;27.47;29.11;33.41;36.68;19.48;59.39;53.43;77.51;32.46;25.52;43.18;25.16;26.65;34.13;20.64;61.97;40.54;29;36.92;28.19;63.92;52.69;66.43;39.55;67.45;38.73;38.38;29.85;25.06 1998-09-21;16.25;27.65;28.65;32.99;38.78;19.21;57.28;53.66;77.86;32.49;25.97;43.08;25.56;26.81;34.13;21.04;63.71;40.54;28.62;38.15;28;64.49;53.94;66.84;40.3;68.49;38.32;37.6;29.92;24.64 1998-09-22;16.29;26.41;28.83;33.17;38.39;19.09;54.55;53.09;76.09;31.96;26.18;43.13;24.98;27.76;33.71;20.78;63.49;41.29;28.2;37.64;28.07;64.96;54.59;66.43;40.99;69.89;38.26;36.54;30.75;24.7 1998-09-23;17.23;27.12;29.36;32.81;41.29;20.81;56.13;54.12;76.66;33.51;27.55;44.45;26.45;29.41;34.84;21.65;65.63;42.17;30.64;38.21;28.07;65.88;56.81;68.42;40.4;73.32;39.72;38.59;31.79;26.29 1998-09-24;16.81;25.76;29.23;33.47;42.03;19.63;54.86;53.61;75.12;33.06;26.79;43.32;26.3;28.05;33.95;21.22;64.89;43.62;28.35;37.88;28.22;65.2;55.06;68.65;39.66;70.93;39.25;38.14;30.96;25.37 1998-09-25;17.14;26.17;29.42;33.65;42.77;19.51;54.37;54.18;73.75;32.58;27.22;44.26;26.7;28.38;33.89;21.96;66.35;45.07;27.81;37.43;28.44;62.53;56.53;69.53;39.28;68.98;39.02;38.23;30.53;25.13 1998-09-28;17.34;26.98;28.68;33.9;44.31;19.63;55.4;56.83;72.16;32.43;27.39;45.02;27.07;27.97;33.65;21.64;66.41;45.66;27.24;38.48;29.74;61.22;55.66;72.16;39.44;72.03;40.31;38.44;30.29;25.74 1998-09-29;17.29;26.29;29.54;34.5;43.11;19;56.79;54.47;71.07;33.95;27.16;43.88;27.29;27.31;34.42;22.01;65.32;45.6;27.51;38.15;29.99;62.73;56.44;72.22;40.19;70.87;41.18;38.77;28.65;25.49 1998-09-30;16.96;25.23;28.83;33.29;40.55;18.18;55.76;51.88;70.1;33.66;26.08;41.52;26.08;26.07;33.77;21.32;63.86;43.39;26.36;37.64;29.65;61.6;55.03;68.94;39.55;69.59;41.47;36.82;26.93;24.88 1998-10-01;16.29;23.89;28.25;31.35;40.04;17.33;54.43;49.51;68.17;33.63;24.76;41;24.7;23.84;32.4;20.75;62.31;41.76;24.89;36.74;29.74;59.43;52.03;67.89;39.76;69.59;42.35;35.64;26.19;24.45 1998-10-02;16.52;24.18;28.93;31.59;41.01;18.69;57.03;50.84;69.31;34.79;24.7;41.61;24.51;23.51;32.69;20.86;62.03;42.17;26.98;37.1;28.81;60.74;52.06;69.94;40.3;73.32;43.46;36.67;27.33;24.76 1998-10-05;16.29;23.57;28.4;32.26;39.81;16.72;59.45;50.26;68.28;35.68;23.92;40.67;24.24;23.18;33.53;20.03;59.76;42.63;25.59;38.21;28.44;61.22;50.59;68.12;40.62;72.58;45.1;35.7;28.22;24.57 1998-10-06;17.32;23.08;28.12;31.96;39.01;16.72;60.78;49.34;69.48;36.1;24.17;38.78;24.58;24.34;33.65;19.8;59.26;42.4;25.32;38.27;28.94;60.68;48.81;69.06;42.01;72.65;44.22;36.6;29.33;24.88 1998-10-07;17.35;23.89;28.8;31.17;39.87;15.39;61.27;49.23;70.5;35.29;24.58;38.87;24.39;23.76;33.11;19.66;60.01;41.99;24.82;37.19;30.33;59.82;47.06;71.46;41.79;75.7;45.02;36.73;28.96;24.5 1998-10-08;17.5;23.6;28.86;29.96;41.01;15.75;62.42;50.9;71.87;34.16;23.45;38.02;24.24;22.52;32.93;19.51;61.38;40.94;24.98;36.47;30.83;60.39;45.59;72.51;40.94;76.93;44.67;36.24;28.01;23.09 1998-10-09;18.62;25.11;29.05;31.05;42.6;17.18;61.75;53.95;74.84;33.72;23.76;38.49;24.42;23.93;34.36;20.84;63.27;42.81;26.4;36.56;30.43;61.84;48.44;74.03;40.67;75.7;41.68;36.97;29.15;23.27 1998-10-12;18.75;26.01;28.93;32.14;43.51;16.94;60.66;55.28;76.2;34.22;24.27;39.3;25.56;24.5;34.84;21.25;65.04;42.86;26.56;36.77;31.26;62.35;49.88;75.37;41.21;75.7;39.04;38.11;29.98;24.2 1998-10-13;17.86;25.6;29.05;32.38;43.06;16.89;61.93;54.24;66;34.79;24.95;38.64;25.41;24.92;35.62;20.78;63.71;42.86;26.33;37.4;31.92;62.17;48.22;74.38;41.05;77.11;40.27;37.9;29.55;25.05 1998-10-14;17.44;26.37;29.73;32.5;41.92;17.27;62.3;53.43;66.34;35.26;25.44;39.49;24.51;25.58;34.78;20.53;64.86;41.7;25.71;38.42;31.64;61.52;50.09;74.38;41.69;78.27;40.74;37.42;30.13;23.95 1998-10-15;18.43;28.86;30.34;32.93;43.74;19.3;65.32;55.8;68;36.04;26.87;42.42;25.59;27.31;35.44;21.03;67.84;42.75;28.99;39.74;33.31;63.36;52.72;76.9;41.74;81.15;41.85;38.65;31.86;25.42 1998-10-16;18.93;28.98;29.97;31.29;42.83;20.27;66.95;59.14;68;36.37;27.47;44.59;26.61;27.89;36.27;20.83;67.56;44.55;30.28;39.98;33.87;64.67;52.53;79.64;41.05;81.94;40.27;40.22;32.84;25.05 1998-10-19;18.65;29.19;30.41;33.41;43.45;20.72;66.17;60.52;67.43;35.68;27.32;45.21;26.64;29.12;37.29;21.14;69.27;45.02;31.61;39.83;33.34;63.6;51.47;79.23;40.94;80.29;39.62;40.79;33.89;25.61 1998-10-20;18.71;29.25;30.59;34.87;44.2;21.97;64.9;59.2;68.97;36.49;26.96;46.63;27.1;28.13;37.29;21.03;68.52;45.19;32.73;39.08;32.35;62.11;50.12;80.93;41.95;80.41;40.27;41.72;32.32;26.59 1998-10-21;18.67;28.39;30.65;34.93;43.63;21.3;64.84;57.18;69.76;36.01;27.49;46.11;28.12;28.63;36.69;21.65;70.91;44.72;33.3;38.87;32.44;63.36;53.22;78.82;42.7;82;40.39;43.56;32.01;27.08 1998-10-22;18.52;29.02;31.76;35.35;43.33;21.84;66.89;56.83;68;34.19;28.35;46.53;28.49;28.84;36.81;21.73;70.48;43.91;34.58;39.98;32.01;63.45;55;76.19;42.86;85;40.62;43.23;32.93;27.51 1998-10-23;18.17;28.57;31.49;34.62;43.16;22.6;67.98;54.53;67.03;33.95;28.37;45.63;28.55;28.18;35.86;21.7;70.35;42.4;34.34;40.29;32.04;62.08;53.19;72.45;42.76;85.55;39.86;42.35;33.52;27.27 1998-10-26;17.96;28.74;31.7;34.08;42.07;22.45;67.62;55.51;66.69;33.92;28.14;45.97;28.43;27.56;35.8;22.12;71.1;42.57;33.61;39.44;31.85;62.59;53.53;73.45;42.97;85.73;41.97;42.41;32.23;27.45 1998-10-27;18.13;28.35;31.3;34.44;41.49;21.12;65.8;54.93;68.05;33.15;28.02;46.86;28.36;26.98;35.26;21.71;71.75;41.58;32.07;39.23;32.47;62.64;52.72;73.33;43.4;83.77;42.85;43.26;31.18;26.34 1998-10-28;17.8;28.37;31.42;34.87;40;21.48;65.38;52.45;67.94;33.57;27.84;47.24;28.79;27.85;35.44;22.19;72.65;41.41;32.3;38.87;33.41;62.76;52.84;72.57;44.09;82.55;42.03;44.04;31.95;25.98 1998-10-29;18.52;27.94;31.58;35.17;40.4;22.06;65.62;52.51;69.25;34.64;28.45;46.3;29.47;28.05;34.9;22.32;73.93;41.23;33.38;39.62;33.59;64.64;53.31;74.5;44.31;85.12;42.5;44.94;33.24;26.16 1998-10-30;18.93;28.73;30.84;36.44;41.21;22.78;65.38;53.26;70.67;34.13;28.68;47.81;29.69;28.75;37.17;22.18;73.8;43.21;35.04;39.2;33.31;64.22;52.94;74.5;43.72;86.77;43.5;45.88;34.04;26.47 1998-11-02;18.44;29.96;30.38;40.08;43.1;22.36;68.71;54.41;71.02;34.34;28.64;49.32;29.87;29.62;38.12;22.83;73.74;42.05;34.85;39.23;33.59;65.85;52.91;75.14;44.47;87.87;43.26;46.12;33.92;28.31 1998-11-03;18.64;29.49;30.53;40.08;43.73;21.39;70.58;54.47;69.25;34.79;29;48.99;29.5;28.51;39.26;22.49;73.24;42.75;34.69;39.53;32.66;66.36;52.59;74.85;45.32;87.69;45.02;45.67;32.97;29.05 1998-11-04;19.01;30.65;29.7;39.72;45.73;21.39;69.8;54.76;69.76;34.31;29.09;50.69;31.04;29.37;39.26;23.59;73.49;42.17;35.77;39.38;33.87;65.76;52.75;75.26;45.86;85.24;44.32;46.27;33.55;28.13 1998-11-05;19.17;30.94;30.72;39.72;45.68;21.81;70.34;56.95;69.93;34.73;29.76;50.5;30.92;29.91;39.62;23.39;74.05;43.27;37.24;39.29;33.69;67.49;53.19;76.95;45.8;87.38;45.14;46.78;34.63;29.66 1998-11-06;19.02;31.73;31.52;40.63;45.16;22.36;70.28;57.64;71.13;35.03;29.62;50.74;31.17;29.83;40.57;23.74;74.52;42.92;37.62;39.41;34.28;68.91;54.66;75.43;45.32;88.06;45.44;47.47;35.21;29.72 1998-11-09;18.95;30.94;31.7;41.29;44.42;21.75;69.25;57.06;72.21;34.31;29.09;50.31;30.98;29.91;39.56;23.88;75.23;42.57;35.96;39.53;33.31;69.21;55.34;74.15;45.37;86.65;44.73;47.26;34.78;29.05 1998-11-10;18.8;30.35;31.27;39.96;44.07;21.09;69.8;54.95;71.64;33.42;29.19;51.27;31.41;30.57;39.2;24.27;77.53;42.75;35.27;40.07;35.36;69.81;56.03;71.87;46.18;89.03;45.14;46.9;34.6;28.37 1998-11-11;18.92;30.18;30.93;40.26;41.67;20.54;69.07;54.66;70.9;33.48;28.57;51.69;32.34;30.53;39.73;25.8;78.09;41.41;34.92;40.01;34.52;68.47;55.53;71.92;46.12;88.36;45.32;47.17;34.38;28.37 1998-11-12;18.71;30.12;30.38;40.2;41.95;20.33;68.28;54.95;70.45;34.7;28.39;51.07;32.09;30.32;39.14;25.55;78.46;40.54;34;40.62;35.11;69.12;54.38;71.98;46.07;88.54;44.67;47.92;33.89;28.06 1998-11-13;18.91;30.84;30.22;40.87;43.56;21.03;67.5;56.29;70.67;34.73;28.9;53.55;32.15;30.69;39.14;25.81;78.24;41.76;35.27;40.83;35.46;69.24;55;71.98;46.23;87.63;44.14;48.5;34.35;28.62 1998-11-16;18.47;31.61;30.04;41.48;44.76;21.39;67.74;57.45;70.96;34.04;29.64;55.51;32.58;31.27;40.39;26.59;79.21;42.11;35.69;41.13;35.86;70.04;54.41;75.02;45.59;89.52;44.97;46.93;35.03;28.56 1998-11-17;18.92;32.41;30.1;41.48;45.1;21.97;67.92;56.69;68.62;33.63;29.5;55.74;29.6;31.6;40.57;26.99;78.52;42.4;37.78;40.95;34.46;70.07;55.94;74.5;46.39;87.5;46.26;47.68;35.31;28.56 1998-11-18;18.98;33.3;30.25;41.54;44.02;21.45;68.65;56.64;69.36;33.69;30.07;55.41;29.47;32.09;40.65;27.34;79.02;42.81;38.12;41.46;34.46;71.02;54.88;77.31;46.76;87.08;45.44;48.19;36.17;28.49 1998-11-19;19.01;33.06;31.05;41.84;43.84;21.54;69.07;56.29;69.48;33.3;30.34;55.32;29.1;32.42;39.46;28.08;78.8;42.34;37.93;41.79;35.3;71.47;55.88;77.9;47.35;88.06;46.32;48.76;35.98;27.82 1998-11-20;19.13;34.1;31.24;42.26;44.82;21.84;70.46;56.46;69.93;34.31;30.38;54.79;28.49;32.55;40.05;27.88;79.58;43.04;38.2;42.94;35.33;72.04;56.81;78.37;47.67;89.46;46.79;50;36.35;28 1998-11-23;19.25;35.52;31.52;42.51;46.08;23.75;73;56.58;68.79;34.34;31.01;55.93;30.37;33.41;41.01;28.25;82.78;42.87;40.09;42.46;35.98;74.17;59.59;80.14;49.81;91.54;47.31;51.36;36.94;28.98 1998-11-24;18.67;34.04;30.9;40.99;45.91;24.54;71.13;55.65;69.19;34.64;30.89;55.55;31.04;33.21;42.81;27.48;82.13;41.17;39.97;41.13;35.77;75.42;60.84;78.67;49.7;89.95;47.31;52.48;36.85;29.29 1998-11-25;18.7;33.77;31.18;41.48;45.79;25.39;70.94;55.53;68.45;34.64;30.54;54.84;30.86;33.5;42.75;27.31;82.87;40.29;40.47;39.95;35.86;75.36;62.12;79.02;49.7;88.48;47.31;53.84;37.34;30.4 1998-11-27;18.74;33.73;31.12;40.2;45.51;25.63;69.51;55.65;68.57;35.44;30.25;54.46;30.64;34.16;42.93;27.37;84.49;40.35;40.36;39.68;35.86;75.54;64.03;77.67;49.7;87.38;46.96;54.02;37.74;31.32 1998-11-30;17.8;32.63;30.68;39.41;45.33;24.36;67.94;54.61;66.62;35.74;29.62;53.27;30.83;32.84;42.15;26.78;82.06;40.65;39.12;39.2;34.8;73.76;61;75.84;47.83;85.73;45.02;51.81;37.12;31.63 1998-12-01;17.5;32.41;30.65;39.17;47.63;24.24;67.76;53.68;66.85;34.13;29.86;54.7;30.64;33.56;42.15;28.61;84.42;41.35;38.31;39.08;35.11;74.65;64.75;76.66;48.74;86.04;45.26;51.45;36.91;30.95 1998-12-02;17.89;32.85;30.75;32.68;46.48;24.39;67.45;52.98;67.14;33.95;29.8;53.65;31.23;33.06;40.47;28.25;83.21;41;38.85;38.84;34.99;75.56;63.38;76.25;48.53;87.93;45.02;49.13;36.51;30.64 1998-12-03;17.51;31.51;30.68;30.93;45.79;23.36;66.06;50.9;67.02;33.63;28.86;51.84;30.64;32.73;41.01;27.24;81.26;40.65;37.78;38.38;34.37;73.89;61.06;74.84;47.35;86.59;45.38;48.85;35.25;30.34 1998-12-04;17.27;32.16;31.3;31.96;44.7;24.03;66.91;51.13;67.48;34.07;29.54;52.98;31.35;33.6;41.97;28.94;81.63;40.7;39.55;39.44;34.77;75.21;63.69;75.6;47.51;90.01;47.08;49.28;36.08;30.83 1998-12-07;17.8;32.67;31.95;33.71;45.1;23.78;66.54;51.71;67.88;34.79;29.76;52.98;31.84;34.8;42.75;29.59;83.09;40.88;40.09;39.38;34.77;75.24;66.78;72.6;47.14;88.42;47.31;50.76;36.79;30.58 1998-12-08;17.87;31.63;33.06;33.41;44.65;23.51;66.54;50.9;67.14;34.88;29.64;52.74;32.64;36.08;42.03;29.87;83.59;40.06;39.86;38.38;35.55;75.71;65.59;73.37;46.6;84.88;46.49;51;37.46;31.44 1998-12-09;17.8;31.51;35.03;33.53;44.02;23.87;65.09;50.26;66.51;35.23;29.5;52.65;32.55;36.08;42.03;29.65;84.21;39.77;39.36;38.54;34.93;72.49;66.81;73.25;46.55;82.31;46.02;51.51;37.87;32.98 1998-12-10;17.42;31.67;35.03;33.05;43.16;23.24;64.06;49.27;66.16;35.15;28.98;52.65;31.44;34.76;40.77;28.52;82;38.72;38.7;38.23;33.65;69.78;65.78;70.19;44.73;81.94;46.61;50.94;37.38;31.87 1998-12-11;17.48;30.57;34.57;32.14;42.75;23.15;60.97;48.46;66.05;35.56;29.19;52.5;32.24;35.13;39.46;28.97;83.49;38.07;37.54;38.51;33.9;69.45;67;68.95;45.6;83.22;46.79;50.12;37.66;31.44 1998-12-14;17.48;29.84;33.83;32.56;42.41;22.33;61.51;50.09;65.01;35.47;28.45;50.12;31.29;33.64;38.74;27.76;80.95;38.89;36.27;38.05;33.16;69.45;63.97;70.13;44.63;84.75;45.2;48.58;36.92;30.09 1998-12-15;17.03;30.9;34.17;32.32;40.75;23.63;63.94;49.97;65.76;35.26;30.52;51.22;32.46;35.83;40.23;28.84;82;39.48;37.47;38.96;33.62;69.6;65.94;69.48;46.19;87.57;46.26;49;37.9;30.21 1998-12-16;17.18;30.49;34.32;31.17;37.94;23.09;62.91;48;67.02;36.01;30.15;53.36;31.94;35.17;40.05;28.39;81.69;38.95;39.16;38.66;34.83;70.49;66.88;67.24;46.08;85.98;46.61;47.89;37.35;30.21 1998-12-17;16.88;32.16;35.49;30.99;37.71;24.24;62.79;50.32;67.36;35.68;30.91;54.89;32.31;35.7;41.49;29.08;82.53;38.83;43.09;38.6;35.73;70.58;67.19;69.01;45.71;85.49;46.2;47.65;37.56;30.34 1998-12-18;16.63;32.75;36.02;30.8;38.4;24.18;63.57;49.27;68.17;36.19;31.75;54.51;32.43;37.81;41.31;29.86;85.26;39.07;42.86;38.35;37.35;68.94;68.91;66.65;44.84;85.43;46.96;48.04;38.37;30.27 1998-12-21;16.69;32.85;36.61;30.86;38.74;24.78;63.76;50.9;67.65;35.65;32.24;56.17;32.55;38.92;40.71;30.52;87.65;40.18;44.56;37.09;38.5;68.74;70.22;66.42;45.11;85.36;50.01;50.39;38.8;30.46 1998-12-22;16.6;33.14;36.17;30.86;38.8;24.45;65.39;50.26;67.36;35.71;32.47;56.32;32.55;39.13;40.77;29.62;90.57;40;44.25;37.15;38.19;70.32;69.22;66.65;46.03;88.06;48.72;50.49;38.64;29.41 1998-12-23;17.15;33.71;37.01;30.93;39.03;25.09;67.82;50.95;67.25;35.77;33.22;55.27;33.41;39.63;41.79;31.1;91.94;40.24;43.94;38.02;38.19;71.39;71.78;67.89;47.16;91.48;49.54;52.36;40.19;30.4 1998-12-24;17.33;33.71;36.79;31.29;39.37;25.03;67.33;51.88;67.08;35.56;33.08;55.98;33.45;39.63;41.49;31.1;93.4;40.59;43.63;38.29;37.91;71;70.88;69.25;47.38;91.72;49.66;51.57;40.03;30.03 1998-12-28;17.29;33.24;37.01;31.53;41.21;24.75;66.79;52.52;66.28;35.5;33.33;55.32;34.06;39.21;42.33;30.38;94.05;40.88;44.02;38.87;37.41;70.61;71.19;70.07;46.57;91.11;50.37;52.6;39.41;29.91 1998-12-29;17.39;34.24;38.98;31.11;41.84;24.72;67.21;52.4;66.28;36.04;33.84;56.03;33.63;40.66;42.81;30.12;93;41.7;44.41;40.41;38.25;72.08;70.25;70.78;46.73;91.48;50.84;53.08;40.43;29.91 1998-12-30;17.8;34.18;37.9;30.86;41.9;24.51;65.76;51.42;65.93;35.56;33.53;55.6;34.46;40.49;42.69;29.65;92.81;40.94;44.41;40.53;38.9;71;69.5;68.95;47;90.26;50.25;53.23;39.85;29.35 1998-12-31;17.87;33.43;37.38;31.65;42.18;24.09;64.97;49.22;66.05;34.85;33.43;54.55;33.66;40.41;42.45;29.5;91.63;41.93;43.79;40.47;38.16;70.38;69.34;67.01;46.14;89.34;50.37;52.57;40.19;29.48 1999-01-04;17.68;33.1;38.42;31.96;43.44;24.39;65.15;51.24;65.3;34.61;32.96;54.03;33.97;38.84;41.73;30.06;90.95;39.42;44.55;39.89;38.22;71.45;70.5;70.31;45.33;88.06;49.43;52.21;39.78;29.05 1999-01-05;18.04;32.47;39.23;34.2;43.33;24.84;66.48;52.58;65.59;34.31;33.65;56.89;34.34;38.55;41.97;30.66;94.24;40.06;44.9;40.04;38.06;71.93;73.25;70.72;45.17;89.58;49.43;53.75;40.09;30.03 1999-01-06;18.76;33.87;40.89;34.99;44.47;26.36;68.12;53.91;67.31;35.68;34.31;59.51;35.29;39.21;42.81;32.22;93.8;40.53;45.87;40.53;38.65;73.33;75.62;74.01;45.81;90.62;50.94;54.32;40.77;30.4 1999-01-07;18.52;34.28;40.58;34.75;44.88;28.36;67.33;53.74;66.62;35.62;33.74;59.13;35.91;38.59;42.39;32.16;94.52;39.83;47.77;40.13;38.68;72.67;75.25;72.31;46.19;88.91;52.71;53.75;41.51;31.2 1999-01-08;20.4;35.32;41.97;34.75;46.77;28.09;65.94;55.19;66.33;35.41;33.55;61.03;36;38.39;42.33;32.27;93.21;42.58;46.8;40.16;39.99;73.39;74.94;72.66;47.11;87.26;54.42;55.44;41.2;31.99 1999-01-11;21.14;34.73;42.13;34.08;48.6;28;64.06;55.19;69.03;33.95;32.67;65.61;35.48;37.31;41.67;34.77;94.05;43.04;47.27;38.69;38.68;71.9;73.75;74.01;47.65;85.36;52;54.23;40.28;34.63 1999-01-12;20.43;33.46;41.57;33.05;46.42;27.03;63.45;53.62;73.04;33.72;32.04;63.27;34.71;35.83;41.01;33.73;91.97;43.51;45.79;38.51;37.41;70.58;71.09;73.25;46.84;86.53;50.71;53.78;39.66;37.34 1999-01-13;20.1;32.25;41.82;32.68;44.07;25.3;63.21;52.87;72.18;33.6;31.65;62.27;35.23;35.68;39.99;34.58;92.19;41.76;44.4;37.15;38.25;70.32;71.91;70.89;46.73;86.1;51.18;53.6;39.78;35.49 1999-01-14;19.56;31.38;40.52;32.5;42.87;24.66;61.57;50.9;64.67;33.24;31.81;61.75;34.58;36.28;39.28;33.28;89.77;41.29;42.31;37.66;37.78;69.06;70.88;67.95;45.71;83.35;51.18;52.48;39.35;35.43 1999-01-15;20.63;34.11;41.57;32.68;43.9;24.97;62.85;52.87;63.29;33.86;33.02;63.51;34.74;36.24;40.77;33.68;91.91;41.99;43.93;38.6;38.5;70.2;74.88;70.25;45.06;84.75;52.77;53.02;39.54;35.37 1999-01-19;20.6;32.85;45.09;32.44;42.4;25;62.18;51.88;63.07;33.86;33.24;67.08;34.25;36.61;39.82;34.68;95.54;40.59;46.1;38.81;39.34;70.49;77.81;68.54;43.82;84.57;55.66;52.69;39.51;35.86 1999-01-20;20.1;33.34;45.15;33.23;41.7;25.81;61.51;50.55;62.49;33.83;32.9;67.8;35.35;37.85;39.22;34.4;96.66;38.36;47.81;39.08;38.62;71.03;81.31;65.83;41.77;82.92;55.19;54.14;39.6;35.37 1999-01-21;20.13;33.5;43.45;32.38;41.42;25.42;59.7;50.14;59.85;33.89;32.55;68.56;34.58;37.44;38.08;33.21;97.9;39.59;46.72;38.6;38.09;69.81;79.16;68.38;39.83;84.63;53.95;55.08;39.01;33.96 1999-01-22;19.47;32.19;43.54;33.47;40.55;25.03;59.03;50.38;60.08;34.01;32.08;69.18;34.31;36.94;37.96;32.06;89.33;38.36;44.55;37.87;37.75;66.32;78.12;67.18;39.99;83.47;53.42;55.38;40.46;33.53 1999-01-25;19.92;33.17;44.22;34.93;41.13;25.81;61.03;50.78;59.63;34.31;32.94;68.42;35.17;38.14;37.9;32.5;90.45;39.36;46.14;37.99;37.69;65.6;80.94;70.78;40.48;81.82;51.24;55.98;40.46;34.33 1999-01-26;19.95;33.26;42.87;33.96;41.65;26.9;60.67;49.97;60.77;34.43;33.43;69.56;35.79;38.51;38.38;34.07;92.25;40.24;46.03;39.8;39.21;68.71;85.78;71.48;41.61;83.71;50.94;56.68;41.23;33.96 1999-01-27;19.61;32.5;42.09;34.08;41.24;26.18;62;49.27;59.28;33.83;33.26;71.18;35.66;39.79;37.84;33.03;88.62;38.25;45.33;40.34;38.99;68.59;84.31;69.89;40.05;84.45;50.83;56.01;42.04;32.36 1999-01-28;20.07;32.83;44.38;33.59;41.07;26.99;63.15;48.87;58.31;33.83;33.9;70.18;36.4;39.63;37.54;34.13;88.8;37.49;45.64;40.89;38.81;67.96;87;71.25;41.99;85.92;51;56.53;42.01;32.92 1999-01-29;20.03;33.62;44.78;33.65;39.97;27.27;63.33;47.48;59.97;33.48;34.37;68.42;38.62;39.96;37.36;35.06;91.07;37.02;47.69;41.07;39.15;70.02;87.5;73.13;40.42;88.91;50.94;57.74;42.44;32.42 1999-02-01;19.88;32.93;46.17;33.05;40.32;26.51;62.06;47.24;60.31;33.18;33.49;71.18;40.37;39.05;37.48;34.3;89.33;37.43;47.61;40.37;39.43;70.11;86.47;72.54;39.67;88.67;49.59;58.64;41.7;33.1 1999-02-02;19.61;32.58;45.36;33.17;39.97;25.81;63.27;47.82;60.43;32.73;33.43;68.55;37.97;38.06;37.84;33.49;87.84;38.54;47.61;40.01;39.27;71.72;83.81;71.48;39.88;86.59;49;58.61;41.26;32.79 1999-02-03;20.01;32.85;46.87;35.72;39.8;26.45;62.54;49.27;61.23;33.54;33.72;68.55;38.68;38.72;37.6;34.52;87.1;38.89;49.2;40.71;40.42;71.51;83.41;70.31;40.37;86.95;48.53;59.22;42.31;33.04 1999-02-04;20.88;32.77;45.12;35.41;40.72;25.84;61.64;50.72;63.29;33.27;32.81;66.73;37.14;38.06;37.96;32.39;84.27;41.35;48.31;40.47;40.11;71.69;79.53;72.07;40.21;85.92;47.88;59.25;41.33;32.55 1999-02-05;21.56;32.07;43.73;36.14;42.68;25.72;60.18;51.13;63.07;34.16;32.12;65.86;35.45;36.9;41.25;31.75;82.5;41.81;47.38;40.53;39.89;71.27;80;73.66;39.78;83.04;48.05;60.43;41.57;33.65 1999-02-08;21.32;31.72;44.9;35.29;43.61;25.54;59.64;51.88;61.8;34.64;31.97;65.86;35.42;36.65;41.01;32.86;83;40.41;45.33;40.53;40.17;71.51;82.62;72.07;39.45;84.45;48.47;58.01;42.16;33.41 1999-02-09;21.22;31.36;43.11;34.44;42.92;24.62;60.06;49.91;60.49;34.4;31.46;64.91;34.8;35.83;40.83;31.19;80.88;39.71;44.63;39.89;39.86;69.36;80.03;70.89;39.13;84.39;49.17;58.13;40.52;32.92 1999-02-10;20.86;31.62;42.34;34.56;42.4;25.47;61.7;50.88;60.43;34.58;32.1;64.95;35.66;36.7;40.95;32.06;83.93;39.48;45.29;40.44;39.68;69.78;80.31;71.01;35.73;86.1;49.06;57.52;39.94;33.47 1999-02-11;20.8;33.01;43.51;34.81;42.05;26.08;62.42;50.41;60.37;33.54;32.77;65.72;37.08;38.47;41.91;33.17;88.71;38.72;47.19;40.95;40.73;71.93;81.38;72.42;34.82;86.53;49.29;58.73;42.34;34.57 1999-02-12;20.4;32.66;42.37;34.5;41.36;25.23;61.94;50.41;59.97;33.09;32;64.24;37.66;37.56;41.19;31.49;85.85;39.94;45.91;40.95;40.39;71.81;78.88;72.9;34.87;85.61;47.94;57.52;41.63;34.82 1999-02-16;19.48;33.4;41.76;34.75;41.76;25.99;62.91;49.3;59.63;32.67;32.45;63.66;34.74;38.35;41.43;31.46;85.73;39.24;48.16;41.92;40.64;73.45;78.12;72.01;34.17;87.75;47.99;58.73;43.21;34.45 1999-02-17;19.06;33.56;41.6;34.5;42.22;25.81;62.36;49.25;58.99;32.7;32.55;63.28;33.57;38.31;40.15;31.02;84.73;38.12;47.89;41.49;39.99;72.7;75;72.19;33.31;88.36;48.11;59.03;41.97;34.27 1999-02-18;19.73;33.54;42.37;34.81;41.36;25.75;62.67;48.25;58.54;32.82;32.98;65.58;33.48;38.59;40.87;31.89;86.6;39.24;47.27;41.77;41.2;74.31;72.88;72.43;33.74;89.65;49.41;59.67;42.13;33.9 1999-02-19;19.99;33.73;42.31;34.62;41.59;26.36;63.76;49.25;60.71;32.64;32.9;65.48;33.66;39.96;40.75;31.88;85.29;39.59;47.15;41.92;42.5;75.39;73.88;72.84;34.44;89.83;48.76;60.82;41.82;33.53 1999-02-22;20.04;35.46;42.71;35.17;42.92;26.96;62.48;50.24;62.78;32.49;34.08;67.06;36.4;40.62;41.48;33.06;88.43;40.65;50.21;42.55;42.53;78.01;74.41;74.5;35.25;90.99;51.47;61.33;43.55;34.27 1999-02-23;19.93;36.48;42.4;36.26;43.32;28.3;60.85;49.95;63.7;32.29;33.76;65.58;36.03;40;40.51;33.42;87.93;40.42;50.75;42.28;42.56;77.35;77.72;73.85;35.36;88.79;49.23;60.63;43.18;34.27 1999-02-24;19.99;35.2;41.72;34.56;42.45;27.69;60.91;49.71;63.24;32.34;33.1;65.15;34.86;39.38;40.69;32.45;86.35;40.3;48.85;41.49;42.22;75.86;76.44;72.31;34.98;87.63;50.94;60.18;41.73;34.45 1999-02-25;19.79;35.26;41.69;33.96;42.17;27.54;62.3;49.65;61.74;32.08;32.9;64.09;35.08;39.5;40.87;31.8;86.29;39.77;49.28;40.86;41.76;77.11;76.75;71.42;34.55;87.87;49.65;59.15;41.94;33.9 1999-02-26;19.51;35.46;40.52;34.56;42.05;28.57;61.94;47.9;61.1;31.72;32.88;63.28;32.74;39.42;39.79;29.85;84.36;39.54;49.36;41.31;42.22;77.77;75.06;70.29;33.74;87.57;49.88;60.06;42.5;34.57 1999-03-01;19.93;36.44;40.09;34.44;45.4;29.79;61.76;48.95;60.76;31.06;33.08;63.71;32.46;39.42;40.33;29.14;83.68;38.54;50.06;41.34;43;76.1;75.88;69.82;33.52;86.59;49;60.42;42.38;34.2 1999-03-02;19.09;35.85;40.4;33.53;43.78;28.7;60.24;47.9;60.07;30.89;32.55;63.37;33.81;38.94;40.03;27.33;83.37;38.01;49.78;41.16;44.65;75.8;74.28;70.59;33.69;88.24;48.94;60.42;42.16;33.59 1999-03-03;18.67;35.24;41.14;32.93;43.61;28.15;59.76;46.91;59.43;31.3;32.36;63.52;33.91;39.77;40.51;28.55;82.87;37.95;50.02;40.98;44.15;75.1;74.81;71;33.9;89.34;46.29;59.79;43.12;33.9 1999-03-04;18.85;36.93;41.66;33.84;44.24;29.33;61.03;48.37;59.49;32.32;32.94;65.72;33.23;40.06;42.02;28.22;84.98;37.71;51.68;42.07;44.77;77.02;76.12;71.36;34.44;90.01;46.58;60.82;44.1;34.57 1999-03-05;19.36;38.77;43.17;34.5;46.03;30.03;62;50;60.12;33.21;33.98;67.92;33.57;41.13;42.98;28.53;88.65;38.01;53.85;43.07;46.85;79.23;77.47;73.2;34.49;91.97;48.88;62.57;46.01;35.19 1999-03-08;19.06;38.1;43.42;33.78;45.8;30.16;62.06;50.3;60.41;33.8;34.35;67.16;34.43;41.71;43.82;29.78;88.9;38.65;53.19;43.1;44.96;79.41;79.5;72.96;33.96;90.99;48.41;61.57;46.11;35.8 1999-03-09;18.24;38.65;42.22;32.93;45.05;30.4;61.09;50;60.41;33.33;34.74;67.78;33.35;42.41;43.76;28.7;90.54;38.42;54.51;42.4;43.22;79.59;80.91;73.85;34.44;90.38;49.06;61.21;46.38;34.08 1999-03-10;18.73;38.44;41.45;33.17;45.22;31.13;60.97;53.56;60.59;34.94;34.66;67.35;33.81;42.91;43.34;29.09;90.2;39.24;55.13;42.34;43.47;79.29;80.69;76.4;34.76;90.2;48.76;61.09;46.17;33.9 1999-03-11;18.79;40.36;40.74;33.53;46.95;32.07;64.53;54.26;61.51;35.62;35.09;68.74;33.91;43.2;43.76;29.4;90.88;38.89;54.67;42.98;44.4;79.29;80.72;76.04;34.77;90.13;50.29;61.79;47.03;34.08 1999-03-12;18;41.26;40.18;34.08;41.24;32.07;67.5;53.91;61.51;35.23;35.19;68.21;34;43.12;43.76;29.43;88.46;39.42;54.55;42.85;43.22;80.31;80.09;76.28;34.28;88.36;50.06;61.82;47.56;35.43 1999-03-15;18.18;41.1;40.68;33.65;41.93;32.07;66.77;52.51;61.62;35.12;36.09;68.64;35.26;42.91;44.72;29.34;90.45;40.77;54.08;44;43.9;80.67;82.94;75.63;33.68;89.71;50.18;62.73;47.74;35.25 1999-03-16;18.21;40.38;40.68;35.17;40.61;31.37;66.77;51.58;62.49;34.85;36.05;68.31;35.82;42.29;44.24;29.96;89.95;41.07;52.57;43.67;43.65;82.22;84.53;74.56;33.57;89.95;50.35;62.85;47.37;34.45 1999-03-17;18.91;39.53;41.45;34.68;43.61;30.52;64.95;51.76;62.89;35.44;35.54;68.16;36.06;41.71;42.74;29.99;88.49;41.83;51.06;43.52;43.28;80.43;83.56;72.48;33.35;89.58;48.47;63.15;47.61;33.9 1999-03-18;19.57;41.71;40.52;34.08;43.2;31.46;66.35;53.04;62.55;35.59;36.05;68.59;36.46;43.03;43.16;30.32;88.28;42.89;51.99;43.46;43.47;82.34;86.22;69.88;36.62;90.75;49.17;64;48.5;34.82 1999-03-19;20.41;40.24;39.29;32.99;43.2;31.25;65.62;52.86;61.62;34.82;36.71;68.83;34.92;41.79;44.18;29.62;83.77;43.36;51.14;44.06;43.34;82.34;85.59;67.86;35.64;91.6;48.11;65.39;46.8;34.45 1999-03-22;19.93;40.16;38.36;33.84;43.32;30.95;65.8;53.45;61.16;35.15;36.17;69.17;34;41.22;44;28.66;83;43.77;50.75;44.34;42.35;82.7;86.41;68.75;36.46;93.44;47.58;64.6;46.09;33.77 1999-03-23;19.27;39.65;38.3;33.11;41.65;29.73;64.04;52.75;60.59;34.67;34.92;65.58;33.11;39.94;43.28;28.52;82.19;42.6;49.32;43.67;42.1;79.47;83.28;67.98;35.31;91.66;45.81;63.03;44.7;32.61 1999-03-24;19.75;38.28;39.87;33.29;42.4;29.24;63.55;52.28;60.12;33.8;34.99;65.62;33.17;39.73;44.9;29.68;84.24;42.01;49.2;43.88;42.72;78.87;85.62;67.74;35.64;93.31;46.82;62.33;43.96;32.61 1999-03-25;20.29;40.04;40.4;33.59;43.78;30.64;64.04;52.34;60.59;34.04;35.56;66.82;33.32;42.04;46.16;29.36;85.14;42.65;50.52;44.52;43.9;79.05;89.97;67.27;35.31;98.33;45.87;63.42;45.38;32.79 1999-03-26;19.51;39.47;40.98;33.78;43.2;30.82;63.49;51.81;60.24;34.1;35.33;67.4;33.85;42.12;48.45;29.04;85.67;41.65;49.9;44.19;44.09;76.96;89.06;66.73;34.93;97.11;44.81;64;45.23;32.36 1999-03-29;20.14;40.3;40.31;33.71;43.61;31.19;63.01;53.45;60.59;34.79;36.71;67.06;34.31;42.37;48.81;30.26;88.4;41.59;50.99;45.46;45.2;78.28;92.38;67.68;35.91;98.94;45.58;65.18;46.93;32.49 1999-03-30;19.57;39.78;39.66;32.99;43.32;31.19;61.49;54.15;59.89;33.98;37.14;66.97;34;41.96;48.27;30.26;88.74;39.83;50.79;45.03;44.71;78.75;93;66.67;32.91;98.02;43.87;65.76;46.93;32.24 1999-03-31;19.84;38.56;39.38;32.99;42.4;31.07;59.67;54.21;58.97;33.63;36.26;66.68;33.41;41.13;47.31;29.59;88.09;39.71;50.44;45.24;45.02;76.72;89.62;67.15;30.68;95.82;44.52;65.67;45.54;30.58 1999-04-01;19.69;39.62;38.73;32.93;43.32;31.46;59.24;54.67;58.97;33.42;36.58;65.48;33.45;40.68;48.33;30.09;87.97;40.95;49.45;45.55;45.33;76.54;92.69;69.04;30.13;96.31;46.93;65.06;46.06;30.95 1999-04-05;19.63;41.07;38.21;33.29;45.28;32.34;58.82;55.49;58.85;34.4;37.57;67.11;35.2;41.67;50.19;31.74;91.41;40.95;49.06;45.91;46.07;74.86;94.94;69.28;30.63;98.7;47.94;65.94;47.11;30.95 1999-04-06;19.78;40.36;39.54;33.35;44.65;32.59;58.15;54.38;58.1;34.64;37.14;69.79;34.49;41.13;49.47;32.47;90.95;41.07;49.37;45.61;45.76;74.74;94.06;68.27;30.3;98.45;47.76;65.63;47.27;30.09 1999-04-07;21.19;41.4;41.88;33.84;44.76;34.87;57.3;54.61;57.64;34.88;37.53;66.44;34.37;42;50.91;32.89;92.69;41.48;52.57;45.91;46.45;76.78;93.31;67.68;29.26;98.57;49.47;65.24;48.16;32.3 1999-04-08;20.71;41.83;41.39;33.59;44.88;35.51;59.18;55.43;57.18;35.38;37.32;67.35;35.14;44.06;50.61;32.62;92.93;41.36;54.75;47.06;46.57;78.16;94.56;68.04;29.92;98.57;50.24;64.88;50.51;33.47 1999-04-09;21.1;42.03;42.19;34.02;44.99;35.81;59.06;54.91;58.1;35.59;36.77;65.62;34.31;44.48;50.07;32.56;92.59;41.59;53.31;47.42;45.51;79.71;94.25;67.56;30.46;99.25;49.23;63.88;50.76;33.9 1999-04-12;21.71;44.33;43.39;33.78;47.41;35.99;60.15;57.01;58.16;35.95;38.18;67.54;33.69;44.19;51.09;30.49;91.16;43.65;54.12;48.21;45.58;81.39;93;67.38;31.39;100.71;51.13;64.12;51.8;34.82 1999-04-13;22.49;45.35;43.42;33.59;50.53;36.6;61.55;56.77;58.85;35.83;38.32;69.31;34.89;42.74;51.03;30.12;89.46;45.77;54.44;47.72;46.2;79.59;90.12;69.16;30.73;100.65;49.47;64;51.65;34.14 1999-04-14;25.65;44.69;42.43;36.87;56.01;35.69;61.67;60.92;59.32;35.35;37.38;68.79;34.98;41.96;51.27;28.38;89.15;49.18;53.81;45.82;44.89;75.16;85.88;71.42;30.19;96.98;48.82;66.42;48.72;34.39 1999-04-15;25.92;43.77;41.39;40.45;57.05;34.56;62.46;63.31;61.45;36.96;36.87;66.34;34.86;41.63;53.98;29.09;88.34;52.13;53.31;44.61;43.96;74.09;88.88;75.21;30.46;94.42;48.34;68.6;48.29;33.47 1999-04-16;25.38;42.53;41.45;38.44;58.89;34.84;63.86;63.25;67.39;38.09;36.46;67.4;34.68;41.83;54.34;28.5;84.67;51.77;53.62;45.06;44.15;74.33;86.62;75.87;30.3;96.07;49.47;68.85;46.93;32.79 1999-04-19;26.34;41.3;39.87;38.38;56.99;34.35;63.13;63.6;69.01;39.2;34.33;68.98;35.17;38.74;54.76;27.63;82.87;54.36;52.96;43.67;42.72;70.02;81;79.96;28.88;92.58;50.18;70.3;44.33;31.87 1999-04-20;25.47;41.75;40.71;38.08;56.01;35.41;63.43;64.12;69.64;38.48;35.83;66.82;35.17;39.98;53.02;28.16;84.36;50.6;51.71;46.57;43.84;72.05;83.12;77.47;29.86;93.74;51.78;68.82;47.17;32.49 1999-04-21;25.35;44.16;42.19;39.17;56.93;35.99;65.68;64.36;68.61;37.38;37.22;68.26;37.02;41.22;53.14;29.09;85.42;50.3;51.98;48.75;45.08;72.65;82;78.42;29.64;96.8;53.97;66.36;48.16;32.85 1999-04-22;25.77;44.92;42;39.11;55.47;36.48;64.65;61.73;67.62;37.62;37.12;67.97;37.76;41.09;54.34;30.62;96.66;50.18;53.42;49.6;44.4;74.56;84.94;75.87;30.08;92.09;53.74;66.91;49.46;32.85 1999-04-23;26.01;44.33;39.5;39.29;56.17;36.42;64.65;62.49;68.26;37.32;36.99;68.31;38;41.26;53.68;30.74;99.27;51.89;53.03;49.24;43.84;72.53;86;76.7;30.63;88.55;52.67;67.42;50.32;33.9 1999-04-26;25.65;43.98;39.18;38.38;57.5;35.9;65.26;62.32;70.74;37.02;37.2;68.12;39.17;40.18;53.86;32.08;104.3;52.54;51.48;48.48;43.15;70.85;88;77.7;29.97;92.76;51.96;67.48;50.32;34.39 1999-04-27;26.67;45.43;39.23;38.2;58.95;36.72;67.5;64.53;71.66;37.29;36.87;67.83;39.48;40.6;53.86;30.99;105.36;52.48;53.31;49.33;42.97;70.44;84;76.7;30.3;91.54;52.2;69.76;50.14;31.93 1999-04-28;29.87;43.57;40.11;39.29;59.88;36.27;66.05;68.62;69.88;38.84;36.54;67.68;39.08;40.76;56.8;30.46;101.88;54.01;52.1;48.15;42.22;67.74;82.12;80.2;30.13;90.38;52.61;69.94;48.59;31.93 1999-04-29;31.16;44.33;39.32;39.17;60.75;37.22;65.92;67.92;71.32;40.27;35.27;68.98;38.62;39.23;57.94;30.27;101.79;52.95;52.26;47.75;41.6;67.38;82.06;81.26;30.68;91.48;52.85;69.91;46.31;29.84 1999-04-30;29.99;42.79;37.38;39.41;59.7;36.52;66.17;65.99;69.01;39.58;34.53;68.26;38.87;39.48;56.5;30.46;103.96;50.18;51.4;47.18;42.1;67.38;81.31;84.47;30.57;91.79;52.85;70.24;45.44;31.2 1999-05-03;29.26;43.67;37.79;41.72;60.46;36.58;67.08;66.98;69.47;41.01;34.62;71.85;39.39;40.51;58.67;31.42;105.48;52.13;51.56;47.3;41.98;67.68;79.88;89.09;31.61;92.21;51.9;71.94;45.57;30.7 1999-05-04;29.53;41.63;38.16;41.84;60.69;35.24;66.77;65.06;71.78;41.19;34.39;68.21;39.17;39.15;58.97;30.71;105.36;52.54;51.24;45.97;40.55;67.86;78.06;89.15;32.8;89.77;51.72;71.57;43.47;30.21 1999-05-05;29.09;42.36;42.14;42.81;60.4;35.48;68.54;66.23;71.72;40.42;35.72;66.63;39.54;38.86;58.67;31.88;105.42;53.19;49.96;45.49;40.36;69.72;79.12;87.67;32.8;89.22;51.84;70.84;44.52;29.54 1999-05-06;30.81;42.89;45.84;43.6;60.63;34.05;67.2;67.86;72.01;39.26;35.48;65.43;38.1;37.66;59.21;29.73;103.99;54.48;48.32;47.24;40.55;71.21;77.94;87.43;31.88;90.13;50.71;70.05;42.36;29.35 1999-05-07;30.87;44.1;44.73;44.39;58.6;34.2;65.86;69.2;72.76;39.52;36.03;66.39;39.39;37.87;62.15;30.35;107.97;53.77;48.83;46.51;39.74;71.33;79.06;88.14;32.26;88.97;51.37;70.44;44.21;29.48 1999-05-10;31.44;42.89;43.76;42.75;57.27;34.78;65.19;69.9;72.88;39.26;35.64;65.58;39.6;37.25;62.45;30.19;108.65;52.83;49.22;45.18;39.24;69.06;79.69;89.39;33.13;88.3;50.18;71.84;44.64;29.23 1999-05-11;31.44;41.85;43.16;42.14;58.6;35.36;65.07;69.49;72.01;38.9;36.36;66.11;39.7;39.15;61.13;31.04;109.83;50.71;49.84;44.91;41.54;68.52;79.88;90.16;33.19;89.65;50;72.6;46.74;28.92 1999-05-12;30.36;41.26;44.5;41.43;56.34;36.06;64.59;66.66;72.64;37.68;36.11;68.13;41.02;38.99;59.87;31.13;112.07;51.07;51.28;45.82;41.48;68.52;80.5;89.09;33.35;90.93;50.54;71.14;46;28.68 1999-05-13;29.96;40.85;45.1;41.67;56.23;35.82;63.92;67.18;72.99;37.83;35.83;66.3;42.87;38.94;59.57;29.91;122.26;50.24;52.33;46.09;40.61;69.9;79.12;86.31;34.33;90.01;50.42;70.9;46.43;28.86 1999-05-14;30.21;39.62;43.62;41.85;56.57;34.63;63.43;66.48;71.66;37.53;34.72;64.08;41.48;38.41;58.13;28.89;118.9;50.01;49.26;45.07;40.11;68.22;76.88;85.71;34;90.32;50.3;68.77;45.82;28.86 1999-05-17;30.51;39.82;44.13;41.37;56.69;34.14;65.26;65.54;70.86;37.65;34.82;61.91;43.73;38.61;58.13;29.6;118.03;49.89;48.99;44.53;39.43;68.88;79.12;84.7;34.33;92.09;49.53;66.95;45.14;28.49 1999-05-18;29.6;40.72;43.76;42.52;54.43;33.69;66.84;64.84;68.43;37.05;34.17;62.44;47.3;39.07;58.89;29.35;118.53;49.54;49.06;43.86;40.42;67.32;78.69;83.58;34.17;91.85;48.05;64.52;45.88;29.05 1999-05-19;29.48;40.89;43.34;43.19;53.79;34.36;66.53;65.37;68.72;37.5;35.4;61.43;46.23;38.2;59.37;29.73;117.22;51.07;49.96;45.32;40.17;67.5;79.31;85.37;35.53;92.95;48.58;63.79;45.14;29.41 1999-05-20;28.18;40.4;43.85;43.44;54.66;33.66;66.05;64.78;69.76;38.12;34.88;61.77;46.32;38.32;58.65;28.73;115.73;51.84;49.96;46.11;39.8;69.18;78.44;85.43;35.04;94.6;49.29;61.3;43.96;29.29 1999-05-21;28.97;39.37;43.99;43.74;55.3;33.08;66.11;64.02;67.39;39.43;34.13;64.23;46.26;38.41;58.83;28.39;114.49;52.02;49.18;44.89;39.62;68.28;77.56;84.95;34.77;95.15;47.81;62.33;42.73;28.98 1999-05-24;29.15;38.25;43.07;43.19;54.89;31.77;64.95;64.9;66.01;37.94;33.92;64.08;44.35;37.91;59.25;27.86;111.2;52.55;47.27;43.92;38.5;66.91;77.25;85.78;34.6;91.91;48.28;61.97;42.3;29.35 1999-05-25;27.46;37.49;42.51;41.91;54.43;30.61;65.13;63.55;65.09;38.21;33.55;65.24;44.1;36.76;57.75;26.33;109.93;51.96;45.99;42.62;38;65.35;76.25;85.6;34.55;92.52;47.87;63.24;41.86;29.35 1999-05-26;27.85;39.15;42.37;40.21;53.62;31.55;66.59;62.96;64.8;39.05;33.8;65.43;46.07;38.04;57.2;25.74;117.41;51.25;46.96;43.68;38.25;64.45;78.5;84.83;34.44;93.68;49.17;62.94;42.42;29.48 1999-05-27;27.37;38.27;41.72;40.21;51.36;30.94;66.23;61.09;63.93;37.56;33;63.89;45.64;37.54;54.73;26.46;115.3;49.83;45.32;43.8;37.69;63.19;78.38;82.14;33.79;91.97;47.63;60.45;40.63;29.11 1999-05-28;26.58;39.64;41.08;40.94;50.89;32.31;66.59;61.38;62.83;38.06;33.33;64.31;46.47;37.37;56;26.93;115.3;47.29;45.09;44.95;38.25;64.75;80.69;81.9;33.62;91.36;48.46;60.33;42.11;28.62 1999-06-01;28.94;38.7;40.75;41.49;54.49;31.41;67.2;63.96;62.36;37.53;33.61;65.89;44.41;36.88;56.72;25.25;111.32;49.89;44.94;44.95;38.37;65.23;78.5;84.23;34.49;93.56;49.17;61.48;42.91;28.31 1999-06-02;28.63;38.78;40.71;41.06;54.14;30.45;66.71;61.91;62.07;38.24;33.45;65.3;44.22;37.46;57.99;25.87;113.06;50.9;44.27;44.5;38;64.17;78.44;85.31;34;92.21;49.05;62.58;43.84;28.62 1999-06-03;28.91;39.82;40.15;41.43;56.05;30.91;66.9;62.79;62.59;38.09;33.72;64.72;45.06;38.74;58.23;25.15;112.25;49.6;44.62;45.47;39.24;65.67;76.38;85.25;34.49;91.48;49.11;64.09;44.95;28.49 1999-06-04;29.93;41.01;39.5;42.77;58.25;31.96;67.81;65.89;63.17;38.45;34.37;63.73;44.59;39.98;56.3;26.49;115.3;47.7;46.3;46.92;40.73;67.89;79.56;83.81;34.55;94.54;50.89;65.55;45.44;30.09 1999-06-07;29.51;41.91;39.6;42.58;58.66;32.33;65.86;68.3;65.21;38.54;34.23;64.43;46.32;39.73;60.58;26.61;119.77;47.29;47.82;46.56;39.74;66.63;80.25;86.62;34.93;95.45;51.19;66.52;45.2;30.34 1999-06-08;30.48;42.24;39.55;42.64;57.62;31.6;65.86;65.19;64.57;38.03;33.55;63.15;44.62;38.6;60.76;25.74;115.92;47.59;46.65;45.01;40.48;65.97;79.38;85.43;34.06;92.76;52.14;65.37;43.84;29.11 1999-06-09;30.45;40.97;39.83;41.12;57.04;31.69;65.13;64.55;64.8;38.18;33.65;60.12;45.67;39.26;60.04;26.46;116.29;49.24;45.99;44.56;40.73;67.17;82.31;83.34;35.64;90.26;52.2;63.12;43.59;28.92 1999-06-10;31.29;40.32;39.74;41.67;57.38;30.91;64.28;64.02;66.02;37.94;33.1;60.29;45.83;38.93;59.55;27.58;114.55;50.84;45.56;43.44;41.6;65.25;79.88;83.16;36.84;87.32;52.14;60.81;42.6;28.86 1999-06-11;30.45;39.79;39.34;41.49;55.12;31.51;62.8;63.14;65.67;37.62;33.21;59.42;43.55;39.63;59.86;27.11;113.62;49.42;45.64;44.1;41.35;63.99;78.12;82.08;37.03;84.39;51.19;60.02;42.17;28.37 1999-06-14;31.41;38.72;39.18;40.7;55.59;30.82;63.16;65.83;65.5;38.66;34;58.89;42.31;38.43;59.92;27.08;114.8;51.49;45.95;43.98;40.98;63.69;77.56;85.25;37;82.49;51.78;60.75;42.6;28.49 1999-06-15;31.26;38.99;39.18;41.43;54.2;32.05;62.13;66.13;65.61;39.14;34.15;57.38;42.59;37.73;60.16;27.74;115.17;52.85;46.8;44.01;41.35;65.01;77.69;85.78;37.67;84.63;51.96;60.69;41.99;28.74 1999-06-16;31.38;40.6;40.2;41.61;54.66;33.75;62.25;66.13;66.19;38.39;35.01;60.06;44.72;38.56;62.63;29.73;119.96;52.49;50.08;44.1;41.85;65.97;81;86.74;37.39;84.2;52.02;62.33;43.89;28.86 1999-06-17;32.56;41.17;40.29;42.46;54.6;34.34;62.92;66.83;65.67;38.72;35.54;59.77;44.01;39.63;63.96;28.89;119.46;50.42;49.49;44.62;42.41;66.81;82.88;86.56;36.56;86.34;52.14;63.73;43.15;29.48 1999-06-18;32.65;40.83;41.17;43.44;57.04;33.88;61.82;66.95;66.08;38.3;35.25;58.55;45.3;40.33;65.1;27.36;120.02;52.2;49.92;44.04;41.73;66.33;85;86.92;37.23;86.01;52.31;64.64;43.27;29.97 1999-06-21;30.63;41.36;41.82;41.85;56.46;34.25;59.99;65.83;66.43;37.29;34.6;59.42;46.26;40.91;65.64;28.3;124;51.55;52.02;43.71;41.23;66.75;88.94;86.2;36.89;85.06;52.2;65.31;44.57;30.21 1999-06-22;30.08;40.85;41.63;42.1;55.82;33.84;61.03;63.55;66.48;36.69;34.7;59.3;45.89;40.91;64.14;27.74;122.63;49.77;50.93;44.07;40.98;67.05;86.5;85.6;36.34;84.75;51.37;63.91;44.45;29.6 1999-06-23;29.87;40.15;40.8;41.55;55.3;33.43;60.18;62.67;66.19;37.23;34.68;57.67;45.79;40.33;64.44;28.17;122.19;50.54;50;43.92;40.48;65.25;86;87.16;37.28;85.06;50.48;62.94;43.89;29.05 1999-06-24;29.18;39.29;40.06;41.67;54.72;32.05;61.03;62.02;64.8;36.46;34.99;58.84;44.78;39.63;62.81;27.42;121.82;50.13;49.84;44.44;39.74;66.27;84.62;84.77;35.68;83.59;49.05;61.48;42.84;29.05 1999-06-25;30.27;40.09;40.43;42.4;54.37;32.05;60.3;62.2;64.57;36.31;34.23;59.19;45.64;39.84;63.53;27.55;122.38;49.42;50.58;43.98;39.37;66.21;84.94;84.29;36.29;83.47;49.71;62.82;42.96;29.17 1999-06-28;30.57;41.01;40.43;42.1;56.34;33.66;59.51;63.49;65.44;35.77;34.8;59.13;47.98;41.57;61.73;28.39;121.82;48.47;51.48;44.1;39.99;67.35;86.75;83.1;36.12;83.41;51.01;63.37;45.07;28.8 1999-06-29;30.42;41.73;41.17;42.64;56.69;33.7;59.63;63.72;64.51;36.69;35.95;59.77;47.98;42.32;61.24;29.51;123.87;49.89;51.48;45.62;41.17;68.73;88;83.16;35.35;84.26;51.66;67.01;46.3;29.6 1999-06-30;29.9;42.68;41.31;42.83;55.65;34.75;60.42;64.08;62.94;36.75;37.03;61.52;49.52;42.61;60.76;29.63;128.47;47.53;53.89;47.56;40.86;70.78;90.19;83.04;35.41;86.22;54.98;69.99;47.72;30.27 1999-07-01;30.42;43.67;41.91;42.89;56.75;35.48;63.22;64.72;64.74;37.38;36.54;63.03;50.26;42.07;61.73;31.32;130.21;47.05;53.8;47.29;41.42;72.34;91.19;83.28;35.24;84.2;53.2;69.2;47.23;28.49 1999-07-02;30.33;45.14;41.86;42.89;57.44;35.8;63.16;66.48;65.55;37.89;36.93;63.96;50.14;42.32;61;31.63;131.45;48.24;53.25;47.29;40.8;72.34;92;84.89;36.12;83.04;53.2;68.04;48.22;27.82 1999-07-06;30.81;45.35;41.91;42.22;55.01;35.76;62;66.36;65.38;38.15;37.34;66.82;49.46;42.69;59.55;31.81;130.21;47.88;53.87;47.02;40.42;71.08;89.56;86.44;35.68;83.59;52.85;67.92;48.65;27.45 1999-07-07;29.66;44.53;43.11;42.46;57.62;35.67;61.39;65.6;65.61;38.33;38.65;65.24;48.94;43.35;61.6;32.06;132.01;49.01;52.97;47.5;40.8;71.8;92.31;86.32;33.37;84.39;54.09;68.16;47.48;27.57 1999-07-08;30.18;43.87;43.3;43.19;56.75;35.3;61.52;64.25;65.67;37.94;38.35;63.15;52.14;43.31;62.81;32.75;133.19;49.12;53.52;46.44;40.36;72.4;92.56;86.68;33.7;83.53;53.67;68.35;46.49;27.33 1999-07-09;30.27;43.79;42.79;43.37;56.75;35.8;62;67.24;66.08;37.86;38.39;61.63;52.57;43.52;63.47;33;136.54;48.95;53.33;46.62;44.27;72.28;93.25;85.54;34.14;84.88;53.73;67.98;47.41;27.14 1999-07-12;30.05;44.36;42.6;43.5;56.57;35.67;61.46;66.25;67.64;37.86;37.81;64.02;52.79;43.23;63.11;32.59;136.98;50.6;52.66;47.29;43.65;72.1;94.19;84.35;34.2;85.12;53.14;68.23;46.92;27.33 1999-07-13;29.99;43.67;42.28;45.08;55.53;34.89;60.85;68.47;67.59;37.38;37.87;63.15;53.86;43.06;62.69;32.56;137.04;50.13;51.84;46.95;44.46;71.74;93.62;85.43;34.14;87.02;52.42;66.46;47.04;27.08 1999-07-14;29.87;43.13;41.68;46.36;55.47;34.71;60.3;68.47;67.59;37.38;37.96;63.21;53.43;43.64;63.9;33.87;136.42;51.13;51.17;46.65;43.84;69.94;94.94;84.05;34.36;88.91;52.24;67.92;47.11;27.02 1999-07-15;29.36;44.04;40.98;45.5;55.18;35.12;62.37;68.77;67.01;37.62;38.53;63.44;55.68;46.24;64.26;33.71;135.49;48.95;51.41;46.95;43.4;70.18;94.38;83.87;34.2;89.4;54.27;66.89;46.98;27.63 1999-07-16;29.51;44.57;41.08;44.77;54.96;35.85;63.34;67.42;67.01;37.8;38.96;64.37;56.17;46.04;65.28;33.43;135.43;50.54;51.21;47.32;43.84;68.37;99.44;83.99;33.7;88.06;56.35;68.29;47.48;27.51 1999-07-19;29.48;45.66;41.31;44.23;56.18;35.99;61.58;66.77;67.94;37.56;39.33;63.67;57.28;46.16;64.02;33.65;133.81;50.01;51.41;46.56;43.15;67.89;98.38;84.35;32.98;87.81;54.33;66.89;47.54;27.33 1999-07-20;29.21;43.89;40.11;44.04;56.13;35.58;61.33;66.42;68.05;37.14;38.53;61.98;54.51;43.31;62.09;32.34;127.47;51.13;50.63;46.8;42.53;66.03;93.31;85.43;32.87;88.67;55.34;66.28;46.36;26.9 1999-07-21;29.06;43.95;41.26;43.68;56.53;34.8;61.03;67.71;67.82;37.23;38.32;61.98;55.46;43.52;62.69;32.65;128.22;51.43;50.9;47.29;42.72;66.03;94.69;85.96;33.37;88.06;55.34;68.35;44.94;26.71 1999-07-22;29.72;44.94;40.52;44.65;56.42;35.03;61.52;67.3;65.96;37.26;37.69;61.22;51.86;42.32;62.57;31.81;123.13;51.78;52.15;47.74;41.98;66.69;91.06;86.62;33.7;87.81;54.86;68.23;44.69;26.53 1999-07-23;28.76;44.47;39.97;45.38;56.88;34.66;60.66;66.6;65.44;37.71;37.75;61.17;53.09;42.73;62.03;31.97;124.06;51.67;51.06;47.47;41.73;66.33;90.25;85.49;33.59;86.34;54.57;66.95;44.45;26.34 1999-07-26;28.33;44.77;40.61;44.04;55.95;34.48;61.46;65.42;64.28;37.17;37.36;61.46;52.08;42.19;61.48;31.32;122.26;51.07;51.88;47.2;42.35;65.67;87.62;84.95;33.81;85.43;54.45;67.13;45.13;27.02 1999-07-27;29.3;46.7;40.71;45.02;56.07;34.57;60.91;67.65;65.09;36.96;38.1;61.63;53.83;41.28;62.63;33.65;125.49;50.72;52.43;46.95;41.91;66.09;88.81;84.89;33.7;86.22;55.4;67.07;45.07;27.76 1999-07-28;29.72;46.33;40.66;45.2;57.12;34.8;59.81;68.3;65.61;37.62;37.36;61.28;54.17;43.06;62.69;35.02;127.6;50.37;51.92;46.47;41.73;65.85;90;85.13;33.15;84.26;54.68;68.23;44.57;27.88 1999-07-29;29.09;45.45;39.55;44.04;54.9;33.57;59.93;68.3;64.68;37.11;36.71;59.59;52.48;42.44;62.39;34.61;124.62;49.48;50.24;45.26;41.42;64.17;86.94;86.74;32.71;86.22;53.73;66.59;43.52;27.27 1999-07-30;28.94;43.22;38.58;44.17;54.67;32.7;59.02;67.65;64.22;37.83;35.72;56.97;51.58;42.19;62.39;34.37;124.93;48.24;48.24;44.19;41.42;65.01;85.81;83.99;32.82;88.61;54.39;64.82;41.79;27.08 1999-08-02;29.69;42.66;38.12;44.59;54.61;32.38;58.53;68.41;64.92;37.11;35.35;57.67;51.62;41.24;62.09;35.52;121.51;48.59;48.98;44.62;42.47;64.77;84.81;85.19;32.87;88.18;56.05;64.46;41.91;26.71 1999-08-03;30.05;41.56;37.65;45.81;53.97;32.38;59.26;67.24;65.21;37.56;35.35;58.78;53.46;40.09;61.3;36.33;118.65;49.18;49.34;45.71;42.1;64.41;84.75;86.08;32.49;91.66;55.34;63.73;41.48;26.34 1999-08-04;31.03;40.51;36.96;45.38;53.33;32.24;58.59;67.07;65.5;38.06;34.99;58.55;54.33;38.93;61.79;36.28;117.78;51.96;49.1;44.65;41.73;62;84.94;87.63;32.05;90.81;54.27;63.18;40.49;25.55 1999-08-05;30.7;41.7;37.52;45.02;52.34;32.29;59.32;69.41;65.15;39.17;35.91;56.86;56.11;38.06;61.79;35.59;122.44;52.26;49.22;44.07;41.42;61.52;85.75;90.2;31.72;91.91;54.86;62.94;40.92;25.42 1999-08-06;30.36;40.37;38.26;45.32;53.85;31.19;57.74;69.29;66.02;38.3;35.07;56.16;54.69;37.9;62.39;35.66;122.75;50.66;47.42;44.62;40.05;59.9;85.12;91.57;31.39;91.11;54.98;62.39;40.8;25.05 1999-08-09;31.82;41;37.65;45.44;53.85;31.28;58.23;66.66;67.47;38.3;34.43;58.25;53.06;36.99;61.48;36.59;121.45;47.53;47.34;45.16;40.61;59.66;83.81;90.5;32.27;89.46;54.92;61.66;39.75;25.3 1999-08-10;32.21;40.84;36.22;44.83;54.9;31;58.29;66.19;66.48;38.69;34.37;57.14;52.57;37.44;60.28;35.75;118.59;47.76;46.52;44.77;39.49;59.84;82.94;90.98;31.61;91.73;53.2;60.45;42.41;25.18 1999-08-11;33.64;41.66;35.85;44.96;55.25;32.15;57.92;68.52;66.25;39.24;34.76;58.25;53.89;38.18;60.46;37.87;122.57;48.84;48.16;44.89;39.12;58.58;84.19;92.53;31.72;91.24;52.84;61.42;42.9;25.42 1999-08-12;32.85;42.56;35.85;44.67;56.88;32.33;58.59;68.23;65.84;39.19;34.43;56.9;50.78;39.26;59.92;37.84;120.39;50.84;47.38;45.98;38.87;59.6;81.75;92.41;31.22;90.07;52.42;64.52;43.89;25.67 1999-08-13;32.24;44.18;36.45;44.3;58.05;33.71;58.29;68.58;66.37;39.07;35.31;60.31;52.23;41.9;61.06;39.74;122.63;51.07;49.53;47.37;39.74;61.28;84.69;93.31;31.17;90.99;53.32;63.43;44.32;26.71 1999-08-16;32.42;44.57;36.31;45.03;58.11;33.98;57.86;67.87;65.96;39.07;35.99;57.96;54.33;42.32;60.76;39.14;126.61;50.37;50.24;47.49;40.61;62.3;84.31;93.6;31.83;91.85;52.36;64.76;45.5;27.45 1999-08-17;32.36;46;36.82;45.4;57.82;34.95;58.59;67.81;67.82;39.19;36.52;58.84;51.49;41.7;61.54;39.36;127.72;51.43;51.96;47.85;41.35;62.48;84.56;93.54;32.54;93.31;53.44;65.67;46.43;28 1999-08-18;32.42;45.02;35.99;45.03;56.88;34.33;57.01;66.99;67.64;39.54;36.6;58.9;50.45;41.41;60.62;39.11;123.13;50.12;53.21;46.82;41.79;62.3;85;91.8;32.54;92.7;52.07;65.19;45.87;28.68 1999-08-19;31.61;45.43;35.67;44.12;56.24;33.48;56.58;68.23;68.17;39.19;36.38;59.31;50.38;40.66;60.02;38.52;122.19;51.31;51.6;46.64;40.92;62.97;83.81;92.52;32.49;92.21;50.52;64.58;45.56;28.86 1999-08-20;32.82;46.87;34.69;44.67;56.24;33.98;57.31;68.05;69.44;39.54;36.97;59.31;51.68;41.53;60.86;39.83;121.01;51.67;52.43;48.16;41.11;65.01;83.38;92.64;33.04;95.15;49.39;65.67;46.18;29.35 1999-08-23;32.06;48.01;34.97;44.85;58.69;35.63;57.31;67.75;69.44;39.66;38.2;60.49;51.74;42.48;63.7;41.32;123.69;51.73;53.64;49.31;41.04;67.35;86.44;95.04;33.1;96.13;48.56;68.04;47.23;29.48 1999-08-24;31.55;48.51;34.51;44.06;58.75;35.96;57.74;67.75;70.08;39.1;38.22;60.66;52.45;42.19;63.58;41.42;121.26;50.3;54.19;50.23;40.8;66.33;92.19;94.74;33.04;98.08;48.56;67.56;47.04;29.29 1999-08-25;30.82;48.3;36.45;43.26;58.52;35.96;59.75;66.63;70.37;39.39;39.1;61.89;51.77;43.43;64.73;41.7;121.64;48.46;53.52;51.47;42.47;67.77;95.31;95.4;34.47;100.41;49.63;68.22;47.85;29.35 1999-08-26;30.64;48.28;36.96;43.32;58.87;34.99;59.99;64.87;70.32;38.47;38.98;63.01;50.57;41.66;63.4;40.39;122.19;48.93;52.58;50.84;41.73;66.15;94.62;94.62;33.81;98.08;49.03;68.1;46.8;28.98 1999-08-27;30.94;47.44;35.16;42.77;57.47;34.49;60.48;63.87;69.85;37.99;38.2;61.95;51.55;42.32;62.13;41.36;123.25;48.52;52.04;49.74;42.1;65.49;93.25;93.84;33.1;95.88;48.44;66.27;46.18;28.62 1999-08-30;31.09;45.82;34.05;43.69;55.48;32.84;59.32;62.27;70.44;37.27;37.44;61.01;50.66;40.91;59.77;40.98;122.44;47.39;50.98;49.83;41.79;65.49;92.25;91.26;33.26;96.37;47.72;64.81;45;28 1999-08-31;31.3;45.1;33.31;44.24;52.8;32.61;58.29;59.74;68.63;37.78;36.81;62.25;51.92;40.69;59.41;40.95;123.81;44.72;52.39;49.77;41.11;64.59;92.56;90.78;32.98;97.11;45.76;64.44;43.83;27.27 1999-09-01;31.39;45.59;35.06;43.93;54.09;32.93;58.47;61.51;70.44;37.51;37.26;62.78;51.74;40.53;60.92;41.57;126.48;46.2;51.78;49.41;39.99;66.5;92.38;90.96;33.15;97.35;47.37;65.6;44.51;27.57 1999-09-02;31.18;44.57;34.79;43.87;54.9;32.24;57.98;61.1;68.45;37.12;37.01;61.19;51.71;40.36;60.32;42.51;125.11;47.09;50.55;48.68;40.24;65.89;91.81;92.52;32.49;97.96;45.52;65.6;45.19;27.27 1999-09-03;31.18;46.58;35.62;44.36;55.19;33.48;55.91;62.33;69.09;37.87;38.15;62.48;54;42.06;61.71;44.5;128.08;47.98;53.21;49.34;41.54;68.07;95.88;93.42;34.58;98.76;46.18;65.54;47.04;27.45 1999-09-07;31.52;46.29;35.02;43.87;54.44;32.88;53.23;61.04;69.21;38.08;39.27;61.54;53.83;41.97;62.55;43.66;131.2;48.28;50.94;49.56;41.98;66.44;94.25;94.92;32.82;100.65;46.11;63.83;45.75;28.19 1999-09-08;31.76;45.35;34.05;43.51;54.67;32.38;53.84;60.51;67.81;38.89;39.62;60.9;54.11;42.76;63.34;42.82;129.96;47.87;51.17;48.92;42.1;66.8;92.25;95.58;33.76;100.53;44.61;63.59;46.61;28.56 1999-09-09;31.82;45.47;34.42;44.06;54.79;32.1;53.6;61.1;68.98;38.92;39.25;60.43;56.14;43.79;62.98;43.72;133.94;48.52;48.51;49.07;42.22;66.8;94.06;94.62;34.09;99.67;45.45;62.86;46.98;28.25 1999-09-10;31.91;45.92;33.95;44.18;52.92;31.83;53.72;61.98;68.28;38.53;39.06;60.9;55.31;44.83;62.49;43.54;134.18;48.76;48.48;48.43;43.09;67.4;95;93.84;33.48;100.9;45.45;61.28;47.17;27.39 1999-09-13;31.7;46;33.4;43.75;55.43;31.83;54.12;64.57;70.96;37.66;38.86;61.42;54.63;45.24;62.31;42.04;131.57;51.13;48.63;48.34;44.09;67.22;93.88;94.62;34.02;99.49;46.53;60.91;47.48;27.57 1999-09-14;31.7;45.72;32.94;43.51;54.49;31.6;53.51;62.33;72.77;37.93;38.26;61.13;54.6;44.99;61.47;42.76;132.51;49.05;48.44;47.67;43.78;66.2;95.06;93.24;32.74;97.41;46.89;60.85;46.43;27.45 1999-09-15;31.61;44.98;32.94;43.38;54.73;31.6;52.84;58.56;71.66;37;38.02;59.96;53.46;43.67;61.29;41.36;131.14;48.64;48.48;47.31;43.16;65.71;92.62;93.78;32.63;96.37;46.17;60.3;45.05;27.02 1999-09-16;31.03;44.77;33.68;42.9;52.75;31.69;52.84;57.91;71.14;37.21;38.43;61.25;51.21;43.67;60.14;41.17;129.22;47.69;48.83;46.61;42.53;67.04;94;92.28;32.51;97.96;46.35;59.45;44.87;27.02 1999-09-17;31.76;45.88;33.77;42.59;54.38;32.06;52.78;58.5;70.55;38.26;39.33;61.13;49.67;44.45;59.96;42.17;124.62;48.46;48.55;46.76;42.53;66.32;96.44;94.38;32.07;98.94;47.84;60.24;46.17;27.76 1999-09-20;31.48;45.66;33.35;41.86;53.21;32.33;53.02;58.15;70.03;37.45;39.98;61.07;51.28;44.33;62.07;41.88;129.34;47.98;49.1;46.97;42.35;67.7;97.56;94.32;32.51;98.76;47.66;59.02;45.73;27.7 1999-09-21;30.27;45.18;32.94;41.74;52.1;31.37;52.53;57.91;69.91;36.76;39.08;59.49;48.97;43.46;61.65;40.86;126.36;47.69;47.54;45.76;42.47;66.38;94.62;92.76;31.79;98.08;46.35;59.33;45.3;27.2 1999-09-22;30.06;44.75;32.57;42.47;52.4;31.46;51.25;58.74;70.26;36.1;39;59.31;48.63;43.92;61.53;41.26;124.43;47.21;47.81;45.39;43.22;67.46;96.06;91.86;30.79;95.88;46.95;57.13;46.78;26.9 1999-09-23;29.39;44.41;31.41;41.74;50.65;31.64;49.78;57.27;68.98;35.83;38.26;58.96;46.5;43.92;57.78;38.62;121.26;45.61;47.11;44.36;42.91;66.2;91.19;91.5;30.79;94.35;46.47;54.64;46.23;26.16 1999-09-24;29.03;44.73;31.55;41.07;50.47;32.1;49.97;55.73;68.57;35.83;38.67;58.31;47.61;44;55.73;37.7;124.25;45.97;47.18;43.81;42.72;63.78;90.94;88.2;30.62;95.21;46.89;56.04;46.04;25.85 1999-09-27;29.64;44.28;32.29;40.7;49.89;31.46;49.84;55.44;68.28;35.98;39.33;58.72;47.37;43.59;57.3;38.96;122.26;46.98;46.4;44.78;42.72;63.66;91.44;89.7;31.06;97.23;48.56;55.06;45.86;25.67 1999-09-28;29.52;44.55;32.38;40.88;49.48;32.1;49.6;56.44;67.98;35.77;38.8;57.96;46.9;43.75;55.6;38.62;122.75;46.08;46.21;44.54;42.78;63.12;92.12;89.04;30.4;96.8;50.66;54.58;46.48;25.98 1999-09-29;29.61;43.81;32.2;41.19;50.94;31.32;47.77;57.03;68.98;35.8;38.16;58.78;43.98;44.33;57.3;37.46;119.34;45.13;45.7;44.63;42.22;62.09;89.5;90.36;30.73;93.74;47.84;56.4;45.18;25.73 1999-09-30;30.09;44.28;32.2;41.62;51.11;32.29;47.16;57.03;70.67;36.4;38.86;59.13;44.72;45.4;57.96;37.03;120.27;45.67;47.18;44.72;42.97;62.57;90.56;92.28;30.51;91.73;48.86;57.8;47.09;25.55 1999-10-01;29.21;43.09;30.9;41.86;50.06;31.74;47.95;59.39;70.32;35.74;38.47;58.49;43.05;46.03;57.96;37.34;117.04;44.72;46.36;45.76;43.22;65.77;89.98;90.66;30.34;91.42;49.04;56.46;47.84;24.93 1999-10-04;30.24;45.12;32.38;42.65;51.35;32.79;46.49;60.98;71.9;34.96;39.35;60.31;41.02;47.1;58.69;38.37;119.15;43.89;48.67;46;44.21;66.86;92.56;89.28;30.9;94.17;49.76;56.28;49.82;25.18 1999-10-05;31.09;46.15;33.31;42.77;50.88;33.16;46.85;60.15;71.37;34.58;39.64;61.42;41.21;46.77;58.69;37.96;121.26;42.16;47.6;45.85;43.16;67.7;91.81;89.76;30.62;93.38;48.74;54.21;50.75;24.5 1999-10-06;30.06;48.13;34.51;42.41;52.75;34.03;50.76;61.33;71.31;35.44;40.54;61.78;43.92;47.93;58.2;38.33;118.47;43.06;47.8;46.12;42.84;69.63;93.69;90.3;30.95;94.97;49.58;55.49;50.87;25.18 1999-10-07;29.88;47.93;34.74;41.74;52.1;33.66;50.82;61.63;70.5;35.02;39.94;61.66;43.24;47.8;59.17;37.68;115.67;43.95;46.94;45.88;42.66;68.43;93.75;91.5;30.84;95.09;48.38;56.71;50.81;25.23 1999-10-08;29.88;49.18;35.11;41.01;52.8;34.17;51.86;63.39;69.85;34.84;40.89;63.25;43.08;49.29;59.29;37.71;112.81;45.19;47.56;48.07;42.97;71.2;94.94;91.5;30.67;95.94;49.76;57.74;54.83;24.92 1999-10-11;30.55;48.91;36.08;40.94;54.49;33.66;51.19;61.74;69.8;35.14;40.35;62.95;43.45;49.37;61.04;38.12;113.56;46.08;46.46;47.88;43.16;72.53;94.31;91.26;30.34;95.88;50.3;56.95;53.41;24.86 1999-10-12;30.15;47.72;35.43;38.69;51.75;33.39;49.42;59.39;67.69;35.11;39.78;62.01;41.36;48.71;58.38;38.21;109.33;46.26;46.11;47.09;42.66;71.38;92.56;88.74;30.34;95.09;47.66;53.6;53.34;24.61 1999-10-13;29.55;46.65;33.86;39.54;52.75;32.15;48.56;58.03;66.99;35.26;39.19;61.19;41.02;47.14;56.39;35.94;104.43;46.92;44.81;46.39;42.16;70;91.06;87.24;29.39;93.07;49.76;51.84;50.81;24.25 1999-10-14;29.82;46.65;33.07;42.59;51.87;32.24;49.42;60.57;67.52;35.62;39.37;61.07;40.41;46.98;57.42;36.54;106.35;47.63;44.65;46.06;41.35;70.48;90.69;88.26;28.61;93.74;49.16;52.69;51.86;24.55 1999-10-15;29.82;44.35;31.96;41.49;52.28;30.91;48.81;58.86;66.23;34.49;37.94;58.37;40.77;45.32;56.87;35.31;107.22;45.02;41.86;45.42;41.29;67.82;88.06;85.86;27.27;91.3;46.59;51.29;50.31;23.75 1999-10-18;29.61;45.3;32.57;41.13;51.64;32.06;49.84;60.09;65.94;34.96;38.55;59.72;38.56;45.61;55.12;34.57;106.35;46.08;43;46;41.73;69.7;87.88;85.2;27.22;93.25;46.35;50.98;51.61;23.26 1999-10-19;29.58;45.95;32.57;41.74;51.29;32.97;51.62;59.8;65.82;35.17;38.69;59.9;36.34;46.6;53.85;32.45;106.48;44.78;44.77;48.55;43.03;72.35;86.31;86.34;27.44;96.31;44.5;52.26;52.17;23.63 1999-10-20;30.27;47.56;32.47;43.08;50.36;33.94;51.56;58.33;65.3;36.64;39.86;61.19;37.73;47.89;53.67;34.85;106.35;47.33;47.72;49.89;43.84;73.07;92.25;86.82;24.09;97.41;44.44;54.58;54.27;24.49 1999-10-21;30.27;47.6;32.1;43.63;48.9;34.44;53.08;60.21;63.49;36.43;40.39;61.42;36.96;47.56;52.34;35.72;90.45;46.62;48.86;51.02;42.04;75.91;93.06;87.42;21.08;98.7;43.12;54.33;54.33;24.25 1999-10-22;30.45;48.83;31.83;43.57;51.77;35.36;54;61.1;64.13;36.82;41.17;61.84;37.39;47.84;53.79;36.59;93.37;46.32;50.75;50.99;40.05;77;92.69;88.92;22.09;98.57;43.96;55.49;56.5;25.66 1999-10-25;30.36;47.1;33.07;43.14;50.6;35.08;55.04;60.21;63.2;35.44;41.05;61.13;37.51;47.6;52.64;35.5;93.31;46.56;49.06;51.23;38.87;75.85;92.44;89.16;22.75;97.53;42.34;53.97;55.39;25.23 1999-10-26;29.67;47.56;32.57;43.81;52.01;35.59;54.24;60.27;63.72;34.52;41.17;61.25;37.76;46.77;50.65;35.59;94.92;45.85;48.98;51.26;39.24;74.94;92.38;92.04;22.81;96.07;43.6;53.3;52.73;24.86 1999-10-27;28.45;49.49;32.57;43.81;51.95;37.65;55.65;60.04;63.43;34.37;42.09;62.72;33.01;46.11;52.7;34.6;92.44;46.38;52.09;50.77;39.24;75.13;90.88;93.72;22.98;97.11;46.11;53.6;52.48;25.11 1999-10-28;28.12;52.9;34.05;44.67;51.36;39.83;57.48;60.27;64.42;35.02;43.59;63.77;35.11;49.33;54.34;35.97;94.36;46.02;55.75;50.62;40.55;76.63;89.88;93.06;23.37;102.37;49.94;56.34;55.2;25.85 1999-10-29;29.45;50.6;34.6;44.97;51.89;39.92;57.66;60.74;64.42;35.47;44.41;66.18;36.56;50.12;55.06;38.58;97.66;50;54.92;50.99;40.98;76.82;92.56;91.32;23.54;102.61;50.48;58.96;55.76;26.09 1999-11-01;29.61;48.95;35.02;43.57;51.25;39.27;57.66;58.5;65.47;35.8;42.4;64.6;36.77;50.45;55.85;37.87;96.17;48.52;52.6;51.14;41.42;76.82;92.38;90.3;21.14;105.67;50.72;58.11;55.7;25.29 1999-11-02;29.48;48.46;34.05;42.35;52.6;39.5;56.44;58.39;65.3;35.5;42.28;64.24;35.6;50.95;54.21;38.62;94.24;50.48;52.68;49.89;40.98;75.37;92.56;91.14;21.42;103.71;48.56;58.47;55.57;26.03 1999-11-03;29.04;48.3;34.93;42.23;53.12;39;55.59;58.39;65.01;34.96;43.06;64.3;36.16;49.79;54.21;39.75;93.8;50.72;51.89;50.74;41.66;76.39;92;90.78;24.09;104.44;48.38;58.11;55.2;26.46 1999-11-04;29.07;48.07;35.48;42.35;51.19;40.29;55.4;58.56;64.71;34.96;43.22;65.07;37.79;50.28;53.19;40.65;91.01;50.54;52.95;51.26;44.89;76.94;91.75;91.02;23.26;103.04;48.92;55.31;55.45;26.09 1999-11-05;29.77;49.2;34.79;43.26;51.36;40.01;56.81;59.03;64.19;33.83;43.83;64.71;38.25;51.61;53.79;41.06;89.7;51.9;54.29;51.35;46.2;77.6;91.56;91.92;22.7;103.59;49.04;54.45;57.49;23.94 1999-11-08;29.13;48.28;35.16;43.14;50.72;39.69;57.48;57.09;63.95;35.59;43.92;65.36;39.11;52.35;54.21;40.94;93.37;50.12;53.11;50.84;46.69;76.21;89.94;91.26;22.92;106.22;48.8;54.82;57.92;23.14 1999-11-09;29.22;47.99;33.81;40.58;50.54;38.86;56.38;57.86;63.08;36.29;43.71;65.54;38.28;52.93;54.27;39.91;93.06;51.37;52.29;50.44;46.07;75.31;88.88;90.36;22.64;105.18;48.62;53.48;57.43;23.26 1999-11-10;28.98;47.64;34.37;40.89;50.43;38.63;56.56;58.96;62.14;36.62;43.92;67.14;36.46;51.07;56.63;39.38;96.41;51.25;50.71;50.14;45.76;74.88;87.12;91.02;21.97;105.06;48.68;52.44;56.56;23.51 1999-11-11;29.61;47.88;33.86;40.28;51.6;38.35;55.46;57;62.09;37.01;43.92;66.07;36.37;52.15;55.91;39.6;94.43;51.73;51.07;50.53;46.69;74.1;89.62;90.3;22.53;104.14;48.92;52.44;56.87;23.94 1999-11-12;30.31;50.68;33.81;40.46;51.6;40.38;56.2;58.37;62.09;37.52;44.37;67.43;37.79;53.22;58.51;37.98;95.3;51.37;53.51;50.64;48.06;73.32;89.19;91.92;22.42;104.69;48.86;52.63;58.3;24.89 1999-11-15;31.1;51.66;34.05;39.3;52.13;41.11;56.93;58.9;61.44;37.58;44.41;68.44;36.77;52.1;58.93;36.92;93.49;52.91;51.97;50.52;46.57;72.59;87;93.6;22.64;104.26;48.74;53.11;58.36;25.7 1999-11-16;30.86;52.4;35.16;40.52;53.3;42.68;57.91;59.25;61.56;38.15;45.76;68.62;37.51;53.18;59.77;38.16;94.05;52.44;54.13;51.8;45.89;73.38;87.31;97.14;23.26;105.06;48.5;55.06;59.29;25.95 1999-11-17;30.5;50.8;35.02;41.69;51.95;41.48;58.58;59.02;62.26;38.67;46.27;67.26;39.91;52.89;58.97;37.26;93.18;52.44;51.54;51.55;45.83;74.58;85;98.05;23.09;106.65;49.4;55.14;58.3;25.82 1999-11-18;30.46;50.88;35.2;42.11;52.48;41.39;59.07;58.37;62.2;39.06;45.68;66.07;46.47;54.92;60;39.13;97.41;52.32;52.48;50.94;46.69;75.97;84.94;99.32;23.2;107.2;49.13;57.15;58.79;26.94 1999-11-19;31.04;50.92;34.46;42.79;46.15;41.57;59.13;57.89;61.33;38.39;45.13;66.01;46.13;54.42;58.85;39.81;103.31;50.23;52.25;51.34;47.07;76.63;86;98.83;22.87;108.11;49.28;55.81;57.55;26.57 1999-11-22;31.44;50.84;38.53;41.01;47.14;41.2;63.89;57.06;61.74;38.33;45.94;69.09;46.23;53.92;59.27;40.13;107.22;50.05;51.54;51.4;46.6;76.02;89.81;95.57;24.54;108.39;49.16;53.3;56.19;27.06 1999-11-23;31.68;51.09;37.56;40.83;47.08;40.24;65.18;57.54;59.75;37.58;45.1;69.09;46.35;53.34;57.76;39.38;105.42;48.56;50.32;50.79;46.32;75.49;89.62;93.4;23.03;109.89;48.86;54.89;55.39;26.82 1999-11-24;31.26;50.27;39.37;40.22;45.56;39.69;66.4;57.54;59.92;38.12;44.86;67.49;47.98;52.6;56.97;40.97;103.87;48.32;50.08;51.13;45.08;76.94;91.69;92.79;23.81;110.01;48.74;54.89;57.37;28.06 1999-11-26;31.74;50.14;42.51;40.22;45.15;40.01;65.05;57.06;60.27;37.58;44.45;67.55;47;53.26;56.67;40;104.37;48.74;49.77;50.36;44.27;77.12;91.12;92.25;23.48;110.56;49.76;54.04;57.63;27.37 1999-11-29;31.62;48.56;44.41;40.03;43.33;39;65.7;56.05;59.1;38.24;43.63;70.33;47.3;52.93;56.91;39.35;103.56;48.68;48.43;51.28;45.2;77.24;90.19;91.71;23.2;109.09;49.76;53.12;58.42;28.24 1999-11-30;31.86;49.64;41.35;39.79;43.51;39.64;65.95;56.35;58.22;38.21;42.65;69.84;46.75;52.43;58.18;38.23;102.44;49.92;48.63;50.64;45.45;75.97;91.05;92.31;23.42;105.67;50.37;55.26;57.06;27.68 1999-12-01;32.5;50.18;41.22;40.65;44.04;39.96;66.8;56.88;58.81;39.75;44.08;68.56;47.55;53.84;58.91;38.04;102.8;48.74;48.72;50.03;45.72;74.03;93.19;91.22;23.98;109.83;49.88;56.79;58;27.81 1999-12-02;33.78;50.42;41.52;39.3;44.56;39.73;66.07;56.94;58.1;39.55;44.14;68.26;49.15;53.82;58.91;38.66;104.63;50.17;49.77;48.85;44.89;73.04;94.81;93.88;23.79;110.07;49.34;57.49;57.1;27.67 1999-12-03;34.63;51.66;42.19;39.54;45.28;42.08;66.93;57.65;56.57;39.76;44.65;71.69;51.74;55.78;60.85;39.22;111.2;50.68;51.62;47.47;45.58;74.98;96.12;95.93;23.54;111.29;51.19;59.05;58.48;28.06 1999-12-06;35.33;51.64;42.19;37.77;44.68;41.34;63.3;58.48;57.69;40.41;44.98;73.36;51.58;55.18;59.82;38.82;115.3;51.54;49.65;47.25;45.76;73.33;95.44;94.49;23.26;110.8;50.77;57.09;58.99;27.62 1999-12-07;35.42;52.2;42.84;37.16;42.86;42.08;57.8;58.07;57.75;40.41;45.88;68.74;52.39;55.12;59.82;38.47;115.92;49.99;49.49;45.57;44.4;70.92;93;89.84;23.2;107.56;52.57;54.89;57.43;27.31 1999-12-08;34.91;51.99;42.64;36.48;42.33;41.17;58.78;56.41;56.93;40.22;46.3;69.09;54.11;55.82;58.24;37.13;117.57;50.65;48.92;44.52;44.27;71.03;91.75;90.8;22.36;108.3;51.73;57.21;58.08;27.06 1999-12-09;35.69;52.51;42.79;37.03;42.98;40.56;60.86;55.94;57.4;41.5;47.05;68.8;54.45;57.77;56.85;36.51;112.69;51.42;49.02;45.51;44.35;68.98;92.75;90.5;22.03;107.5;51.67;58.13;61.64;27.44 1999-12-10;36.91;55.11;42.19;38.32;43.8;41.3;61.97;56.94;57.63;39.9;48.32;68.85;53.71;58.93;56.36;36.01;108.34;52.02;49.69;46.06;42.97;69.23;93.88;90.74;22.92;108.05;51.19;57.95;62.63;27.85 1999-12-13;36.85;54.64;41.12;37.4;43.45;40.71;60.74;58.42;57.65;39.83;48.77;67.57;53.08;60.33;57.39;36.92;109.04;51.42;49.43;45.48;41.73;66.14;96.62;90.55;22.39;107.92;51.01;58.06;67.33;27.44 1999-12-14;36.33;52.73;40.98;37.71;43.27;39.37;60.01;61.51;57.16;39.69;49.12;66.61;50.94;61.25;58.06;36.11;108.59;51.84;48.19;45.97;40.98;67.53;98.69;90.98;21.77;109.15;50.95;57.09;66.4;28.3 1999-12-15;38.43;51.97;40.34;37.95;43.64;40.1;58.66;61.67;56.75;40.02;47.3;67.43;49.83;61.91;58.95;39.35;106.35;53.29;47.53;46.21;41.54;69.47;108.44;92.01;21.43;110.19;49.82;56.85;65.41;28.68 1999-12-16;37.09;50.14;39.5;38.87;44.21;39.73;57.31;61.92;56.4;40.35;48.38;68.62;52.54;64.02;59.88;40;108.53;50.11;47.21;46.18;41.54;67.29;113.69;90.5;21.2;107.5;49.28;56.18;68;27.81 1999-12-17;37.91;50.97;39.69;37.52;42.16;40.1;58.54;65;57.51;39.81;49.77;67.2;51.86;65.39;61.82;40.9;109.34;51.07;45.79;46.31;40.98;64.5;115.25;91.89;20.69;103.95;49.16;55.14;64.41;28.06 1999-12-20;37.34;51;40.14;37.62;42.33;40.04;58.35;61.27;56.78;39.47;50.23;68.71;52.25;65.2;54.91;40.41;108.54;50.68;45.48;44.9;42.02;64.56;112.75;90.29;21.03;105.3;48.38;56.57;63.7;27.95 1999-12-21;37;51.85;40.11;37.89;41.63;41.2;57.25;60.5;53.98;38.91;51.72;66.84;53.59;63.43;54.97;41.31;109.46;50.89;47.21;44.41;41.35;64.02;115.88;88.87;20.91;102.24;48.32;57.03;64.22;28.24 1999-12-22;37.24;51.05;39.18;38.56;40.69;40.47;57.31;60.08;58.4;39.03;51.74;67.55;52.69;63.77;52.42;41.12;107.35;51.13;47.13;44.69;40.8;65.11;117.56;89.17;20.86;106.65;48.08;56.24;65.09;28.8 1999-12-23;38.49;52.32;38.95;40.34;42.04;40.93;58.05;61.03;59.69;40.38;51.62;68.91;55.5;64.31;53.39;41.43;107.97;53.27;48.78;46.64;40.24;67.59;117.44;89.9;21.31;107.14;48.62;58.25;66.76;28.93 1999-12-27;37.97;51.99;37.01;40.58;43.57;40.1;58.29;59.61;60.4;39.51;52.27;66.96;53.46;64.76;52.73;42.4;109.09;51.78;48.15;47.71;40.55;68.32;119.12;90.56;19.55;108.79;46.83;59.66;68.8;29.11 1999-12-28;39.16;53.14;37.65;40.46;44.62;40.84;57.92;60.91;60.75;38.88;51.54;68.68;54.85;65.97;54.12;41.37;109.15;52.8;48.12;46.58;40.36;67.59;117.5;93.58;20.12;107.38;47.13;62.78;68.68;28.8 1999-12-29;39.77;54.37;37.47;40.16;43.62;40.38;57.74;62.45;62.57;39.12;51.31;68.68;55.99;66.79;55.03;41.81;108.34;53.87;48.82;45.12;39.93;66.14;117.94;94.18;21.2;107.01;45.45;62.23;66.76;28.43 1999-12-30;39.19;54.46;37.24;40.4;43.16;40.7;57.25;61.74;61.63;38.76;50.8;68.74;56.79;66.34;55.03;41.71;108.09;52.02;49.14;45.63;39.55;65.71;117.62;93.1;21.54;107.26;45.63;62.72;67.19;28.93 1999-12-31;40.38;54.62;37.61;40.58;44.15;40.97;57.07;62.45;62.34;38.82;50.72;68.8;56.05;68.28;55.94;41.03;107.22;53.87;48.9;45.51;40.05;65.11;116.75;94.55;20.91;107.2;46.65;63.57;68.5;29.05 2000-01-03;39.37;51.66;39.5;39.36;45.62;39;55.23;61.62;60.75;37.73;49.16;70.63;57.87;64.74;54.97;43.37;115.3;52.98;45.87;44.99;39.37;65.53;116.56;91.16;21.31;104.87;44.97;61.13;66.2;29.67 2000-01-04;39.56;49.71;38.02;39.3;45.03;36.61;55.29;61.62;59.4;37.01;47.19;67.79;53.49;61.33;54;41.34;111.39;51.66;44.87;43.35;38.56;63.23;112.62;87.54;21.48;102.86;42.34;58.62;63.73;31.41 2000-01-05;41.84;48.45;37.7;41.75;46.09;38.08;55.78;64.41;58.98;39.03;47.11;67.79;53.16;62.57;53.27;41.68;115.3;53.45;44.59;43.8;39.18;65.71;113.81;90.08;21.37;100.9;43;57.46;62.43;32.71 2000-01-06;41.29;49.44;35.53;42.18;48.43;39.92;55.84;67.79;59.87;41.04;47.74;67.73;49.77;59.59;54.3;39.25;113.31;54.53;45.22;45.18;38.62;66.26;110;97.32;20.97;105.55;42.09;60.21;63.11;31.41 2000-01-07;41.17;50.16;36.45;43.4;50.02;39.73;59.52;67.91;58.75;40.92;49.59;70.81;51.18;63.07;57.21;40.87;112.81;55.96;46.05;47.1;39.62;72.62;111.44;99.25;21.54;113.98;42.45;62.59;67.88;30.91 2000-01-10;41.05;50.86;37.65;42.79;48.37;39.6;57.62;66.36;59.4;40.35;49.57;71.46;54.73;62.76;57.52;42.74;117.29;55.84;45.26;45.91;39.8;70.5;112.25;98.77;21.82;113.43;43.05;63.21;66.64;35.63 2000-01-11;40.8;51.33;38.35;41.99;47.61;39.09;59.58;65.18;57.87;40.47;49.65;69.03;53.49;61.14;57.09;44.7;118.28;53.27;44.19;46.06;40.73;70.74;109.38;97.08;21.94;115.21;42.45;61.74;65.65;36 2000-01-12;40.44;51.06;40.43;42.18;48.43;40.47;60.25;65.48;56.16;40.23;49.82;72.29;55.37;60.65;57.64;45.48;118.78;52.38;44.47;45.63;42.47;72.13;105.81;97.32;22.05;114.47;40.23;63.14;64.47;33.46 2000-01-13;39.71;51.33;40.34;41.5;48.96;40.93;59.33;64.94;57.16;41.17;50.39;72.29;55.56;61.7;58.06;45.39;117.54;52.38;45.14;45.57;42.04;72.44;107.81;97.32;22.28;112.52;39.27;63.82;64.53;34.57 2000-01-14;38.92;52.48;40.48;43.09;48.73;42.68;59.82;63.89;56.98;40.35;49.49;77.85;55.43;61.52;58.06;51.37;118.9;53.33;46.77;45.73;42.33;71.83;112.25;95.93;22.05;114.47;40.41;62.41;63.91;33.33 2000-01-18;37.94;49.87;39.5;44.07;47.14;43.04;63.68;62.1;56.34;40.83;48.51;78.56;55.96;60.09;57.21;50.9;115.05;49.81;44.95;44.57;41.23;68.62;115.31;93.82;20.91;114.41;39.57;61.37;64.97;34.26 2000-01-19;38.01;49.01;39.32;46.64;46.55;43.96;63.93;61.27;57.4;41.23;48.74;77.14;57.16;61.45;52.61;49.88;118.78;50.11;46.92;44.72;42.1;69.29;107;95.45;21.26;112.88;39.03;59.35;63.48;34.51 2000-01-20;35.76;49.82;38.26;45.54;44.49;43.12;64.54;60.68;57.28;40.32;47.83;77.14;57.22;60.4;51.27;47.66;118.28;48.38;46.88;44.87;42.29;70.68;106;91.89;20.53;110.13;39.45;58.01;62.8;33.39 2000-01-21;36.67;49.91;38.53;44.75;44.73;41.53;65.52;59.97;57.16;40.95;47.24;77.55;55.74;59.59;49.76;48.82;120.77;47.85;46.17;43.87;40.8;70.2;103.75;91.71;20.01;100.47;41.37;59.29;61.87;32.53 2000-01-24;35.72;50.01;37.38;43.4;42.78;40.61;63.56;59.49;58.4;40.59;45.27;75.54;55.68;57.61;46.3;49.25;120.77;46.29;46.21;40.85;39.24;68.08;101.25;89.59;20.01;100.9;40.41;58.68;58.83;33.08 2000-01-25;35.18;52.11;37.98;44.75;41.19;41.11;64.54;58.31;58.1;40.5;45.39;73.76;55.5;55.74;46.12;50.62;118.41;45.58;47.24;41.61;39.55;68.68;102.81;88.27;19.95;95.39;38.48;55.63;60.57;37.24 2000-01-26;34.63;52.56;37.75;45.24;42.42;42.77;61.78;57.77;57.81;40.23;46.35;74.36;53.59;56.98;46.18;48.1;116.05;46.06;49.65;40.75;35.52;70.56;99.38;93.04;19.15;98.45;38.48;55.75;61.37;36.37 2000-01-27;34.3;53.61;37.28;44.13;42.07;43.41;58.29;58.31;58.04;39.03;46.46;78.44;53.46;57.85;44.85;48.91;112.81;45.64;51.08;39.29;37.38;71.83;98.75;92.98;19.1;101.81;37.52;53.98;58.59;36.87 2000-01-28;33.81;52.07;36.17;43.71;41.07;41.3;55.78;56.17;58.1;38;43.92;74.77;53.59;55.25;43.82;46.85;110.89;45.7;48.55;41.24;36.51;74.01;98.25;89.11;18.87;98.15;37.76;51.1;54.62;36.5 2000-01-31;33.9;54.21;39.04;43.58;40.06;41.94;56.27;55.94;58.22;39.93;43.92;76.25;53.34;56.24;46.55;49.32;111.57;45.46;51.08;42;37.13;76.19;97.88;90.44;18.98;98.88;41.25;51.77;54.25;36.06 2000-02-01;35.09;55.61;38.86;42.85;40.77;42.86;56.95;56.77;57.45;40.08;44.57;80.68;52.14;61.58;46.06;50.56;109.34;45.88;53.02;41.39;36.39;74.43;102.94;90.92;19.1;97.35;40.77;52.51;58.15;35.75 2000-02-02;36.4;54.02;37.75;43.71;41.01;42.49;55.23;57.6;57.87;40.38;43.94;77.02;54.48;60.34;46.79;49.88;112.81;45.52;52.15;41.67;35.27;74.5;100.81;89.35;18.75;96.5;40.89;52.57;57.84;37 2000-02-03;35.27;53.59;37.24;42.54;39.95;41.55;54.13;56.59;59.51;39.69;45.64;77.49;55.93;60.09;46.06;51.95;116.42;44.15;52.66;40.66;34.77;73.89;103.62;88.57;19.1;95.7;40.41;51.77;57.84;37.62 2000-02-04;34.42;53.12;37.47;43.09;39.95;40.4;55.11;55.76;59.51;38.97;46.4;77.96;58.14;60.71;45.94;52.23;114.93;43.55;51.75;40.08;34.9;72.74;106.56;86.03;18.75;92.7;40.41;50.25;55.8;37.86 2000-02-07;33.26;53.45;37.93;40.95;38.94;40.12;55.72;55.34;58.34;38.91;44.74;76.13;63.32;58.6;43.64;53.82;113.44;42.54;52.03;39.75;34.71;72.92;106.62;84.64;18.7;91.24;40.29;50.06;55.24;37.74 2000-02-08;32.19;53.63;37.28;40.16;38.71;41.32;56.03;53.92;57.98;38.03;44.92;75.24;61.19;60.59;43.88;54.25;118.09;42.95;53.85;40.05;36.08;73.1;109.94;84.7;17.73;93.68;40.47;49.88;58.96;37.31 2000-02-09;31.55;51.51;36.13;38.33;36.94;39.98;55.84;53.74;57.63;36.94;43.94;75.36;61.1;58.35;42.42;52.17;116.67;41.16;52.46;39.05;35.64;69.17;104;84.64;17.85;91.97;41.01;49.51;57.29;37.43 2000-02-10;31.97;50.84;36.36;39.07;35.93;39.61;55.54;51.25;55.93;36.76;44.39;73.22;62.09;59.16;41.94;53.66;118.41;41.76;52.62;38.07;35.27;66.86;106;83.07;18.07;89.46;40.53;49.02;56.48;36.68 2000-02-11;33.04;50.51;35.99;39.19;33.99;39.84;54.43;48.43;55.28;35.79;43.83;70.42;59.81;59.65;40.97;52.79;114.68;40.75;52.3;37.93;34.71;63.23;99.94;80.12;17.33;91.73;38.91;47.31;55.55;37.62 2000-02-14;35.27;50.67;35.8;37.59;36.46;39.84;53.03;49.38;54.69;37.04;44.04;71.43;60.61;59.9;41.33;54.78;115.36;40.51;50.05;38.02;33.65;64.02;99.62;80.06;17.22;89.89;39.33;49.21;58.34;36.75 2000-02-15;36.06;52.36;35.53;37.84;37.76;40.49;54.56;52.24;54.4;38.43;45.06;70.54;61.47;59.34;44.91;55.84;116.42;41.58;51.32;39.03;33.53;63.59;98.56;86.09;17.39;93.68;39.15;51.29;57.47;36.62 2000-02-16;36;50.62;36.64;36.61;37;39.57;52.48;50.93;55.75;38.76;44.46;71.19;64.55;56.86;43.69;53.44;115.05;41.46;50.33;39.09;33.16;63.47;97.62;85.31;17.28;92.02;37.58;51.18;52.27;36.68 2000-02-17;37.56;48.68;36.68;36.85;36.52;38.74;51.25;50.16;56.51;37.73;42.93;70.6;63.07;54.13;45.21;54.85;116.05;40.8;49.61;38.79;33.53;61.29;99.62;86.58;17.73;92.15;38.48;53.14;47.93;36.25 2000-02-18;36.67;45.49;35.2;35.38;35.58;37.95;50.33;49.32;56.98;36.34;41.01;70.24;63.56;53.38;43.14;52.54;111.82;38.94;47.32;37.93;32.29;60.08;95.06;84.58;17.85;91.62;36.8;51.42;47.31;35.26 2000-02-22;35.39;45.78;34.32;38.21;36.17;37.63;50.7;51.71;56.4;36.55;42.48;70.12;63.07;53.26;46;53.23;110.33;39.84;48.9;38.51;32.1;63.47;93.81;87.06;18.98;90.87;35.12;52.53;47.69;33.15 2000-02-23;34.72;45.45;34.69;36.49;35.7;37.58;50.21;50.81;57.28;36.16;42.77;69.53;64.43;54.44;44;54.38;108.09;38.64;48.98;37.29;32.41;61.17;94.25;89.17;18.47;88.67;34.4;51.79;46.57;33.89 2000-02-24;34.02;42.77;33.21;35.93;34.22;36.34;48.8;50.46;55.98;35.28;42.93;71.67;63.81;52.7;44.54;56.97;109.83;36.3;48.11;36.12;31.17;60.08;94.75;87.9;18.24;86.59;34.15;49.95;47.44;32.96 2000-02-25;34.26;41.05;33.31;37.16;33.99;35.42;47.7;49.14;54.46;34.43;41.34;73.4;61.41;52.64;45.34;56.47;107.35;34.56;48.03;35.27;30.8;58.32;91.31;82.83;17.85;83.29;34.09;49.15;44.09;30.79 2000-02-28;34.69;43.64;33.31;36.36;33.57;36.15;48.31;49.5;53.92;35.61;42.42;73.99;63.5;56.43;46.74;56.03;103.87;34.44;49.34;35.64;30.92;59.66;91.56;83.5;18.24;86.47;35.6;50.13;45.77;32.53 2000-02-29;33.44;44.15;36.54;36.3;33.1;38.18;47.64;48.19;54.34;36.49;43.38;72.44;66.27;57.11;46.86;56.34;102.13;35.34;50.41;35.27;31.54;59.66;89.38;85.19;18.36;85.98;36.32;50.01;48.31;33.77 2000-03-01;34.05;44.58;35.43;35.69;32.92;38.09;49.96;46.16;55.18;36.9;43.06;70.72;65.84;55.25;46.86;57.78;99.64;34.26;51.91;35.94;31.05;58.42;90.81;83.2;18.58;86.34;40.41;49.89;49.55;34.45 2000-03-02;32.62;43.95;40.11;35.32;32.51;38;48.62;44.73;56.77;37.31;44.33;70.42;66.03;54.75;44.67;57.71;102.5;33.72;51;36.09;30.67;57.69;93.38;83.13;18.3;85.43;43.54;49.89;50.1;34.26 2000-03-03;33.16;43.93;40.38;35.32;34.34;39.43;49.11;48.43;56.53;36.67;45.68;72.27;68.31;54.13;44.3;59.46;107.35;34.86;51.35;36;32.1;55.98;96.12;86.46;18.47;86.53;43.84;50.87;52.15;36.25 2000-03-06;32.58;42.53;39.6;34.52;34.64;38.51;48.01;47.47;54.87;35.34;45.04;72.68;72.19;53.51;43.14;58.52;102.44;33.54;52.82;34.53;31.36;55.01;90.62;84.28;18.07;85.55;41.73;49.09;50.04;35.75 2000-03-07;31.7;41.58;38.86;34.15;31.92;37.17;46.17;44.19;52.68;38.76;42.59;71.02;70.46;52.08;40.71;57.71;102.38;32.04;51.79;33.55;29.68;52.52;92.88;79.94;17.79;59.68;40.29;49.58;47.13;35.75 2000-03-08;32.89;40.39;39.23;32.8;32.98;37.26;46.54;44.79;53.51;38.58;42.71;72.15;69.42;52.2;41.56;57.31;105.61;34.58;50.01;34.78;30.55;55.31;95.56;79.75;17.5;56.75;40.05;48.35;47.87;34.7 2000-03-09;33.04;40.39;38.95;33.17;33.28;37.17;45.8;44.31;52.09;38.97;42.28;73.87;74.84;55;42.84;59.02;107.35;33.36;51.35;35.6;31.79;59.51;100;78.18;17.73;56.5;39.99;47.19;48.49;36 2000-03-10;32.71;41.68;40.11;31.82;33.69;36.15;44.58;43.84;51.2;37.32;43.16;74.11;72.4;53.2;44.18;59.93;104.61;34.68;49.81;34.72;31.54;57.99;101;78.73;17.33;52.59;40.41;47.98;47.5;34.88 2000-03-13;33.23;41.64;38.95;32.06;33.63;36.85;43.02;46.22;51.61;36.76;42.42;74.11;72.19;52.7;43.45;60.89;107.04;34.56;50.68;34.29;32.23;55.5;98;76.31;18.07;56.01;42.03;48.11;47.25;34.7 2000-03-14;29.9;42.26;39.23;32.49;33.81;36.71;42.59;45.62;51.2;37.43;41.62;72.44;68.86;52.01;43.81;58.77;107.97;32.82;50.01;35.64;30.3;55.01;95.12;76.43;17.7;54.55;40.53;49.03;47.31;33.89 2000-03-15;31.27;43.72;37.75;34.27;36.11;38.55;46.77;48.31;52.27;37.67;43.77;75.06;65.04;56.68;44.73;59.93;106.35;35.16;52.62;37.69;32.29;58.24;95.38;79.69;18.3;57.24;40.89;52.89;51.09;34.57 2000-03-16;33.65;47.3;39.23;35.01;38.41;41.41;48.92;51.05;55.11;38.64;45.56;79.77;65.54;61.15;48.44;62.36;108.34;38.58;57.05;39.09;33.84;63.29;95.38;85.07;18.86;58.58;43.42;55.96;54.2;35.07 2000-03-17;31.58;47.26;39.37;37.35;37.41;42.06;48.31;50.16;54.46;37.37;45.84;76.31;68.49;62.83;45.64;64.76;109.34;36.54;57.61;38.97;33.59;61.1;99.38;82.95;18.86;56.38;44.02;53.63;55.31;36.56 2000-03-20;32;46.72;42;36.36;36.35;41.46;47.76;52.13;54.75;36.28;46.19;77.15;70.96;63.26;46.25;67.31;112.07;36.48;54.8;38.85;34.34;60;97.38;84.04;18.57;56.87;42.75;55.1;54.69;39.17 2000-03-21;33.35;48;41.26;35.93;37.59;42.84;48.62;51.47;54.75;37.31;49.32;76.37;69.91;63.14;48.68;69.03;112.81;37.5;58.24;39.31;35.02;62.25;102.75;87.36;18.92;55.77;43.54;55.72;56.18;38.92 2000-03-22;32.65;48.61;41.73;35.63;36.76;43.35;46.28;49.74;53.15;36.31;49.45;77.86;72.03;62.7;45.03;71.83;113.56;35.76;57.96;40.29;35.02;62.74;103.25;83.07;18.11;55.77;41.67;54.8;54.94;40.22 2000-03-23;33.93;51.33;42.37;34.52;37.35;45.52;46.22;52.48;53.33;36.58;52.44;82.86;72.56;63.76;45.03;71.11;114.55;37.56;62.35;39.19;34.96;61.22;111.88;84.04;18.17;54.97;41.91;57.31;53.58;41.28 2000-03-24;34.93;51.21;43.48;35.38;37.29;44.69;46.22;52.3;54.16;37.43;52.13;81.31;70.16;64.01;48.32;69.34;119.9;37.86;60.89;35.39;34.59;60.12;111.69;87.78;18.46;55.22;41.37;56.02;55.06;41.15 2000-03-27;35.18;49.52;44.64;36.49;36.88;44.32;44.5;51.29;52.74;37.07;51.76;80.96;72.03;64.01;46.74;71.14;126.11;36.84;59.94;34.17;34.52;59.51;104.06;85.61;18.27;54.06;41.55;56.39;55;41.46 2000-03-28;34.72;50.18;44.32;37.35;36.17;45.01;44.13;50.46;52.27;38.28;51.13;79.95;69.32;63.64;45.58;67.65;121.76;36.18;59.66;35.27;34.9;59.94;104.31;85.85;18.22;55.77;40.89;56.76;54.07;40.66 2000-03-29;35.21;49.89;44.59;37.22;36.82;44.82;46.1;50.46;51.97;39;53.42;77.15;66.52;68.11;47.71;65.75;118.28;36.32;57.21;34.81;36.57;62.31;107.19;84.64;17.82;57.42;40.65;56.57;58.29;40.53 2000-03-30;35.09;49.03;42.79;37.96;38.47;45.01;47.76;51.29;52.74;38.1;52.03;77.98;64.43;66.62;50.14;63.32;122.01;38.52;55.07;34.66;37.38;62.37;103.38;85.97;20.03;56.75;40.05;60.26;58.54;39.97 2000-03-31;34.29;49.01;41.68;37.16;37.23;44.18;46.16;50.52;51.49;37.79;51;78.87;65.32;64.13;51.3;65.78;117.66;41.04;55.19;34.41;37.13;60.49;106.25;85.55;19.33;55.52;40.53;62.04;56.06;40.97 2000-04-03;35.03;51.16;42.93;36.55;39.53;45.75;48.49;54.93;54.69;39;52.77;80.78;65.32;67.61;52.94;65.13;121.26;41.1;58.56;35.39;38.25;64.99;90.88;88.75;21.25;58.22;43.05;60.75;60.71;41.53 2000-04-04;34.51;48.37;41.82;36.67;41.01;43.53;51.5;55.35;57.12;39.97;50.47;78.93;68.06;64.26;52.33;66.19;120.46;39.9;55.2;37.59;38.28;65.9;88.56;89.78;20.67;62.13;44.26;62.04;59.53;40.84 2000-04-05;33.77;47.55;40.52;35.44;40.06;43.3;46.83;54.93;56.89;38.64;50.25;78.52;69.97;63.64;51.36;64.76;124.25;38.64;54.96;37.96;38.31;66.45;86.38;88.03;20.84;60.23;44.56;59.89;57.79;39.73 2000-04-06;34.63;46.39;41.86;35.5;39.95;43.76;44.99;53.8;57.84;39.61;51.41;80.66;72.99;65.56;50.75;64.72;122.01;38.76;55.64;36.68;36.76;63.83;86;90.2;21.37;61.4;45.09;60.38;60.64;40.16 2000-04-07;33.16;45.76;41.96;35.07;39.06;43.53;45.42;52.48;58.55;38.55;52.05;80.6;76.87;63.76;50.26;68.21;122.38;38.04;54.96;36.28;36.76;63.77;89.06;88.51;20.96;62.07;44.86;59.83;61.02;40.72 2000-04-10;33.04;47.11;41.63;34.46;39.12;45.93;44.25;54.87;59.61;37.91;52.25;81.91;72.56;66.31;52.09;65.38;121.39;40.92;56.08;37.23;36.14;64.62;86.06;89.59;20.49;64.57;44.74;62.83;63.06;41.03 2000-04-11;34.35;47.77;40.89;35.07;39.71;46.81;46.4;56.3;58.78;38.46;52.97;83.28;71.85;66.99;54.59;65.19;118.65;41.46;54.73;38.33;37.44;65.54;83.88;92.19;20.26;65;45.71;63.08;62.88;42.21 2000-04-12;34.32;49.6;39.27;36.98;41.01;46.48;47.69;59.16;60.09;38.73;51.37;83.34;66.52;65.62;51.48;60.77;113.06;41.88;55.24;37.72;36.08;63.16;79.38;91.41;20.38;67.82;45.47;63.08;61.95;39.79 2000-04-13;34.08;48.04;39.97;36.36;39.65;46.16;46.46;56.54;59.14;38.76;49.32;83.81;65.01;62.14;53.98;60.39;109.96;40.98;53.77;37.35;33.9;64.08;79.25;91.53;20.79;68;45.47;59.77;59.59;38.98 2000-04-14;32.98;44.09;37.01;34.77;38.23;42.8;46.22;53.96;58.31;38.16;47.77;78.16;60.61;59.91;52.7;55.1;104.37;38.52;50.19;35.91;33.34;61.89;74.12;87.72;19.68;61.64;41.24;55.22;54.57;38.61 2000-04-17;31.55;44.09;34.65;34.7;38.65;43.72;47.69;53.62;58.61;36.58;49.82;81.31;65.91;56.92;53.55;61.33;111.2;38.4;50.03;37.96;33.47;62.74;75.88;86.82;19.8;67.51;40.51;58.48;53.58;38.48 2000-04-18;30.57;46.04;37.52;34.15;38;45.84;47.82;51.05;58.07;36.91;51.29;83.81;68.52;58.42;52.33;64.32;110.83;39.24;51.23;39.92;32.29;64.5;80.56;86.82;19.27;64.64;40.15;57;53.45;39.23 2000-04-19;30.69;45.9;37.7;36.61;35.81;43.99;48.37;50.52;56.18;37.52;50.96;84.29;66.92;58.42;52.88;59.36;104.37;38.16;49.63;40.29;32.85;67.18;78.69;87.36;19.39;64.64;40.57;60.01;54.51;40.66 2000-04-20;31.76;47.13;36.96;39.37;36.17;45.19;48.62;51.77;55.47;38.28;51.95;84.53;68.74;58.29;55.5;57.53;103.37;37.56;49.2;39.98;35.58;67.91;78.94;89.11;19.91;67.45;39.84;62.9;57.23;41.96 2000-04-24;31.67;49.46;36.31;37.22;37.12;45.61;48.8;53.44;54.75;38.7;53.11;83.58;65.2;59.22;54.77;57.9;105.86;38.4;47.57;41.08;38.75;70.04;66.62;94.06;20.09;68.98;40.87;63.69;58.41;39.97 2000-04-25;33.44;52.08;38.39;38.33;38.19;47.59;49.66;49.26;56.18;39.25;54.4;85.18;68.65;58.66;56.29;62.33;111.82;35.76;49.67;41.3;38.5;70.59;69.38;90.62;20.49;62.86;43.47;63.39;59.22;40.22 2000-04-26;32.04;50.96;37.75;39.25;37.83;46.12;48.62;46.88;54.75;38.82;53.5;87.62;69.26;60.16;54.22;60.24;109.83;35.88;48.64;40.53;38.62;70.04;68;85.91;20.79;59.44;42.57;59.52;58.29;42.09 2000-04-27;31.85;51.09;35.53;39.13;38.19;45.49;47.45;46.4;54.4;39.09;52.93;88.4;67.94;58.48;53.85;62.48;109.96;35.94;47.01;40.66;38.56;69.61;69.81;84.46;20.49;59.56;41.84;60.87;57.23;41.34 2000-04-28;31.67;49.27;33.95;39;37.53;43.64;46.46;45.27;53.45;37.64;51.54;89.17;66.52;56.18;54.52;63.23;110.83;35.28;45.9;40.41;37.81;67.67;69.75;83.68;20.38;58.46;42.38;61.05;54.94;43.33 2000-05-01;30.97;49.89;36.27;38.39;36.94;44.62;45.48;45.03;53.15;37.79;52.23;88.28;68.49;55.81;54.04;63.38;111.32;35.52;46.93;40.5;38.62;65.78;73.44;83.98;21.95;58.41;43.17;60.87;57.48;41.71 2000-05-02;31.55;48.8;31.04;37.28;37.71;45.22;45.48;46.16;52.62;37.91;52.79;88.93;68.03;56.49;52.58;60.42;110.7;36.9;48.44;41.24;38.93;67.42;69.88;83.98;22.18;58.52;40.99;61.61;57.17;42.71 2000-05-03;31.18;46.8;29.47;36.67;37;44.48;47.69;46.64;51.61;37.55;51.15;83.87;65.29;53.69;52.76;59.38;107.47;36.3;47.25;40.78;37.07;66.51;70.56;82.89;21.66;59.32;40.57;60.2;53.02;40.97 2000-05-04;31.67;47.71;28.63;37.53;36.11;43.37;47.69;47.47;51.44;38.52;50.47;83.93;65.1;52.2;51.85;59.63;106.97;35.52;46.61;40.69;35.52;65.42;70.44;82.53;21.72;59.13;39.72;60.62;50.6;39.42 2000-05-05;32.65;48.33;28.59;38.82;37.18;44.06;46.28;48.91;51.73;38.76;51.78;82.1;67.38;53.01;52.88;61.53;107.22;36.66;45.94;41.15;35.46;67.42;71.12;83.74;21.89;59.56;41.6;64.12;50.91;39.29 2000-05-08;32.4;50.12;27.48;37.59;37.06;44.2;47.69;48.31;50.78;38.97;51.56;81.08;66.86;53.26;52.88;58.66;109.09;36.72;45.82;42.98;35.58;68.03;69.81;84.34;22.53;59.87;41.48;61.12;51.96;40.28 2000-05-09;32.4;48.78;27.89;37.65;36.17;44.01;49.66;48.19;50.78;38.49;51.25;81.98;65.44;52.2;52.58;58.32;108.34;35.76;45.1;42.62;36.76;67.12;67.81;83.07;22.01;61.4;40.93;61.36;52.58;40.47 2000-05-10;31.95;47.26;26.83;36.37;36.52;41.75;51.93;47.53;51.2;39.49;49.78;78.5;62.21;53.69;52.39;52.9;102.38;35.34;43.75;41.88;38.37;66.21;66.19;83.01;22.12;62.8;43.65;58.66;56.24;40.78 2000-05-11;31.91;48.95;26.27;36.8;36.94;43.55;52.67;48.77;52.8;40.4;50.08;79.02;64.49;53.57;52.21;57.63;103.81;35.34;44.54;42.16;37.94;66.45;67.88;83.01;21.89;63.6;44.08;62.34;55.56;40.84 2000-05-12;31.96;49.69;28.68;36.68;37.48;44.52;51.38;48.41;53.21;39.96;51.37;81.45;64.83;53.69;51.82;57.35;103.81;35.37;45.58;41.88;37.32;66.33;68.81;81.99;22.65;62.74;43.38;63.08;56.37;40.53 2000-05-15;33.26;51.6;28.63;36.68;38.61;46.51;50.89;50.27;54.28;40.74;53.09;82.81;66.03;56.18;54.1;58.91;103.56;38.64;47.49;42.25;37.94;67.79;69.38;83.01;25.5;63.47;44.5;62.9;56.55;40.53 2000-05-16;32.8;50.55;28.68;36.87;38.31;45.63;48.12;50.87;54.04;40.55;53.34;85.56;68.25;53.13;54.65;60.78;108.34;37.56;47.25;42.77;38.93;69.13;69.5;87;25.56;63.11;44.2;64.98;57.54;41.9 2000-05-17;32.04;50.37;28.22;36.87;38.07;45.17;47.45;50.69;54.75;39.64;52.72;82.75;64.09;51.95;52.88;61.44;107.22;37.74;47.09;42.65;38.81;67.97;67.69;85.56;25.38;63.6;43.84;64.19;55.93;41.96 2000-05-18;32.16;51.23;27.29;37.11;36.94;45.54;48.62;50.69;54.34;39.68;52.23;85.74;64.89;51.21;53.72;61.81;105.42;37.68;47.8;43.35;38.37;68.09;66.19;84.65;24.51;63.35;42.81;63.9;57.48;40.91 2000-05-19;31.85;49.75;26.46;36.43;38.13;45.08;49.23;49.79;54.1;39.82;51;83.29;62.18;51.27;53;58.79;105.8;37.92;46.13;43.63;37.57;70.53;65.06;82.15;25.62;63.66;41.3;61.42;56.61;40.78 2000-05-22;31.21;49.07;26.88;36.06;38.25;45.36;49.84;49.49;53.75;40.59;49.16;74.72;60.48;50.09;52.02;59.04;108.59;36.9;45.94;42.71;38.62;70.41;64.19;81.85;25.5;63.47;41.11;60.99;56.92;40.6 2000-05-23;30.35;50.18;25.63;36.62;37.59;46.09;49.17;48.29;54.58;40.43;49.16;71.49;59.47;49.47;52.14;54.8;106.73;35.63;46.53;42.77;38.87;71.87;63.19;81.79;25.38;62.99;40.45;59.89;56.74;39.79 2000-05-24;30.26;49.44;25.72;38.35;37.77;45.4;51.81;48.17;55.52;40.4;49.9;72.33;58.45;46.48;52.75;58.54;108.96;34.36;45.58;44.21;38.5;72.66;65.56;85.74;26.61;64.45;41.72;58.96;56.43;39.04 2000-05-25;29.5;48.33;25.12;37.85;36.23;43.32;51.81;47.57;54.93;39.67;49.9;69.34;57.28;46.24;52.2;57.45;105.86;33.03;44.7;43.91;37.07;72.72;61.5;82.58;26.08;64.51;40.69;58.47;54.57;39.54 2000-05-26;28.09;48.51;25.53;37.73;36.29;43.09;53.66;46.79;56.71;40.13;48.73;67.48;58.21;46.61;52.33;58.63;106.29;32.55;44.86;43.32;37.5;72.6;61.44;81.67;25.56;64.82;41.24;58.04;53.58;39.6 2000-05-30;28.45;50.06;26.18;39.02;36.46;44.62;52.98;47.51;58.32;40.68;50.39;68.86;61.35;46.98;53.91;62.71;110.27;34.12;46.77;43.72;36.32;73.02;63.38;82.76;24.63;64.7;42.81;58.1;52.96;41.59 2000-05-31;28.64;53.4;25.86;38.53;36.4;46;52.49;47.09;57.07;40.59;51.74;67.66;59.22;48.72;53.43;62.18;106.67;33.64;47.53;44;35.58;72.94;62.56;83.37;24.34;65.06;42.26;59.52;57.17;41.9 2000-06-01;28.27;53.27;25.86;39.7;37.83;46.83;52.36;47.27;57.55;40.4;51.5;66.88;66.15;49.59;55.26;64.68;105.36;32.85;49.08;43.11;35.39;70.8;64.56;82.52;24.63;64.21;42.57;60.75;56.55;41.46 2000-06-02;30.38;55.87;26;39.33;39.08;49.29;51.69;48.05;57.25;38.58;51.86;65.74;70.03;53.32;55.32;66.92;108.16;33.58;51.34;41.3;35.89;67.38;66.31;81.97;23.52;62.62;43.53;62.16;58.6;40.16 2000-06-05;29.92;55;27.2;38.41;38.07;49.15;51.14;47.75;56.83;38.64;50.7;67.36;59.3;52.08;55.44;66.11;112.13;33.88;50.51;41.3;35.27;67.62;66.88;82.7;23.75;61.95;42.87;59.82;58.85;40.35 2000-06-06;30.08;53.4;26.74;39.33;37.18;47.94;50.95;47.09;55.92;40.1;50.33;65.62;58.16;50.09;55.2;64.62;111.7;32.91;49;41.36;34.9;68.02;69.62;80.03;24.05;61.88;43.84;60.62;57.79;40.6 2000-06-07;29.53;55.81;27.48;38.04;36.94;49.1;52.12;47.03;54.98;39.52;50.51;67.12;60.41;50.27;52.57;64.3;120.27;32.28;48.92;41.14;34.65;68.91;70.5;79.48;24.92;60.54;44.86;59.09;57.42;39.91 2000-06-08;29.07;54.38;26.09;37.67;36.29;47.71;51.93;46.73;54.74;39;50.02;65.86;62.04;49.59;50.31;62.93;119.03;32.67;48.68;41.73;35.21;67.75;68.81;79.48;25.15;56.26;45.47;56.07;56.43;40.16 2000-06-09;28.43;53.21;25.63;38.65;36.4;47.34;51.44;46.97;54.38;38.58;49.04;65.68;63.09;47.91;50.86;63.37;118.97;32.31;46.65;42.34;33.65;68.3;68.81;79.66;25.15;55.77;46.56;57.79;53.58;41.28 2000-06-12;28.3;53.06;25.16;37.61;36.76;47.34;51.75;47.36;55.64;39.34;49.04;66.1;62.1;45.74;50.07;62.37;118.13;32.67;46.38;41.68;32.41;68.36;66.88;79.69;25.85;55.16;45.29;57.39;52.34;40.44 2000-06-13;27.63;53.89;25.16;38.28;35.45;48.31;52.66;45.41;56.12;39.55;50.33;65.44;58.65;49.16;49.03;65.58;118.59;31.82;46;43.26;32.16;71.78;67.88;79.6;25.5;55.77;46.43;56.32;54.57;39.91 2000-06-14;29.34;56.11;24.79;38.28;35.81;49.66;52.29;46.01;57.55;40.25;50.14;64.73;56.19;50.78;50.13;63.06;115.3;32.97;47.78;44.12;31.54;71.29;70.5;81.85;25.56;55.77;48.37;58.84;54.75;40.47 2000-06-15;30.02;54.88;25.3;39.82;35.22;47.99;55.12;46.01;58.09;40.16;51;62.33;57.66;50.65;49.7;63.96;116.11;31.64;46.59;44.55;31.92;71.17;72.38;84.04;25.68;55.52;47.1;58.72;55.12;41.71 2000-06-16;30.44;50.92;24.75;38.72;34.2;46.37;54.75;45.47;56.71;41.1;50.27;60.17;56.22;49.59;47.38;62.87;112.57;31.88;43.37;44.03;31.11;69.4;72.56;82.09;24.18;54.3;45.71;57.98;53.51;40.91 2000-06-19;29.46;52.9;25.07;38.47;33.43;47.57;53.71;44.99;56.65;40.95;49.41;61.73;58.06;49.78;39.32;68.08;119.65;30.92;44.74;44.34;31.3;70.43;73.69;81.18;24.47;54.88;45.95;56.5;54.01;41.65 2000-06-20;29.46;53.4;25.16;38.78;33.37;47.62;52.23;44.15;55.4;40.55;50.14;59.46;57.42;48.66;35.78;68.98;115.67;30.74;45.76;43.54;31.3;69.27;74.94;79.91;23.82;54.06;45.65;54.78;54.13;41.46 2000-06-21;28.13;52.04;25.9;39.27;33.43;46.23;52.78;43.85;55.82;40.9;48.61;59.7;58.9;48.35;36.15;69.32;113.81;30.31;44.86;44.18;31.11;70.8;80.69;83.86;23.7;53.38;46.56;56.01;53.57;41.46 2000-06-22;28.55;52.84;26.69;38.41;32.78;46.05;55.37;43.43;55.28;40.28;47.93;57.72;58.43;47.66;34.19;66.86;111.14;30.56;44.27;43.54;31.23;69.64;79.88;83.67;22.69;52.96;47.52;55.64;52.14;41.22 2000-06-23;29.65;53.02;25.44;39.33;32.95;45.77;57.1;43.85;56.41;40.49;49.04;59.1;57.73;47.79;33.89;67.02;111.2;30.07;44.74;44.12;32.41;70.98;77.69;82.09;22.22;53.75;46.98;56.19;53.39;39.35 2000-06-26;28.3;55.56;24.29;39.21;33.13;47.34;58.21;43.37;57.67;40.61;49.1;57.9;59.14;46.92;33.46;66.92;113.72;28.8;45.4;46.95;33.22;72.57;79.5;83.13;25.78;54.42;45.83;56.19;53.39;40.22 2000-06-27;29.34;53.58;24.79;39.45;33.97;47.3;57.1;44.45;57.49;39.98;48.42;58.14;57.48;49.34;32.48;65.52;109.09;28.87;45.76;48.15;32.47;72.57;78.81;84.22;26.07;54.42;45.04;55.64;56.43;39.73 2000-06-28;29.07;52.65;23.96;39.98;34.41;47.48;59.24;44.31;57.59;40.01;49.7;57.7;61.01;47.91;33.31;66.02;113.09;29.26;44.91;48.22;32.01;72.33;78.94;83.69;24.74;54.35;43.46;55.87;55.6;38.89 2000-06-29;28.42;51.91;23.87;40.38;33.31;46.33;58.27;42.76;57.67;39.56;48.91;56.76;59.02;47.66;32.97;65.71;113.31;29.59;45.46;48.45;31.05;72.44;77.19;83.19;25.66;52.47;44.08;53.67;53.76;39.23 2000-06-30;28.42;51.54;23.55;41.24;32.24;44.57;56.67;42.04;56.83;38.24;52.11;55.62;61.55;49.72;32.91;66.67;108.9;28.8;43.97;50.08;32.72;74.89;80;80.7;25.18;55.52;42.57;57.98;57.23;38.55 2000-07-03;29.16;51.79;23.96;41.12;34.26;46.19;57.41;43.24;57.43;38.75;51.13;57.12;61.24;49.47;33.58;68.26;108.84;29.89;45.72;49.68;32.29;74.74;80;81.73;25.78;54.67;45.04;55.82;56.49;38.3 2000-07-05;28.91;51.62;24.79;42.23;33.49;46.79;57.96;43.3;57.61;37.48;49.1;57.48;58.96;50.03;33.22;65.64;104.37;30.07;45.9;49.65;31.61;75.44;78.5;86.04;26.43;54.42;44.26;57.85;56.61;37.8 2000-07-06;28.36;51.43;24.61;42.41;33.13;47.25;58.15;42.34;57.91;38.09;49.35;58.74;58.34;51.02;34.19;68.14;100.64;29.71;46.14;49.01;31.98;73.67;80.94;84.16;26.37;54.06;42.44;56.81;57.11;37.24 2000-07-07;27.08;53.23;24.42;43.15;32.3;48.22;57.96;42.22;58.26;38.25;50.45;57.6;61.48;55.26;33.83;69.48;104.43;30.37;48.12;49.04;32.29;72.69;82;83.73;25.42;53.69;43.47;57.85;61.15;37.74 2000-07-10;29.4;54.34;24.42;42.41;32.6;48.27;56.79;43.18;58.32;38.06;51.56;59.76;60.96;57.25;34.19;68.73;102.69;31.16;47.82;49.25;32.04;73.18;79.44;84.77;25.6;54.24;43.59;58.41;60.83;37.55 2000-07-11;31.85;53.54;23.68;43.71;34.38;49.47;55.43;45.41;57.73;39.25;51.37;58.92;62.41;57.37;35.17;69.23;101.38;33.33;48.72;49.25;32.35;73;79.12;86.47;24.59;53.93;43.17;59.09;61.58;35.75 2000-07-12;31.49;54.47;23.59;43.28;34.8;49.47;55.37;43.49;57.49;38.29;52.85;60.23;63.27;57.12;35.11;70.41;103.99;34.42;48.6;48.21;31.79;71.73;80.31;87.56;23.94;53.93;43.71;59.33;60.59;35.82 2000-07-13;31.91;54.53;24.93;43.96;34.2;49.29;57.16;44.93;57.31;38;51.62;59.16;66.47;55.94;34.99;71.41;103.37;35.09;48.78;46.83;31.3;67.56;79.94;87.08;23.58;53.38;44.5;59.58;58.72;36.87 2000-07-14;32.28;56.01;24.42;43.83;34.03;50.3;56.85;43.67;58.38;37.78;50.64;59.22;65.95;56.19;35.29;73.16;103.31;34.6;50.46;45.14;31.17;65.73;78.94;85.44;23.23;54.79;44.14;60.19;59.1;37.18 2000-07-17;30.14;55.77;24.56;43.37;34;49.1;56.57;42.88;58.23;38.36;52.79;57.84;66.43;56.62;36.88;72.97;104.86;34.81;50.01;46.38;31.11;65.85;78.19;84.83;22.4;54.91;42.1;59.61;60.31;36.31 2000-07-18;29.71;54.65;25.44;44.51;36.27;49.33;57.41;42.88;56.23;38.09;51.37;58.26;64.56;57.12;36.02;71.32;102.69;34.12;48.96;46.7;31.11;64.88;78.5;85.56;22.81;56.99;42.32;58.1;59.66;35.51 2000-07-19;30.02;54.53;25.26;45.25;36.45;50.3;59.69;42.52;56.41;38.33;51.86;58.38;63.98;56.87;36.33;68.89;108.09;33.45;48.72;45.81;31.17;63.78;73.12;84.1;23.7;57.85;42.44;56.62;59.59;36.75 2000-07-20;29.89;56.32;24.42;45.43;35.61;52.2;59.69;42.16;57.19;38.06;53.4;57.6;64.07;57.81;35.41;71.16;116.54;32.91;49.32;45.17;31.48;62.62;74.81;84.1;24.18;57.73;41.95;56.5;59.59;38.36 2000-07-21;31.12;58.68;25.35;46.17;35.07;52.43;60.04;42.04;55.4;37.57;53.22;57.48;61.11;56.87;33.95;68.92;114.06;33.58;50.69;45.35;30.67;62.31;72.31;83.98;23.94;57.85;41.83;57.85;59.28;37.18 2000-07-24;31.06;56.51;24.66;47.47;34.83;52.34;58.45;41.32;53.25;37.63;53.09;56.82;58.56;55.75;34.56;68.82;111.82;33.58;49.56;46.43;30.05;67.99;70.56;86.59;23.52;57.73;42.01;58.16;57.05;36.37 2000-07-25;30.69;55.33;25.16;47.96;34.47;52.11;58.45;41.92;52.77;36.72;52.66;56.34;56.86;54.76;36.09;70.26;111.32;33.03;49.26;45.97;31.11;69.3;69;85.86;24.65;59.32;42.8;57.36;58.79;37.24 2000-07-26;30.02;55.09;23.96;47.35;33.39;51.5;58.02;43.18;52.56;37.11;51.25;55.86;54.21;53.33;34.31;69.32;109.21;31.46;47.46;44.37;31.48;68.42;67.81;86.1;23.88;58.37;41.95;56.5;58.35;37.8 2000-07-27;30.87;57.75;23.68;47.59;33.51;51.74;59.63;44.33;52.53;39.22;51.62;55.44;52.24;54.51;34.13;68.33;109.65;32.13;47.94;45.16;31.98;70.71;69.38;86.53;24.29;58.28;41.65;56.62;59.66;37.74 2000-07-28;30.38;55.46;22.67;48.15;32.73;50.81;61.85;44.09;52.71;38.97;50.08;55.03;52.86;52.46;32.24;64.4;111.14;31.88;46.5;46.04;31.79;71.14;69.69;88.47;24.35;57.91;41.34;56.56;58.29;37.62 2000-07-31;29.65;56.14;22.9;48.15;32.73;52.15;60.49;43.55;52.41;39.06;50.82;54.55;53.84;51.52;33.22;66.58;111.57;32.55;47.88;45.75;31.48;70.04;69.81;87.56;23.94;55.77;41.4;57.48;54.88;38.3 2000-08-01;30.44;56.39;23.55;48.02;32.97;52.15;62.15;43.79;54.98;38.97;51.86;56.34;53.17;51.77;33.34;64.46;109.83;33.21;49.62;46.61;32.41;72.42;68.69;86.89;24.41;57.48;42.5;58.35;54.13;39.23 2000-08-02;31.31;56.82;22.94;49.2;33.63;52.52;62.09;44.03;55.16;40.37;51.13;55.92;55.45;52.89;32.97;63.15;113.56;32.67;49.44;47.44;33.22;73.31;69.38;87.75;24.59;56.93;43.11;57.3;53.7;39.85 2000-08-03;30.75;57.44;22.67;48.33;33.69;52.89;62.15;44.21;55.16;39.67;51.99;55.68;55.2;51.52;32.36;64.92;115.3;33.09;48.3;47.69;33.03;73.52;70.25;87.44;25.06;56.81;42.8;56.25;53.51;42.21 2000-08-04;30.69;59.23;22.57;48.33;33.48;54.51;61.29;43.97;54.38;39.8;52.48;56.88;55.08;53.76;32.79;62.42;115.17;32.37;50.4;47.47;33.16;72.15;69.12;87.5;25.24;56.14;42.74;58.1;52.58;42.15 2000-08-07;31.86;57.75;22.57;48.39;35.25;54.65;60.55;44.81;55.52;39.41;51.74;57.54;56.83;54.76;34.8;62.8;115.61;32.67;51.48;47.62;33.47;71.38;70;88.35;26.55;55.89;43.17;60.07;54.75;40.78 2000-08-08;34.07;58.18;22.16;47.9;36.87;54;60.12;46.67;57.79;39.36;52.85;59.04;57.08;56.75;35.41;61.49;118.29;34.3;51.42;47.52;33.28;70.72;74.12;88.84;27.02;55.28;41.34;60.32;57.23;41.09 2000-08-09;32.97;59.05;22.3;47.24;36.09;53.86;59.01;46.55;58.32;39.49;55;58.31;56.06;57.75;34.99;63.42;118.17;33.88;50.28;46.61;32.47;68.97;74.25;89.93;26.43;55.1;40.55;59.95;53.26;40.41 2000-08-10;33.03;58.06;22.85;48.35;36.03;52.8;60.18;45.41;58.68;39.67;56.04;59.52;55.32;54.88;34.68;61.86;119.16;33.33;49.86;47.89;32.6;69.85;72.62;92.24;27.02;55.59;41.16;60.19;50.65;40.22 2000-08-11;32.78;59.17;22.94;49.09;37.11;53.73;61.41;47.8;58.92;39.86;55.61;61.09;54.21;55.69;34.31;63.67;120.03;33.82;49.98;48.1;33.22;70.77;72.44;94.06;29.63;56.99;41.4;59.82;51.77;40.35 2000-08-14;33.58;59.42;22.94;48.97;37.54;54.88;62.22;48.35;60.29;40.44;56.04;62.06;56.43;58.74;34.38;66.79;122.64;33.33;50.7;47.84;33.1;71.2;72.19;93.03;30.22;57.97;40.73;60.01;52.52;40.66 2000-08-15;33.7;58.61;23.13;46.74;37.14;54.84;61.17;48.29;60.05;39.83;56.29;61.39;54.71;53.26;34.56;67.72;121.4;33.33;49.8;47.24;32.23;71.6;71.62;92.24;30.75;61.4;40.86;59.15;51.21;40.22 2000-08-16;33.89;56.76;23.87;45.69;37.11;54.28;59.87;48.29;60.17;40.54;55.86;62.48;55.02;50.78;33.39;67.91;121.77;33.46;48.42;48.1;32.16;71.96;71;91.94;32.23;61.4;40.19;59.7;49.6;39.6 2000-08-17;34.01;57.93;23.87;45.38;36.75;55.44;58.89;48.65;62.5;41.05;55.74;63.2;53.66;51.09;33.7;69.91;121.9;32.24;48.72;47.69;31.05;72.27;71.56;92.61;32.12;60.91;38.42;61.55;49.66;39.91 2000-08-18;33.7;57.93;23.96;45.2;36.69;55.46;59.5;47.86;61.85;40.62;55.24;67.61;55.2;51.15;34.8;70.4;119.84;33.03;48.78;47.56;31.36;70.37;71;92.48;30.34;61.64;38.24;60.56;50.53;38.86 2000-08-21;32.54;58.55;23.45;47.24;36.21;57.02;59.01;48.41;61.13;40.9;55.61;65.68;54.71;50.65;36.34;71.9;120.84;31.87;48.96;47.84;31.36;70.25;70.62;92.3;30.52;61.82;38.97;62.53;48.67;38.17 2000-08-22;32.23;57.38;23.18;48.78;36.33;57.34;57.22;47.03;61.79;40.72;55.31;66.94;55.72;50.96;37.94;71.96;120.78;31.45;50.7;48.21;31.11;70.86;71.25;93.64;30.16;62.74;38.55;62.78;48.79;37.68 2000-08-23;32.9;56.76;22.94;50.02;35.67;55.9;58.01;46.35;61.07;41.39;56.97;66.58;56.68;51.15;37.44;74.46;122.64;30.23;52.2;47.81;30.98;70.62;70.75;93.84;29.39;62.92;39.09;63.32;48.79;37.18 2000-08-24;32.66;55.95;23.27;53.05;36.21;56.92;57.16;46.23;61.43;40.62;57.95;70.39;59.08;50.22;39.29;74.08;124.2;31.2;51.18;47.47;30.18;70.86;71.12;92.74;30.1;61.58;39.4;62.48;49.1;37.62 2000-08-25;32.84;56.01;22.99;53.54;36.15;56.32;55.25;45.56;62.2;40.62;58.26;69;58.53;50.28;39.16;72.77;128.37;30.72;50.04;47.07;30.18;71.29;70.62;93.66;30.4;61.4;40.07;62.48;50.16;37.86 2000-08-28;33.52;59.29;22.39;52.68;35.73;58.22;56.23;45.08;61.19;40.56;58.99;72.2;59.14;49.78;38.3;73.71;130.85;30.66;50.64;46.73;30.18;70.83;71.31;93.05;30.22;61.4;40.98;63.04;49.16;37.8 2000-08-29;32.11;58.68;23.5;51.75;36.57;57.36;55.56;44.26;60.23;40.42;58.87;71.17;59.11;49.51;37.69;73.9;132.22;30.54;49.86;45.87;30.24;69.58;70.94;92.56;29.27;61.15;41.16;61.8;49.1;38.17 2000-08-30;32.17;58.37;23.45;51.93;36.09;57.36;53.52;43.87;60.06;39.85;56.53;69.9;58.16;48.2;38.79;73.34;129.67;30.66;51.18;45.01;30.18;69.85;70;91.33;28.92;60.72;40.98;60.26;48.11;38.11 2000-08-31;32.74;58.44;23.41;53.06;35.33;57.74;51.93;43.46;59.89;39.99;57.64;67.61;59.46;47.89;38.18;74.71;131.37;31.04;53.71;45.35;29.7;68.64;69.81;90.98;28.2;60.49;40.63;61.68;47.3;38.69 2000-09-01;32.66;57.87;23.59;54.16;35.85;56.86;53.52;44.11;60.36;40.41;57.52;70.63;61.61;48.39;38.73;73.77;132.97;30.96;54.13;45.69;29.37;67.95;70.19;90.48;27.73;60.05;41.77;61.25;48.42;38.73 2000-09-05;33.27;59.17;23.87;54.84;36.57;56.92;55.56;44.66;60.84;40.84;56.84;70.45;60.59;49.94;39.04;69.1;130.54;32.06;54.91;45.99;29.49;65.94;70.12;90.23;28.15;61.15;42.01;60.51;49.41;38.36 2000-09-06;33.15;59.42;23.13;57.19;37.17;54.31;53.58;45.5;60.06;40.65;58.01;71.41;59.14;50.44;40.15;65.56;130.79;32.54;53.83;45.99;29.93;64.82;69.44;92.07;28.2;62.07;41.71;63.04;49.66;39.73 2000-09-07;32.23;58.74;22.62;57.87;36.57;54.14;53.27;40.78;60.54;41.02;58.01;73.16;61.02;50.32;37.57;67.29;132.72;31.69;55.03;46.09;29.31;66.05;70.06;89.62;28.2;61.27;41.59;62.73;50.65;41.22 2000-09-08;32.72;60.04;22.39;57.5;36.33;55.87;53.83;39.94;60.6;40.9;58.87;70.81;59.64;52.75;34.37;65.23;128.86;31.27;55.57;46.6;28.56;66.32;69.31;87.97;27.97;62.07;43.84;61.12;51.77;39.97 2000-09-11;31.66;61.21;22.57;57.99;36.81;56.12;52.29;39.21;59.64;41.63;58.69;71.96;56.19;54.05;35.91;64.54;123.89;30.54;55.27;46.87;28.19;66.72;68.81;86.99;28.15;61.33;44.69;62.11;54.01;39.66 2000-09-12;29.77;60.78;22.76;58.36;36.51;55.87;52.78;39.82;59.15;42;58.07;69.66;54.71;55.67;36.34;64.79;124.38;30.41;50.76;47.66;28.81;66.49;68.12;86.14;28.15;61.7;44.38;62.11;53.63;38.36 2000-09-13;29.95;60.72;23.5;58.8;37.17;55.13;51.96;39.7;58.67;42.03;58.07;70.45;51.75;54.55;36.83;61.11;127.06;30.66;48.72;48.15;27.01;67.11;68.25;84.61;27.15;61.15;44.14;62.17;53.57;39.73 2000-09-14;29.09;60.22;23.5;57.75;37.72;55.6;50.48;39.39;60.48;41.76;58.01;70.51;53.35;55.3;36.89;59.49;126.25;29.93;48.06;47.32;27.07;66.35;65.81;83.14;26.49;59.97;43.65;63.22;52.2;39.11 2000-09-15;28.14;58.74;23.87;56.26;35.97;54.45;50.29;38.79;60.42;43.1;55.8;67.61;50.76;54.05;35.85;57.39;124.38;29.32;47.22;46.86;27.82;65.98;64.19;83.26;26.24;61.15;43.05;63.16;51.7;38.92 2000-09-18;26.57;57.44;23.45;56.32;34.65;52.91;52.58;39.09;58.43;43.91;56.53;66.82;50.84;54.86;35.11;55.69;122.64;30.11;44.76;45.44;28.31;65.92;63;81.37;25.76;60.78;43.53;63.59;50.83;38.17 2000-09-19;25.4;59.23;22.9;56.14;34.11;53.65;52.33;38.74;58.07;43.1;56.04;65.92;52.57;52.81;35.36;60.24;124.32;27.98;45.06;45.29;27.69;67.09;65;82.04;26.24;60.17;44.26;61.86;49.59;38.05 2000-09-20;24.79;57.44;22.2;58.43;33.81;52.6;49.73;38.12;56.87;42.37;55.67;65.01;50.53;52.81;34.37;62.92;124.14;28.1;44.7;44.92;27.51;66.68;64.25;79.96;25.16;60.48;43.23;62.73;48.22;36.93 2000-09-21;23.86;57.69;21.65;59.35;33.45;50.93;49.05;37.52;55.31;42.28;55.31;65.98;46.89;54.8;34.87;61.35;120.9;28.04;42.89;46.49;26.82;68.87;64.19;84.55;25.34;61.52;45.42;61.49;49.72;36.87 2000-09-22;24.6;58.18;22.02;62.82;33.75;52.16;52.33;38.61;55.79;42.37;56.35;65.92;51.43;55.74;35.66;47.83;123.27;28.53;45.42;47.29;28.5;71.88;63.25;86.32;26.67;62.5;46.63;64.7;50.21;37.18 2000-09-25;23.37;59.42;21.37;63.19;34.11;53.52;53.01;38.42;56.75;42.05;57.09;64.29;48.81;54.43;34.93;45.27;122.39;27.8;45.18;47.28;29.25;70.96;61.25;88.03;27.09;61.76;47.18;65.94;48.72;37.31 2000-09-26;23.49;58.99;20.82;65.35;33.63;52.91;54.37;37.27;42.8;42.43;57.03;64.05;48.44;53.18;35.3;43.22;118.54;27.01;44.27;46.61;29.68;68.99;62.69;87.91;27.15;60.42;47;66.31;47.11;37.43 2000-09-27;23.13;58.18;20.61;63.87;32.19;50.56;55.05;37.88;40.94;43.72;58.44;64.05;51.09;54.55;34.25;43.78;117.42;27.01;43.73;46.9;29.68;71.57;60.62;87.97;28.36;60.42;46.15;67.98;47.85;37.31 2000-09-28;23.99;60.35;21.26;63.81;32.67;52.84;54.87;38.48;39.5;43.66;58.01;64.77;51.24;54.8;35.79;44.34;114.68;27.86;45.06;46.06;29.68;71.82;61.31;89.62;29.2;65.49;48.33;70.63;48.29;38.55 2000-09-29;24.91;60.16;21.63;63.81;29.79;53.46;54.56;39.57;39.32;43.65;56.97;62.78;47.88;52.75;34.99;41.47;112.07;27.92;44.39;46.33;29.99;73.11;60.31;89.13;28.42;65.55;48.52;68.53;47.85;37.99 2000-10-02;24.11;62.39;21.63;57.81;32.91;54.76;56.41;40.3;39.74;44.79;57.65;64.83;46.31;52.37;35.36;40.04;117.23;27.25;45.66;45.96;29.87;72.68;59.12;89.68;28.6;66.59;48.7;67.42;45.99;39.23 2000-10-03;26.51;60.9;21.73;59.23;33.69;56.24;55.73;42.96;39.74;44.48;58.21;63.62;46.15;53.62;36.52;40.22;110.02;28.83;44.94;45.62;30.05;72.68;56.56;91.94;29.02;67.33;48.58;69.77;45.55;39.04 2000-10-04;26.82;60.36;22.19;60.47;33.75;54.14;56.66;43.93;38.96;43.72;58.02;63.62;47.2;55.36;37.2;41.91;113.81;30.66;44.1;44.55;29.8;72.25;55.44;93.41;29.98;68.61;50.34;69.71;45.86;39.6 2000-10-05;26.69;60.49;21.54;60.4;33.63;55.5;58.52;43.33;38.84;43.68;58.88;61.09;43.56;53.56;35.97;40.91;112.63;29.08;43.01;45.9;29.93;73.96;55.38;91.21;29.38;71.42;52.36;71.87;45.8;40.97 2000-10-06;27.12;57.45;20.33;60.34;33.15;52.91;57.84;43.14;37.93;43.81;58.58;60.12;43.04;50.88;35.85;39.85;115.43;29.02;41.49;45.53;29.68;74.7;55.56;90.17;29.08;72.34;52.12;71.13;45.24;40.41 2000-10-09;28.17;56.15;19.82;58.8;33.21;52.04;57.22;43.51;38.71;44.63;57.65;60.12;44.89;50.69;36.28;38.98;117.36;28.53;40.71;45.04;29.87;73.96;54.19;89.74;29.68;71.3;51.26;69.21;44.87;40.66 2000-10-10;29.15;55.03;19.95;58.92;32.07;50.43;57.59;43.2;38.71;45.7;57.22;57.65;44.15;50.51;35.79;37.48;114.31;27.62;39.5;46.67;29.74;75.5;54.56;91.09;30.11;70.87;49.8;70.94;46.11;41.09 2000-10-11;26.75;53.92;18.84;59.54;31.95;48.95;57.96;42.18;39.08;45.92;55.8;56.62;42.24;48.76;35.42;35.3;111.45;29.02;39.38;47.35;29.8;75.13;55.75;91.21;30.41;71.91;48.02;70.63;45.06;40.04 2000-10-12;25.52;51.44;17.81;55.52;30.63;46.23;56.66;40.6;37.99;46.1;53.71;55.42;41.31;34.75;34.37;37.04;102.62;27.37;36.6;47.84;28.19;75.81;54.38;88.89;31.13;72.04;48.76;67.17;43.87;38.73 2000-10-13;25.4;53.48;18.37;58.12;30.45;49.26;56.6;39.27;37.45;44.33;56.17;55.72;44.73;36.18;34.01;40.28;108.53;26.7;38.41;47.26;28.69;74.82;53.75;89.01;29.92;71.06;49;68.84;44.74;39.48 2000-10-16;24.85;55.28;17.9;59.54;30.51;50.25;58.02;40.06;37.33;43.01;56.91;55.42;45.75;37.55;35.17;35.61;110.58;26.89;38.29;47.81;28.81;75.5;50.38;90.17;29.68;70.38;49.61;71.19;47.04;37.99 2000-10-17;25.59;53.3;17.16;59.85;29.31;48.83;57.34;38.79;35.05;43.01;54.82;53.91;44.67;35;34.62;36.11;112.44;26.1;36.72;47.87;27.82;76.79;50.44;89.13;30.59;71.73;51.26;68.84;45.74;35.2 2000-10-18;24.29;53.79;17.44;60.1;28.97;49.01;57.59;40.24;36.79;42.4;54.7;52.76;42.24;36.37;33.09;38.1;94.97;29.2;35.69;46.49;27.88;76.79;51.75;89.13;31.85;73.08;51.51;67.54;46.48;35.26 2000-10-19;23.93;55.59;18.51;57.81;29.64;50.74;56.54;39.27;35.59;42.37;54.82;55.9;44.89;38.49;35.23;41.84;95.96;29.87;37.68;45.25;27.69;76.17;61.88;87.05;31.79;71.42;50.89;63.22;47.54;34.7 2000-10-20;23.19;55.59;20.14;59.35;29.82;50.37;54.25;39.27;36.07;43.32;51.37;56.32;47.39;39.3;45.18;42.97;94.28;29.44;37.14;45.32;28.07;80.41;65.19;85.34;32.1;71.3;49.61;64.21;46.3;36.13 2000-10-23;23.62;53.92;20.61;60.59;30.55;49.88;54.74;39.39;37.57;43.62;49.03;54.33;48.56;40.42;49.05;43.22;92.42;28.89;37.14;45.16;28.94;83.23;62.12;87.85;33.54;68.06;52.91;62.73;47.04;35.94 2000-10-24;24.54;56.65;20.05;60.34;30.97;51.11;55.55;41.75;37.99;42.49;52.6;55.66;45.66;39.11;52.36;41.91;90.99;31.69;38.77;45.22;28.94;83.91;61.5;88.09;33.85;72.04;52.67;63.9;48.1;35.94 2000-10-25;24.54;56.89;17.44;61.89;30.43;50.06;57.34;41.27;39.08;42.7;52.17;54.33;42.85;38.24;51.32;41.22;87.13;31.14;38.71;46.33;28.81;85.75;61.25;88.15;34.39;73.32;53.58;63.22;45.68;34.57 2000-10-26;24.36;53.98;16.27;62.38;30.91;48.46;58.08;40.6;39.98;42.98;51.37;54.93;42.45;38.8;51.26;44.59;92.29;32.85;38.71;45.93;28.75;85.14;64.44;90.17;34.75;73.32;53.22;65.69;43.19;34.88 2000-10-27;24.6;55.34;16.36;63.06;31.95;49.69;58.33;40.97;40.58;42.89;51.49;57.95;43.04;39.23;50.58;46.27;93.23;32.36;41.31;45.75;29.56;86.42;67.69;91.46;35.41;75.28;55.05;66.43;43;34.08 2000-10-30;27.8;57.95;16.88;63.99;33.95;50.99;59.26;43.57;42.68;43.81;53.22;57.83;45.23;40.79;52.79;44.9;92.85;35.04;42.34;46.55;30.98;87.1;69.06;92.92;36.62;75.22;56.82;68.04;43.5;34.64 2000-10-31;28.23;59.5;17.3;67.08;34.07;52.04;59.75;43.93;43.16;43.68;54.02;60;45.91;42.85;52.85;44.9;98.01;35.46;44.04;45.44;30.8;88.33;68.88;94.51;35.35;69.9;56.39;68.96;45.12;35.57 2000-11-01;28.72;57.88;16.41;65.04;33.77;51.11;60.25;42.54;43.46;45.09;53.65;59.28;43.87;43.9;52.54;44.77;98.08;35.1;44.22;44.88;31.42;88.14;69.62;93.05;35.29;67.51;54.81;67.79;46.42;36.37 2000-11-02;27.43;57.14;16.09;65.41;33.83;52.62;60.12;42.36;45.03;43.19;52.91;57.47;44.49;42.6;51.19;46.58;101.44;34.49;44.04;44.33;31.73;87.53;70.31;92.86;34.93;66.47;54.74;67.91;48.16;37.06 2000-11-03;27.3;59.12;16.74;65.35;33.83;53.48;58.7;41.69;44.97;42.86;52.54;55.05;45.66;41.1;50.7;45.85;99.63;36.01;43.01;45.22;32.16;86.3;68.25;92.8;33.79;66.78;55.9;66.31;47.11;37.8 2000-11-06;28.48;60.12;16.36;65.35;35.16;54.41;59.88;41.27;45.03;43.44;53.71;58.86;45.35;41.16;51.93;46.48;99.82;35.46;44.04;45.41;31.79;88.39;69.5;95.25;33.66;67.02;55.29;68.96;48.72;37.06 2000-11-07;28.66;60.43;16.74;64.49;35.1;54.29;59.44;41.93;46.05;43.59;54.14;55.05;46.83;41.23;53.28;46.1;101.81;35.89;43.49;45.44;31.54;85.32;70.5;94.82;34.03;66.96;55.78;67.24;48.66;36.87 2000-11-08;28.6;57.51;16.41;64.44;35.41;52.62;59.57;43.08;45.69;44.42;53.77;55.78;45.1;41.1;52.54;42.61;99.63;35.95;42.16;46.09;31.42;89.19;69.44;95.18;35.41;67.94;56.09;66.87;48.47;36.62 2000-11-09;28.23;57.76;15.81;65.12;35.53;52.24;61.67;42.66;45.93;44.24;53.77;55.9;42.39;38.67;52.73;41.3;99.07;35.34;42.7;46.15;31.54;88.82;70.88;95.25;34.39;68;56.33;67.11;46.86;30.91 2000-11-10;28.11;56.58;15.2;62.95;34.74;51.07;61.24;41.33;45.27;44.08;53.09;53.72;38.63;36.12;52.42;36.93;92.66;35.1;41.43;46.58;32.85;89.86;67.38;92.92;35.6;70.08;55.84;65.38;43.44;31.47 2000-11-13;27.86;55.41;15.67;62.27;35.16;50.08;60.43;41.43;45.09;44.27;50.69;54.63;33.69;37.24;49.72;38.12;97.08;35.22;40.77;45.9;33.06;87.78;66.44;92.74;33.42;70.69;56.7;65.26;45.06;30.23 2000-11-14;28.54;56.83;15.43;63.82;35.04;50.32;59.94;41.67;45.27;44.24;51.99;56.09;36.53;39.05;50.95;40.86;99.14;34.55;41.19;46.67;33.44;89.43;68.81;92.92;33.42;70.87;56.03;66.49;46.61;30.73 2000-11-15;28.91;57.2;15.34;63.01;35.65;49.77;60.68;42.4;45.93;44.48;51.74;56.34;34.86;39.48;50.7;41.42;99.01;35.04;39.44;46.86;33.31;89.98;70.06;93.29;34.51;71.79;56.03;66.47;48.72;31.59 2000-11-16;27.61;57.26;15.48;65.24;35.29;51.25;61.3;40.63;45.03;44.64;51.86;55.3;34.62;39.05;50.77;39.93;97.89;33.39;39.56;46.46;32.69;88.57;68.94;93.23;35.05;72.46;56.76;67.96;47.98;30.66 2000-11-17;26.69;55.59;14.97;64.81;35.89;50.68;60.81;41.55;44.31;44.45;51.12;54.45;35.17;38.67;50.27;41.42;101.56;32.54;38.35;47.08;33.44;86.92;69.06;93.9;35.41;74.12;54.74;68.76;48.29;29.98 2000-11-20;25.88;52.18;14.45;65;36.14;48.96;55.98;40.51;42.32;44.97;49.34;50.25;34.12;38.74;48.55;41.05;102.87;32.3;37.32;47.6;33.5;88.76;67.19;92.56;35.29;73.32;55.72;68.39;47.6;29.67 2000-11-21;25.94;52.8;14.13;68.03;37.17;48.71;54.68;40.21;42.32;45.84;50.01;50;33.5;38.11;49.16;42.55;98.14;32.36;37.44;48.38;33.94;90.35;67.75;94.17;36.14;72.46;55.66;69.38;46.86;29.17 2000-11-22;25.82;51.38;13.94;64.56;36.74;46.67;58.95;39.78;42.14;46.39;47.86;49.39;33.26;36.62;47.56;41.11;98.14;32.42;36.23;47.76;34.25;89.06;68.25;94.3;34.57;73.81;57.19;69.57;45.61;28.86 2000-11-24;25.82;50.94;14.41;65.12;37.78;46.91;58.39;40.02;42.5;46.48;48.66;50.06;35.11;37.37;47.93;43.86;99.57;33.04;37.87;47.05;33.69;87.84;69.94;94.3;34.33;72.04;55.48;71.3;44.93;29.55 2000-11-27;26.56;52.55;14.08;66.79;38.57;47.04;58.95;39.72;42.26;45.84;48.41;49.21;35.23;38.61;47.93;43.86;98.08;33.04;38.11;48.19;31.94;89.98;70.69;97.68;35.23;71.3;54.19;69.32;49.03;29.73 2000-11-28;27.49;54.66;13.94;66.92;37.9;47.22;59.82;39.23;40.16;45.8;49.09;47.57;34.25;39.46;48.42;41.96;97.52;33.89;36.78;49.55;31.25;90.97;67;97.31;35.9;72.1;54.5;67.77;48.72;29.67 2000-11-29;27.55;56.46;14.17;69.33;38.99;49.02;61.66;40.57;41.38;43.77;48.97;49.21;34.12;39.9;47.62;42.67;99.45;34.69;36.72;49.62;32.5;93.18;65.06;98.54;37.1;73.93;53.95;68.76;51.58;28.62 2000-11-30;27.86;54.48;14.64;68.47;38.2;49.39;62.16;41.3;40.83;43.31;48.84;48.24;31.22;39.09;48.05;37.99;93.16;33.22;35.69;49.49;31.88;91.03;57.38;98.29;36.86;73.26;53.71;70.19;51.89;28.74 2000-12-01;28.66;53.79;14.59;65.24;39.54;48.53;61.72;41.79;39.8;43.71;50.26;49.03;31.78;38.84;49.22;34.06;95.28;35.55;36.11;48.38;30.94;89;56.62;98.05;36.32;72.34;51.02;69.88;50.9;29.79 2000-12-04;30.64;51.56;14.73;64.25;42.09;47.41;62.28;44.78;40.46;44.64;50.88;50.25;32.58;40.65;49.9;32.88;98.02;36.59;36.72;49.28;31.44;90.29;56.44;103.34;36.38;73.75;51.81;71.92;53.51;29.24 2000-12-05;31.13;53.55;15.2;68.34;42.15;50.32;60.98;45.09;39.43;43.5;53.34;51.89;34.55;43.89;52.18;35.93;103;36.53;39.98;49.24;30.5;88.39;59.88;114.78;37.22;71.61;52.24;75.2;54.94;30.48 2000-12-06;30.95;53.3;15.43;66.79;40.39;49.33;60.42;42.95;37.18;42.45;53.16;50.73;31.59;44.95;52.18;31.69;96.4;35.67;38.77;47.57;29.62;88.29;56.69;113.3;37.71;70.57;53.03;74.71;54.5;31.44 2000-12-07;28.85;52.99;14.69;66.23;40.39;49.33;61.91;42.16;38.34;43.31;52.72;50.06;30.85;44.82;51.87;32.25;92.78;34.87;37.93;48.04;30.25;89.77;53.12;112.87;38.31;71.98;53.03;74.65;54.69;30.62 2000-12-08;30.21;54.35;14.97;69.33;40.45;51.07;60.42;42.34;37.91;43.56;54.39;49.7;33.01;47.13;53.72;33.94;96.64;36.28;38.71;47.7;29.5;88.29;54.44;115.09;38.25;69.71;50.53;74.15;54.13;30.94 2000-12-11;31.81;56.03;15.29;67.78;41.18;52.43;57.88;40.94;38.46;42.21;54.51;50.25;32.7;45.01;54.4;37.37;94.65;36.9;41.13;47.33;29.94;89.34;58.06;113.42;37.65;67.57;49.67;71.61;51.08;30.38 2000-12-12;31.26;55.72;16.09;68.53;41.18;52.18;57.56;41.18;39.92;42.61;52.05;50.43;34.8;44.88;51.38;36.43;93.53;36.84;41.62;48.01;30.88;90.08;58.38;112.07;37.53;70.39;51.08;72.85;51.58;30.31 2000-12-13;32.31;56.03;16.64;67.29;40.51;52.55;57.38;42.16;38.46;43.16;52.23;51.83;32.76;45.07;51.38;35.44;90.92;37.2;43.07;48.84;31.12;90.7;57.25;112.01;39.94;70.87;52.24;70.99;50.03;29.75 2000-12-14;31.38;54.97;16.41;66.67;39.54;50.32;56.57;43.38;37.85;42.08;50.69;52.56;33.07;43.76;49.84;35.06;92.1;37.02;41.49;49.12;31.56;89.71;55.5;109.24;40.61;71.91;53.4;70.56;50.77;29 2000-12-15;30.58;54.17;15.67;64.31;39.66;47.66;53.1;42.71;37.12;41.41;49.09;52.44;31.22;41.83;47.19;32.38;87.49;36.65;42.52;48.78;31.5;89.09;49.19;110.41;39.21;69.83;52.48;70.56;49.59;29.38 2000-12-18;31.94;56.27;15.15;67.91;41.12;48.96;54.46;44.42;37.37;42.51;50.26;50.79;30.81;44.01;49.04;33.19;90.17;37.08;43.91;48.78;32.31;88.05;47.81;112.81;40.43;71.06;52.12;73.16;50.28;29.31 2000-12-19;33.11;54.48;15.34;65.8;41.66;49.83;56.32;44.54;36.58;42.91;49.4;50.55;30.99;42.52;48.18;33.38;89.8;38.74;43.37;49.09;32.88;90.2;44.81;111.95;42.14;71.55;45.52;74.09;47.73;29.12 2000-12-20;31.07;51.01;14.13;64.44;41.85;47.6;55.83;43.44;36.21;41.93;46.75;48.72;30.13;41.02;45.34;31.88;85.69;36.9;42.1;49.8;31.38;92.05;41.5;111.15;43.18;71;43.07;72.66;48.72;27.06 2000-12-21;31.38;52.12;12.73;64.07;43.49;48.34;58.93;45.39;37.61;41.71;47.18;50.06;29.07;42.76;45.65;33.07;81.26;38.8;43.73;49.99;32.69;91.19;43.44;110.9;43.18;72.89;43.87;74.34;51.52;27.69 2000-12-22;34.41;52.74;13.29;62.89;45.31;49.64;58.43;46.86;37.79;42.73;48.17;48.78;31.86;41.52;47.07;32.88;88.67;41.43;44.16;50.23;32.69;89.22;46.44;110.97;42.57;72.16;44.85;75.33;52.27;26.44 2000-12-26;34.16;52.8;13.15;62.46;46.4;50.51;59.55;47.16;36.88;43.59;48.6;49.58;31.42;40.58;47.32;32.82;84.5;41.92;44.28;50.67;32.5;91.37;46.88;113.18;43.61;72.83;45.76;77;50.4;26.94 2000-12-27;33.79;52.74;12.76;63.51;46.16;50.45;60.11;47.41;37.79;43.19;47.64;50.12;32.11;42.64;46.88;32.5;84.38;41.31;44.88;50.98;33.12;91.37;46.44;117.3;44.28;74.85;46.68;79.05;52.33;28.31 2000-12-28;34.22;53.55;12.66;64.87;46.28;50.82;60.6;48.14;39.07;42.76;47.89;49.45;32.11;43.51;47.25;30.88;84.94;41.62;45.43;51.84;33.88;93.41;44.56;120.01;43.67;75.58;46.07;77.99;52.7;28.75 2000-12-29;33.11;54.48;12.9;65.43;45.98;50.63;60.48;47.16;38.28;42.79;47.4;49.64;31.24;45.57;46.64;30.01;84.69;40.02;43.97;52;34;92.3;43.38;118.59;43.06;76.75;46.68;77.93;52.89;28.94 2001-01-02;31.88;51.56;13.64;61.46;45;50.08;60.36;46.86;37.43;43.87;43.26;50.85;29.94;45.45;43.62;31.01;84.5;38.67;42.58;50.48;33.5;91.68;43.38;117.3;45.2;76.81;49.25;74.59;53.64;27.94 fBasics/data/swissEconomy.R0000644000176200001440000000411013202116740015352 0ustar liggesusers swissEconomy <- ts(matrix(c( 50.74, 50.74, 56.69, 3.97, 3.15, 0.01, 5.79, 53.58, 53.58, 55.19, 3.95, 3.33, 0.01, 5.86, 56.21, 56.21, 56.09, 4.16, 4.84, 0.01, 5.92, 57.42, 57.42, 56.44, 4.61, 3.85, 0.01, 5.99, 62.98, 62.98, 59.78, 4.37, 2.47, 0.01, 6.07, 70.50, 70.50, 67.84, 4.90, 2.41, 0.01, 6.14, 75.18, 75.18, 79.13, 5.82, 3.76, 0.00, 6.19, 74.36, 74.36, 78.10, 5.27, 6.58, 0.00, 6.23, 75.50, 75.50, 77.77, 4.97, 6.60, 0.00, 6.39, 78.52, 78.52, 81.40, 5.60, 8.78, 0.00, 6.43, 83.90, 83.90, 88.99, 7.15, 9.72, 0.01, 6.44, 75.17, 75.17, 68.39, 6.44, 6.69, 0.33, 6.41, 79.19, 79.19, 71.46, 4.99, 1.72, 0.68, 6.35, 88.53, 88.53, 82.37, 4.05, 1.23, 0.39, 6.33, 85.11, 85.11, 79.25, 3.33, 1.07, 0.34, 6.34, 87.87, 87.87, 89.22, 3.45, 3.77, 0.33, 6.36, 89.97, 89.97, 98.61, 4.77, 3.92, 0.20, 6.32, 93.95, 93.95, 96.42, 5.57, 6.56, 0.18, 6.35, 88.55, 88.55, 87.41, 4.83, 5.64, 0.4 , 6.39, 88.97, 88.97, 89.09, 4.51, 2.98, 0.8 , 6.42, 96.50, 96.50, 97.23, 4.70, 2.89, 1.1 , 6.44, 104.19, 104.19, 103.08, 4.78, 3.40, 1.0 , 6.47, 101.16, 101.16, 98.05, 4.29, 0.79, 0.8 , 6.5 , 100.08, 100.08, 97.75, 4.12, 1.46, 0.8 , 6.55, 105.34, 105.34, 104.05, 4.15, 1.88, 0.7 , 6.59, 115.24, 115.24, 115.84, 5.20, 3.15, 0.6 , 6.65, 115.05, 115.05, 113.42, 6.68, 5.37, 0.5 , 6.71, 110.11, 110.11, 105.78, 6.35, 5.80, 1.1 , 6.8 , 112.21, 112.21, 101.21, 5.48, 4.06, 2.5 , 6.88, 112.07, 112.07, 96.64, 4.05, 3.36, 4.5 , 6.94, 111.72, 111.72, 97.66, 5.23, 0.79, 4.7 , 6.99, 110.99, 110.99, 98.30, 3.73, 1.83, 4.2 , 7.04, 113.96, 113.96, 100.76, 3.63, 0.86, 4.7 , 7.07, 128.35, 128.35, 114.06, 3.08, 0.42, 5.2 , 7.09, 131.57, 131.57, 119.09, 2.39, 0.02, 3.9 , 7.11, 139.15, 139.15, 123.79, 3.51, 0.89, 2.7 , 7.13), byrow = TRUE, ncol = 7, dimnames = list(as.character(1964:1999), c("GDPR","EXPO","IMPO","INTR","INFL","UNEM","POPU"))), start = 1964) fBasics/data/nyse.csv0000644000176200001440000051576413202116740014246 0ustar liggesusers%Y-%m-%d-;NYSE 1966-01-04;49.92 1966-01-05;50.23 1966-01-06;50.32 1966-01-07;50.37 1966-01-10;50.49 1966-01-11;50.53 1966-01-12;50.44 1966-01-13;50.54 1966-01-14;50.64 1966-01-17;50.83 1966-01-18;50.97 1966-01-19;50.85 1966-01-20;50.66 1966-01-21;50.69 1966-01-24;50.85 1966-01-25;50.89 1966-01-26;50.84 1966-01-27;50.82 1966-01-28;50.66 1966-01-31;50.44 1966-02-01;50.04 1966-02-02;50.26 1966-02-03;50.32 1966-02-04;50.64 1966-02-07;50.81 1966-02-08;50.77 1966-02-09;51.06 1966-02-10;50.92 1966-02-11;50.91 1966-02-14;50.86 1966-02-15;50.64 1966-02-16;50.63 1966-02-17;50.36 1966-02-18;50.26 1966-02-21;49.96 1966-02-23;49.74 1966-02-24;49.41 1966-02-25;49.55 1966-02-28;49.61 1966-03-01;48.98 1966-03-02;48.5 1966-03-03;48.7 1966-03-04;48.55 1966-03-07;47.89 1966-03-08;47.94 1966-03-09;48.34 1966-03-10;48.35 1966-03-11;48.31 1966-03-14;47.75 1966-03-15;47.43 1966-03-16;47.69 1966-03-17;47.84 1966-03-18;48.07 1966-03-21;48.44 1966-03-22;48.58 1966-03-23;48.42 1966-03-24;48.49 1966-03-25;48.61 1966-03-28;48.7 1966-03-29;48.5 1966-03-30;48.1 1966-03-31;48.37 1966-04-01;48.76 1966-04-04;49.2 1966-04-05;49.51 1966-04-06;49.64 1966-04-07;49.74 1966-04-11;49.72 1966-04-12;49.57 1966-04-13;49.59 1966-04-14;49.69 1966-04-15;49.78 1966-04-18;49.58 1966-04-19;49.61 1966-04-20;49.88 1966-04-21;50.04 1966-04-22;49.94 1966-04-25;49.89 1966-04-26;49.76 1966-04-27;49.59 1966-04-28;49.29 1966-04-29;49.29 1966-05-02;49.23 1966-05-03;48.68 1966-05-04;48.42 1966-05-05;47.58 1966-05-06;47.49 1966-05-09;46.67 1966-05-10;47.07 1966-05-11;47.15 1966-05-12;46.57 1966-05-13;46.09 1966-05-16;45.48 1966-05-17;45.06 1966-05-18;45.92 1966-05-19;45.85 1966-05-20;46.07 1966-05-23;46.48 1966-05-24;46.8 1966-05-25;46.98 1966-05-26;46.98 1966-05-27;47.14 1966-05-31;46.5 1966-06-01;46.51 1966-06-02;46.48 1966-06-03;46.54 1966-06-06;46.21 1966-06-07;45.88 1966-06-08;45.95 1966-06-09;46.28 1966-06-10;46.78 1966-06-13;47 1966-06-14;47.16 1966-06-15;46.98 1966-06-16;46.87 1966-06-17;46.88 1966-06-20;46.86 1966-06-21;47.03 1966-06-22;47.12 1966-06-23;46.93 1966-06-24;46.95 1966-06-27;46.66 1966-06-28;46.44 1966-06-29;45.98 1966-06-30;45.91 1966-07-01;46.36 1966-07-05;46.44 1966-07-06;47.09 1966-07-07;47.26 1966-07-08;47.34 1966-07-11;47.27 1966-07-12;47.03 1966-07-13;46.74 1966-07-14;47.01 1966-07-15;47.15 1966-07-18;47.1 1966-07-19;46.76 1966-07-20;46.34 1966-07-21;46.33 1966-07-22;46.29 1966-07-25;45.42 1966-07-26;45.31 1966-07-27;45.54 1966-07-28;45.37 1966-07-29;45.29 1966-08-01;44.6 1966-08-02;44.59 1966-08-03;45.03 1966-08-04;45.44 1966-08-05;45.5 1966-08-08;45.38 1966-08-09;45.28 1966-08-10;45.08 1966-08-11;45.04 1966-08-12;45.15 1966-08-15;44.93 1966-08-16;44.35 1966-08-17;44.09 1966-08-18;43.53 1966-08-19;43.21 1966-08-22;42.44 1966-08-23;42.39 1966-08-24;42.89 1966-08-25;42.35 1966-08-26;41.41 1966-08-29;40.32 1966-08-30;40.99 1966-08-31;41.65 1966-09-01;41.94 1966-09-02;41.81 1966-09-06;41.58 1966-09-07;41.21 1966-09-08;41.07 1966-09-09;41.2 1966-09-12;42.07 1966-09-13;42.31 1966-09-14;42.7 1966-09-15;43.15 1966-09-16;43.14 1966-09-19;42.94 1966-09-20;42.65 1966-09-21;41.93 1966-09-22;42.02 1966-09-23;41.9 1966-09-26;42 1966-09-27;42.12 1966-09-28;41.62 1966-09-29;41.17 1966-09-30;41.3 1966-10-03;40.42 1966-10-04;40.47 1966-10-05;40.24 1966-10-06;39.85 1966-10-07;39.37 1966-10-10;40.05 1966-10-11;40.26 1966-10-12;41.35 1966-10-13;41.33 1966-10-14;41.21 1966-10-17;41.67 1966-10-18;42.35 1966-10-19;42.04 1966-10-20;41.92 1966-10-21;42.07 1966-10-24;42.18 1966-10-25;42.41 1966-10-26;42.79 1966-10-27;43.15 1966-10-28;43.17 1966-10-31;43.16 1966-11-01;43.49 1966-11-02;43.54 1966-11-03;43.39 1966-11-04;43.53 1966-11-07;43.52 1966-11-09;43.86 1966-11-10;44.15 1966-11-11;44.19 1966-11-14;43.92 1966-11-15;44.08 1966-11-16;44.46 1966-11-17;44.16 1966-11-18;43.89 1966-11-21;43.28 1966-11-22;43.08 1966-11-23;43.4 1966-11-25;43.75 1966-11-28;43.71 1966-11-29;43.56 1966-11-30;43.59 1966-12-01;43.42 1966-12-02;43.44 1966-12-05;43.48 1966-12-06;43.78 1966-12-07;44.22 1966-12-08;44.4 1966-12-09;44.5 1966-12-12;44.93 1966-12-13;44.81 1966-12-14;44.8 1966-12-15;44.33 1966-12-16;44.34 1966-12-19;44.22 1966-12-20;44.04 1966-12-21;44.28 1966-12-22;44.46 1966-12-23;44.35 1966-12-27;44.12 1966-12-28;43.9 1966-12-29;43.74 1966-12-30;43.72 1967-01-03;43.74 1967-01-04;43.82 1967-01-05;44.38 1967-01-06;44.71 1967-01-09;45.08 1967-01-10;45.08 1967-01-11;45.45 1967-01-12;45.72 1967-01-13;46.04 1967-01-16;45.96 1967-01-17;46.46 1967-01-18;46.72 1967-01-19;46.74 1967-01-20;46.91 1967-01-23;47.08 1967-01-24;47.17 1967-01-25;46.85 1967-01-26;46.88 1967-01-27;47.08 1967-01-30;47.35 1967-01-31;47.3 1967-02-01;47.24 1967-02-02;47.39 1967-02-03;47.73 1967-02-06;47.64 1967-02-07;47.54 1967-02-08;47.96 1967-02-09;47.77 1967-02-10;47.87 1967-02-13;47.94 1967-02-14;48.26 1967-02-15;48.29 1967-02-16;48.08 1967-02-17;48.09 1967-02-20;47.84 1967-02-21;47.84 1966-02-23;47.89 1967-02-24;47.9 1967-02-27;47.39 1967-02-28;47.56 1967-03-01;48.03 1967-03-02;48.3 1967-03-03;48.37 1967-03-06;48.3 1967-03-07;48.36 1967-03-08;48.43 1967-03-09;48.57 1967-03-10;48.75 1967-03-13;48.52 1967-03-14;48.47 1967-03-15;48.9 1967-03-16;49.35 1967-03-17;49.44 1967-03-20;49.43 1967-03-21;49.3 1967-03-22;49.44 1967-03-23;49.79 1967-03-27;49.77 1967-03-28;49.81 1967-03-29;49.75 1967-03-30;49.77 1967-03-31;49.52 1967-04-03;48.98 1967-04-04;48.99 1967-04-05;49.29 1967-04-06;49.4 1967-04-07;49.1 1967-04-10;48.5 1967-04-11;48.84 1967-04-12;48.79 1967-04-13;49.11 1967-04-14;49.62 1967-04-17;49.95 1967-04-18;50.36 1967-04-19;50.42 1967-04-20;50.53 1967-04-21;50.65 1967-04-24;50.81 1967-04-25;51.08 1967-04-26;51.03 1967-04-27;51.45 1967-04-28;51.54 1967-05-01;51.51 1967-05-02;51.47 1967-05-03;51.6 1967-05-04;51.79 1967-05-05;51.85 1967-05-08;51.93 1967-05-09;51.4 1967-05-10;51.31 1967-05-11;51.56 1967-05-12;51.45 1967-05-15;51.06 1967-05-16;51.29 1967-05-17;51.15 1967-05-18;51.04 1967-05-19;50.83 1967-05-22;50.66 1967-05-23;50.44 1967-05-24;49.85 1967-05-25;50.34 1967-05-26;50.25 1967-05-29;49.99 1967-05-31;49.17 1967-06-01;49.77 1967-06-02;49.56 1967-06-05;48.74 1967-06-06;49.69 1967-06-07;50.13 1967-06-08;50.41 1967-06-09;50.55 1967-06-12;50.85 1967-06-13;51.15 1967-06-14;51.06 1967-06-15;51.14 1967-06-16;51.16 1967-06-19;51.17 1967-06-20;51.15 1967-06-21;51.03 1967-06-22;50.92 1967-06-23;50.94 1967-06-26;50.74 1967-06-27;50.56 1967-06-28;50.59 1967-06-29;50.35 1967-06-30;50.27 1967-07-03;50.43 1967-07-05;50.69 1967-07-06;50.67 1967-07-07;50.91 1967-07-10;51.16 1967-07-11;51.39 1967-07-12;51.39 1967-07-13;51.42 1967-07-14;51.6 1967-07-17;51.63 1967-07-18;52 1967-07-19;52.06 1967-07-20;52.14 1967-07-21;52.18 1967-07-24;52 1967-07-25;52 1967-07-26;52.22 1967-07-27;52.4 1967-07-28;52.5 1967-07-31;52.65 1967-08-01;52.97 1967-08-02;53.16 1967-08-03;53.09 1967-08-04;53.22 1967-08-07;53.08 1967-08-08;53.13 1967-08-09;53.19 1967-08-10;53.05 1967-08-11;52.81 1967-08-14;52.5 1967-08-15;52.56 1967-08-16;52.44 1967-08-17;52.51 1967-08-18;52.59 1967-08-21;52.32 1967-08-22;52.04 1967-08-23;51.98 1967-08-24;51.7 1967-08-25;51.49 1967-08-28;51.46 1967-08-29;51.6 1967-08-30;51.73 1967-08-31;52.07 1967-09-01;52.15 1967-09-05;52.42 1967-09-06;52.51 1967-09-07;52.49 1967-09-08;52.49 1967-09-11;52.58 1967-09-12;52.84 1967-09-13;53.36 1967-09-14;53.44 1967-09-15;53.48 1967-09-18;53.61 1967-09-19;53.37 1967-09-20;53.39 1967-09-21;53.69 1967-09-22;53.85 1967-09-25;54.14 1967-09-26;53.66 1967-09-27;53.69 1967-09-28;53.72 1967-09-29;53.71 1967-10-02;53.51 1967-10-03;53.68 1967-10-04;53.61 1967-10-05;53.74 1967-10-06;54.05 1967-10-09;54.16 1967-10-10;53.78 1967-10-11;53.53 1967-10-12;53.2 1967-10-13;53.32 1967-10-16;52.9 1967-10-17;52.8 1967-10-18;52.93 1967-10-19;52.99 1967-10-20;52.93 1967-10-23;52.7 1967-10-24;52.41 1967-10-25;52.48 1967-10-26;52.71 1967-10-27;52.72 1967-10-30;52.63 1967-10-31;52.13 1967-11-01;51.47 1967-11-02;51.24 1967-11-03;50.96 1967-11-06;50.78 1967-11-08;50.6 1967-11-09;50.81 1967-11-10;51.12 1967-11-13;50.97 1967-11-14;50.6 1967-11-15;50.81 1967-11-16;51.3 1967-11-17;51.47 1967-11-20;50.78 1967-11-21;51.63 1967-11-22;51.96 1967-11-24;52.1 1967-11-27;52.26 1967-11-28;52.47 1967-11-29;52.5 1967-11-30;52.26 1967-12-01;52.52 1967-12-04;52.86 1967-12-05;52.91 1967-12-06;53.11 1967-12-07;53.07 1967-12-08;53.02 1967-12-11;52.92 1967-12-12;52.89 1967-12-13;53.09 1967-12-14;53.18 1967-12-15;52.89 1967-12-18;52.75 1967-12-19;52.71 1967-12-20;53 1967-12-21;53.14 1967-12-22;53.06 1967-12-26;53.14 1967-12-27;53.51 1967-12-28;53.5 1967-12-29;53.83 1968-01-02;53.68 1968-01-03;53.4 1968-01-04;53.25 1968-01-05;53.57 1968-01-08;53.96 1968-01-09;53.9 1968-01-10;53.95 1968-01-11;54.07 1968-01-12;54.17 1968-01-15;54.07 1968-01-16;53.75 1968-01-17;53.7 1968-01-18;53.68 1968-01-19;53.5 1968-01-22;52.78 1968-01-23;52.53 1968-01-24;52.31 1968-01-25;52.35 1968-01-26;52.45 1968-01-29;52.37 1968-01-30;52.08 1968-01-31;51.66 1968-02-01;51.82 1968-02-02;51.67 1968-02-05;51.42 1968-02-06;51.44 1968-02-07;51.52 1968-02-08;50.83 1968-02-09;50.22 1968-02-13;49.72 1968-02-14;50.32 1968-02-15;50.42 1968-02-16;50.21 1968-02-19;50.38 1968-02-20;50.68 1968-02-21;50.91 1968-02-23;50.68 1968-02-26;50.27 1968-02-27;50.45 1968-02-28;50.2 1968-02-29;49.77 1968-03-01;49.58 1968-03-04;48.86 1968-03-05;48.7 1968-03-06;49.55 1968-03-07;49.47 1968-03-08;49.43 1968-03-11;50.07 1968-03-12;50.16 1968-03-13;50.08 1968-03-14;49.07 1968-03-15;49.47 1968-03-18;49.76 1968-03-19;49.45 1968-03-20;49.42 1968-03-21;49.04 1968-03-22;49.05 1968-03-25;48.99 1968-03-26;49.33 1968-03-27;49.75 1968-03-28;49.71 1968-03-29;50.05 1968-04-01;51.27 1968-04-02;51.38 1968-04-03;51.84 1968-04-04;52.07 1968-04-05;51.79 1968-04-08;52.71 1968-04-10;53.11 1968-04-11;53.6 1968-04-15;53.69 1968-04-16;53.74 1968-04-17;53.9 1968-04-18;54.06 1968-04-19;53.39 1968-04-22;53.12 1968-04-23;53.77 1968-04-24;53.92 1968-04-25;54.08 1968-04-26;54.26 1968-04-29;54.41 1968-04-30;54.49 1968-05-01;54.67 1968-05-02;55.03 1968-05-03;55.06 1968-05-06;54.94 1968-05-07;55.25 1968-05-08;55.29 1968-05-09;55 1968-05-10;55.14 1968-05-13;55.01 1968-05-14;54.98 1968-05-15;54.96 1968-05-16;54.71 1968-05-17;54.38 1968-05-20;54.13 1968-05-21;54.42 1968-05-22;54.6 1968-05-23;54.53 1968-05-24;54.63 1968-05-27;54.56 1968-05-28;54.9 1968-05-29;55.07 1968-05-31;55.5 1968-06-03;56.19 1968-06-04;56.47 1968-06-05;56.22 1968-06-06;56.72 1968-06-07;57.11 1968-06-10;57.18 1968-06-11;57.32 1968-06-13;57.1 1968-06-14;57.02 1968-06-17;56.41 1968-06-18;56.35 1968-06-20;56.67 1968-06-21;56.77 1968-06-24;56.58 1968-06-25;56.37 1968-06-27;56.28 1968-06-28;56.08 1968-07-01;55.96 1968-07-02;56.19 1968-07-03;56.88 1968-07-08;57.48 1968-07-09;57.61 1968-07-11;57.69 1968-07-12;57.65 1968-07-15;57.56 1968-07-16;57.26 1968-07-18;57.09 1968-07-19;56.54 1968-07-22;55.81 1968-07-23;55.7 1968-07-25;54.98 1968-07-26;55.16 1968-07-29;54.71 1968-07-30;54.78 1968-08-01;54.5 1968-08-02;54.18 1968-08-05;54.36 1968-08-06;54.6 1968-08-08;54.47 1968-08-09;54.46 1968-08-12;54.99 1968-08-13;55.24 1968-08-15;55.02 1968-08-16;55.35 1968-08-19;55.54 1968-08-20;55.54 1968-08-22;55.37 1968-08-23;55.39 1968-08-26;55.48 1968-08-27;55.38 1968-08-29;55.34 1968-08-30;55.44 1968-09-03;55.65 1968-09-04;56 1968-09-05;56.4 1968-09-06;56.63 1968-09-09;56.69 1968-09-10;56.42 1968-09-12;56.29 1968-09-13;56.5 1968-09-16;56.71 1968-09-17;56.86 1968-09-19;56.96 1968-09-20;57.03 1968-09-23;57.33 1968-09-24;57.54 1968-09-26;57.44 1968-09-27;57.47 1968-09-30;57.7 1968-10-01;57.81 1968-10-03;58.04 1968-10-04;58.23 1968-10-07;58.23 1968-10-08;58.22 1968-10-10;57.98 1968-10-11;57.98 1968-10-14;58.07 1968-10-15;58.2 1968-10-17;58.5 1968-10-18;58.91 1968-10-21;58.99 1968-10-22;58.79 1968-10-24;58.45 1968-10-25;58.63 1968-10-28;58.43 1968-10-29;58.1 1968-10-31;58.17 1968-11-01;57.95 1968-11-04;57.97 1968-11-06;58.08 1968-11-07;58.19 1968-11-08;58.47 1968-11-12;58.93 1968-11-13;59.26 1968-11-14;59.32 1968-11-15;59.65 1968-11-18;59.74 1968-11-19;59.91 1968-11-21;59.86 1968-11-22;60.09 1968-11-25;60.23 1968-11-26;60.65 1968-11-27;60.91 1968-11-29;61.27 1968-12-02;61.14 1968-12-03;61.09 1968-12-05;60.88 1968-12-06;61.03 1968-12-09;60.91 1968-12-10;60.81 1968-12-12;60.78 1968-12-13;60.96 1968-12-16;60.72 1968-12-17;60.46 1968-12-19;60.61 1968-12-20;60.3 1968-12-23;59.67 1968-12-24;59.57 1968-12-26;59.64 1968-12-27;59.42 1968-12-30;58.84 1968-12-31;58.9 1969-01-02;58.94 1969-01-03;58.95 1969-01-06;58.08 1969-01-07;57.35 1969-01-08;57.07 1969-01-09;57.3 1969-01-10;57.14 1969-01-13;56.77 1969-01-14;57.17 1969-01-15;57.5 1969-01-16;57.81 1969-01-17;57.76 1969-01-20;57.63 1969-01-21;57.58 1969-01-22;57.81 1969-01-23;58.11 1969-01-24;58.1 1969-01-27;58.1 1969-01-28;58.1 1969-01-29;58.14 1969-01-30;58.16 1969-01-31;58.38 1969-02-03;58.3 1969-02-04;58.31 1969-02-05;58.42 1969-02-06;58.6 1969-02-07;58.64 1969-02-11;58.7 1969-02-12;58.68 1969-02-13;58.7 1969-02-14;58.64 1969-02-17;57.93 1969-02-18;57.28 1969-02-19;56.83 1969-02-20;56.31 1969-02-24;55.59 1969-02-25;55.19 1969-02-26;55.44 1969-02-27;55.21 1969-02-28;55.19 1969-03-03;55.28 1969-03-04;55.82 1969-03-05;56.01 1969-03-06;55.39 1969-03-07;55.33 1969-03-10;55.51 1969-03-11;55.72 1969-03-12;55.57 1969-03-13;55.18 1969-03-14;54.93 1969-03-17;55.06 1969-03-18;55.22 1969-03-19;55.62 1969-03-20;55.98 1969-03-21;55.87 1969-03-24;55.78 1969-03-25;55.84 1969-03-26;56.21 1969-03-27;56.62 1969-03-28;56.85 1969-04-01;56.77 1969-04-02;56.39 1969-04-03;56.36 1969-04-07;55.89 1969-04-08;56.03 1969-04-09;56.49 1969-04-10;56.77 1969-04-11;56.82 1969-04-14;56.75 1969-04-15;56.72 1969-04-16;56.23 1969-04-17;56.32 1969-04-18;56.56 1969-04-21;56.15 1969-04-22;56.25 1969-04-23;56.32 1969-04-24;56.57 1969-04-25;56.84 1969-04-28;57.03 1969-04-29;57.48 1969-04-30;57.99 1969-05-01;57.93 1969-05-02;58.17 1969-05-05;58.4 1969-05-06;58.66 1969-05-07;58.54 1969-05-08;58.76 1969-05-09;58.76 1969-05-12;58.67 1969-05-13;58.9 1969-05-14;59.32 1969-05-15;59.14 1969-05-16;59.16 1969-05-19;58.66 1969-05-20;58.16 1969-05-21;58.41 1969-05-22;58.5 1969-05-23;58.48 1969-05-26;58.36 1969-05-27;57.9 1969-05-28;57.74 1969-05-29;57.87 1969-06-02;57.58 1969-06-03;57.39 1969-06-04;57.39 1969-06-05;57.45 1969-06-06;57.08 1969-06-09;56.54 1969-06-10;56.09 1969-06-11;55.56 1969-06-12;54.8 1969-06-13;55 1969-06-16;54.81 1969-06-17;54.54 1969-06-18;54.44 1969-06-19;54.01 1969-06-20;53.65 1969-06-23;53.32 1969-06-24;53.9 1969-06-25;53.72 1969-06-26;53.84 1969-06-27;53.88 1969-06-30;54.13 1969-07-01;54.35 1969-07-02;54.82 1969-07-03;55.21 1969-07-07;54.87 1969-07-08;54.12 1969-07-09;53.7 1969-07-10;52.85 1969-07-11;53.05 1969-07-14;52.37 1969-07-15;52.15 1969-07-16;52.7 1969-07-17;52.98 1969-07-18;52.58 1969-07-22;51.78 1969-07-23;51.52 1969-07-24;51.33 1969-07-25;50.82 1969-07-28;49.73 1969-07-29;49.31 1969-07-30;49.55 1969-07-31;50.64 1969-08-01;51.62 1969-08-04;51.35 1969-08-05;51.57 1969-08-06;51.88 1969-08-07;51.94 1969-08-08;51.9 1969-08-11;51.59 1969-08-12;51.17 1969-08-13;51.19 1969-08-14;51.56 1969-08-15;51.98 1969-08-18;52.35 1969-08-19;52.64 1969-08-20;52.64 1969-08-21;52.78 1969-08-22;53.11 1969-08-25;52.61 1969-08-26;52.21 1969-08-27;52.37 1969-08-28;52.58 1969-08-29;52.94 1969-09-02;52.9 1969-09-03;52.55 1969-09-04;52.11 1969-09-05;51.8 1969-09-08;51.28 1969-09-09;51.65 1969-09-10;52.49 1969-09-11;52.15 1969-09-12;52.19 1969-09-15;52.5 1969-09-16;52.6 1969-09-17;52.47 1969-09-18;52.65 1969-09-19;52.84 1969-09-22;53.07 1969-09-23;53.08 1969-09-24;52.98 1969-09-25;52.59 1969-09-26;52.23 1969-09-29;51.85 1969-09-30;51.69 1969-10-01;51.37 1969-10-02;51.8 1969-10-03;51.77 1969-10-06;51.86 1969-10-07;51.74 1969-10-08;51.49 1969-10-09;51.66 1969-10-10;51.98 1969-10-13;52.63 1969-10-14;53.32 1969-10-15;53.36 1969-10-16;53.76 1969-10-17;53.72 1969-10-20;53.88 1969-10-21;54.31 1969-10-22;54.66 1969-10-23;54.49 1969-10-24;54.89 1969-10-27;54.83 1969-10-28;54.68 1969-10-29;54.2 1969-10-30;54.28 1969-10-31;54.45 1969-11-03;54.41 1969-11-04;54.46 1969-11-05;54.7 1969-11-06;54.73 1969-11-07;55.07 1969-11-10;55.12 1969-11-11;54.94 1969-11-12;54.86 1969-11-13;54.56 1969-11-14;54.33 1969-11-17;53.92 1969-11-18;53.9 1969-11-19;53.63 1969-11-20;53.04 1969-11-21;52.68 1969-11-24;52.12 1969-11-25;51.98 1969-11-26;52.16 1969-11-28;52.49 1969-12-01;52.12 1969-12-02;51.78 1969-12-03;51.18 1969-12-04;51.36 1969-12-05;51.2 1969-12-08;50.59 1969-12-08;50.51 1969-12-10;50.47 1969-12-11;50.51 1969-12-12;50.66 1969-12-15;50.52 1969-12-16;50.04 1969-12-17;49.78 1969-12-18;50.58 1969-12-19;51 1969-12-22;50.53 1969-12-23;50.28 1969-12-24;50.87 1969-12-26;51.29 1969-12-29;50.93 1969-12-30;51.23 1969-12-31;51.53 1970-01-02;52.1 1970-01-05;52.36 1970-01-06;52 1970-01-07;51.92 1970-01-08;51.96 1970-01-09;51.82 1970-01-12;51.41 1970-01-13;51.44 1970-01-14;51.34 1970-01-15;51.34 1970-01-16;50.94 1970-01-19;50.27 1970-01-20;50.36 1970-01-21;50.4 1970-01-22;50.43 1970-01-23;49.93 1970-01-26;49.38 1970-01-27;49.04 1970-01-28;48.59 1970-01-29;47.94 1970-01-30;47.54 1970-02-02;47.92 1970-02-03;48.53 1970-02-04;48.19 1970-02-05;47.98 1970-02-06;48.24 1970-02-09;48.64 1970-02-10;48.2 1970-02-11;48.65 1970-02-12;48.57 1970-02-13;48.49 1970-02-16;48.45 1970-02-17;48.36 1970-02-18;48.93 1970-02-19;49.09 1970-02-20;49.2 1970-02-24;49.2 1970-02-25;49.97 1970-02-26;49.73 1970-02-27;50.1 1970-03-02;50.19 1970-03-03;50.48 1970-03-04;50.38 1970-03-05;50.37 1970-03-06;50.04 1970-03-09;49.51 1970-03-10;49.58 1970-03-11;49.53 1970-03-12;49.31 1970-03-13;49.02 1970-03-16;48.48 1970-03-17;48.67 1970-03-18;48.8 1970-03-19;48.69 1970-03-20;48.47 1970-03-23;48.44 1970-03-24;48.93 1970-03-25;49.96 1970-03-26;50.03 1970-03-30;49.88 1970-03-31;49.87 1970-04-01;50.1 1970-04-02;49.93 1970-04-03;49.7 1970-04-06;49.3 1970-04-07;49.15 1970-04-08;49.07 1970-04-09;49.04 1970-04-10;48.86 1970-04-13;48.46 1970-04-14;48.07 1970-04-15;47.94 1970-04-16;47.44 1970-04-17;47.29 1970-04-20;47.39 1970-04-21;47.14 1970-04-22;46.47 1970-04-23;45.74 1970-04-24;45.53 1970-04-27;44.74 1970-04-28;44.08 1970-04-29;44.98 1970-04-30;44.82 1970-05-01;44.75 1970-05-04;43.59 1970-05-05;43.11 1970-05-06;43.6 1970-05-07;43.85 1970-05-08;43.61 1970-05-11;43.13 1970-05-12;42.73 1970-05-13;41.99 1970-05-14;41.37 1970-05-15;42.14 1970-05-18;42.16 1970-05-19;41.35 1970-05-20;40.27 1970-05-21;39.46 1970-05-22;39.44 1970-05-25;38.2 1970-05-26;37.69 1970-05-27;39.65 1970-05-28;40.69 1970-05-29;41.78 1970-06-01;42.53 1970-06-02;42.54 1970-06-03;43.01 1970-06-04;42.36 1970-06-05;41.66 1970-06-08;41.71 1970-06-09;41.7 1970-06-10;41.28 1970-06-11;40.7 1970-06-12;40.54 1970-06-15;40.67 1970-06-16;41.59 1970-06-17;41.5 1970-06-18;41.76 1970-06-19;42.06 1970-06-22;41.8 1970-06-23;40.78 1970-06-24;40.33 1970-06-25;40.32 1970-06-26;40.02 1970-06-29;39.68 1970-06-30;39.58 1970-07-01;39.71 1970-07-02;39.64 1970-07-06;39.02 1970-07-07;38.7 1970-07-08;39.63 1970-07-09;40.26 1970-07-10;40.54 1970-07-13;40.51 1970-07-14;40.46 1970-07-15;40.87 1970-07-16;41.44 1970-07-17;42.15 1970-07-20;42.21 1970-07-21;41.8 1970-07-22;41.85 1970-07-23;42.38 1970-07-24;42.28 1970-07-27;42.19 1970-07-28;42.28 1970-07-29;42.45 1970-07-30;42.47 1970-07-31;42.43 1970-08-03;41.9 1970-08-04;41.96 1970-08-05;41.94 1970-08-06;41.86 1970-08-07;41.97 1970-08-10;41.36 1970-08-11;41.14 1970-08-12;40.95 1970-08-13;40.59 1970-08-14;40.77 1970-08-17;40.83 1970-08-18;41.28 1970-08-19;41.66 1970-08-20;41.98 1970-08-21;42.85 1970-08-24;43.85 1970-08-25;43.98 1970-08-26;44.09 1970-08-27;44.04 1970-08-28;44.48 1970-08-31;44.32 1970-09-01;44.03 1970-09-02;44.01 1970-09-03;44.64 1970-09-04;45.11 1970-09-08;45.27 1970-09-09;45.14 1970-09-10;44.89 1970-09-11;45.04 1970-09-14;44.82 1970-09-15;44.39 1970-09-16;44.64 1970-09-17;45 1970-09-18;45.19 1970-09-21;44.82 1970-09-22;44.66 1970-09-23;45.27 1970-09-24;45.91 1970-09-25;45.97 1970-09-28;45.93 1970-09-29;46.19 1970-09-30;46.14 1970-10-01;46.19 1970-10-02;46.66 1970-10-05;47.35 1970-10-06;47.49 1970-10-07;47.49 1970-10-08;46.96 1970-10-09;46.51 1970-10-12;46.05 1970-10-13;45.95 1970-10-14;46.02 1970-10-15;46.23 1970-10-16;45.98 1970-10-19;45.36 1970-10-20;45.62 1970-10-21;45.6 1970-10-22;45.42 1970-10-23;45.64 1970-10-26;45.4 1970-10-27;45.27 1970-10-28;45.41 1970-10-29;45.34 1970-10-30;45.28 1970-11-02;45.44 1970-11-03;45.84 1970-11-04;45.92 1970-11-05;45.81 1970-11-06;45.85 1970-11-09;46.09 1970-11-10;46.16 1970-11-11;46.31 1970-11-12;45.81 1970-11-13;45.38 1970-11-16;45.3 1970-11-17;45.33 1970-11-18;45 1970-11-19;45.04 1970-11-20;45.47 1970-11-23;45.73 1970-11-24;46 1970-11-25;46.18 1970-11-27;46.64 1970-11-30;47.41 1970-12-01;47.56 1970-12-02;48.14 1970-12-03;48.37 1970-12-04;48.65 1970-12-07;48.94 1970-12-08;48.7 1970-12-09;48.72 1970-12-10;48.9 1970-12-11;49.08 1970-12-14;48.8 1970-12-15;48.73 1970-12-16;48.79 1970-12-17;48.95 1970-12-18;49.06 1970-12-21;48.93 1970-12-22;48.99 1970-12-23;49.06 1970-12-24;49.37 1970-12-28;49.63 1970-12-29;50.19 1970-12-30;50.29 1970-12-31;50.23 1971-01-04;49.73 1971-01-05;50.13 1971-01-06;50.49 1971-01-07;50.52 1971-01-08;50.46 1971-01-11;50.4 1971-01-12;50.89 1971-01-13;50.85 1971-01-14;51.01 1971-01-15;51.16 1971-01-18;51.34 1971-01-19;51.49 1971-01-20;51.53 1971-01-21;51.77 1971-01-22;52.11 1971-01-25;52.35 1971-01-26;52.49 1971-01-27;52.12 1971-01-28;52.3 1971-01-29;52.64 1971-02-01;52.96 1971-02-02;53 1971-02-03;53.13 1971-02-04;53.16 1971-02-05;53.36 1971-02-08;53.66 1971-02-09;53.65 1971-02-10;53.59 1971-02-11;53.85 1971-02-12;54.16 1971-02-16;54.29 1971-02-17;54.04 1971-02-18;53.68 1971-02-19;53.2 1971-02-22;52.62 1971-02-23;52.86 1971-02-24;53.23 1971-02-25;53.31 1971-02-26;53.19 1971-03-01;53.34 1971-03-02;53.34 1971-03-03;53.35 1971-03-04;53.9 1971-03-05;54.47 1971-03-08;54.72 1971-03-09;54.81 1971-03-10;54.75 1971-03-11;54.74 1971-03-12;54.83 1971-03-15;55.44 1971-03-16;55.71 1971-03-17;55.71 1971-03-18;55.77 1971-03-19;55.69 1971-03-22;55.47 1971-03-23;55.29 1971-03-24;54.97 1971-03-25;54.98 1971-03-26;55.19 1971-03-29;55.25 1971-03-30;55.38 1971-03-31;55.44 1971-04-01;55.48 1971-04-02;55.58 1971-04-05;55.68 1971-04-06;56.01 1971-04-07;56.25 1971-04-08;56.33 1971-04-12;56.73 1971-04-13;56.77 1971-04-14;56.97 1971-04-15;57.05 1971-04-16;57.06 1971-04-19;57.29 1971-04-20;57.03 1971-04-21;56.88 1971-04-22;57.03 1971-04-23;57.32 1971-04-26;57.32 1971-04-27;57.56 1971-04-28;57.76 1971-04-29;57.64 1971-04-30;57.27 1971-05-03;56.91 1971-05-04;57.22 1971-05-05;57.2 1971-05-06;56.88 1971-05-07;56.67 1971-05-10;56.38 1971-05-11;56.55 1971-05-12;56.7 1971-05-13;56.6 1971-05-14;56.35 1971-05-17;55.48 1971-05-18;55.52 1971-05-19;55.65 1971-05-20;55.79 1971-05-21;55.59 1971-05-24;55.14 1971-05-25;54.77 1971-05-26;54.86 1971-05-27;54.78 1971-05-28;54.92 1971-06-01;55.26 1971-06-02;55.71 1971-06-03;55.82 1971-06-04;55.95 1971-06-07;55.86 1971-06-08;55.45 1971-06-09;55.43 1971-06-10;55.6 1971-06-11;55.8 1971-06-14;55.36 1971-06-15;55.38 1971-06-16;55.48 1971-06-17;55.46 1971-06-18;54.63 1971-06-21;53.99 1971-06-22;53.84 1971-06-23;54.32 1971-06-24;54.22 1971-06-25;54.1 1971-06-28;53.97 1971-06-29;54.58 1971-06-30;55.09 1971-07-01;55.16 1971-07-02;55.18 1971-07-06;55.2 1971-07-07;55.4 1971-07-08;55.59 1971-07-09;55.76 1971-07-12;55.83 1971-07-13;55.12 1971-07-14;55.03 1971-07-15;55.06 1971-07-16;54.97 1971-07-19;54.84 1971-07-20;55.06 1971-07-21;55.04 1971-07-22;54.92 1971-07-23;54.82 1971-07-26;54.65 1971-07-27;54.13 1971-07-28;53.71 1971-07-29;53.06 1971-07-30;52.81 1971-08-02;53.03 1971-08-03;52.17 1971-08-04;51.85 1971-08-05;51.96 1971-08-06;52.07 1971-08-09;51.66 1971-08-10;51.66 1971-08-11;52.29 1971-08-12;53.03 1971-08-13;52.88 1971-08-16;54.67 1971-08-17;55.27 1971-08-18;54.53 1971-08-19;54.28 1971-08-20;54.38 1971-08-23;54.88 1971-08-24;55.42 1971-08-25;55.46 1971-08-26;55.39 1971-08-27;55.52 1971-08-30;55.01 1971-08-31;54.74 1971-09-01;54.76 1971-09-02;54.9 1971-09-03;55.66 1971-09-07;55.94 1971-09-08;56.04 1971-09-09;55.76 1971-09-10;55.56 1971-09-13;55.38 1971-09-14;54.96 1971-09-15;55.16 1971-09-16;55.07 1971-09-17;55.24 1971-09-20;55.07 1971-09-21;54.9 1971-09-22;54.42 1971-09-23;54.37 1971-09-24;54.26 1971-09-27;53.96 1971-09-28;54.08 1971-09-29;54.08 1971-09-30;54.33 1971-10-01;54.66 1971-10-04;54.8 1971-10-05;54.74 1971-10-06;55.15 1971-10-07;55.27 1971-10-08;54.94 1971-10-11;54.82 1971-10-12;55.02 1971-10-13;54.76 1971-10-14;54.27 1971-10-15;54.06 1971-10-18;53.79 1971-10-19;53.57 1971-10-20;52.85 1971-10-21;52.85 1971-10-22;52.82 1971-10-25;52.6 1971-10-26;52.34 1971-10-27;51.8 1971-10-28;51.87 1971-10-29;52.07 1971-11-01;51.3 1971-11-02;51.46 1971-11-03;52.35 1971-11-04;52.34 1971-11-05;52.16 1971-11-08;52.12 1971-11-09;52.16 1971-11-10;51.58 1971-11-11;50.87 1971-11-12;50.85 1971-11-15;50.67 1971-11-16;51.13 1971-11-17;51.17 1971-11-18;50.78 1971-11-19;50.47 1971-11-22;49.97 1971-11-23;49.6 1971-11-24;49.67 1971-11-26;50.57 1971-11-29;51.47 1971-11-30;51.84 1971-12-01;52.73 1971-12-02;52.89 1971-12-03;53.51 1971-12-06;53.25 1971-12-07;53.49 1971-12-08;53.55 1971-12-09;53.55 1971-12-10;53.99 1971-12-13;54.19 1971-12-14;53.99 1971-12-15;54.43 1971-12-16;55.05 1971-12-17;55.32 1971-12-20;56.02 1971-12-21;56.16 1971-12-22;55.86 1971-12-23;55.62 1971-12-27;55.71 1971-12-28;56.24 1971-12-29;56.42 1971-12-30;56.22 1971-12-31;56.43 1972-01-03;56.23 1972-01-04;56.44 1972-01-05;56.97 1972-01-06;57.21 1972-01-07;57.21 1972-01-10;57.17 1972-01-11;57.39 1972-01-12;57.36 1972-01-13;57.02 1972-01-14;57.22 1972-01-17;57.39 1972-01-18;57.62 1972-01-19;57.53 1972-01-20;57.5 1972-01-21;57.39 1972-01-24;56.77 1972-01-25;56.86 1972-01-26;56.77 1972-01-27;57.38 1972-01-28;57.78 1972-01-31;57.71 1972-02-01;57.77 1972-02-02;58.12 1972-02-03;58.09 1972-02-04;58.26 1972-02-07;58.07 1972-02-08;58.15 1972-02-09;58.56 1972-02-10;58.59 1972-02-11;58.33 1972-02-14;58.09 1972-02-15;58.34 1972-02-16;58.64 1972-02-17;58.63 1972-02-18;58.48 1972-02-22;58.47 1972-02-23;58.54 1972-02-24;58.59 1972-02-25;58.95 1972-02-28;59.01 1972-02-29;59.24 1972-03-01;59.7 1972-03-02;59.73 1972-03-03;60.07 1972-03-06;60.53 1972-03-07;60.61 1972-03-08;60.71 1972-03-09;60.72 1972-03-10;60.39 1972-03-13;59.82 1972-03-14;59.99 1972-03-15;60.06 1972-03-16;59.91 1972-03-17;60.08 1972-03-20;59.88 1972-03-21;59.33 1972-03-22;59.42 1972-03-23;59.99 1972-03-24;59.86 1972-03-27;59.73 1972-03-28;59.68 1972-03-29;59.31 1972-03-30;59.68 1972-04-03;59.82 1972-04-04;60.17 1972-04-05;60.68 1972-04-06;60.93 1972-04-07;61.08 1972-04-10;60.98 1972-04-11;61.2 1972-04-12;61.42 1972-04-13;61.27 1972-04-14;61.28 1972-04-17;61.13 1972-04-18;61.24 1972-04-19;60.9 1972-04-20;60.8 1972-04-21;60.72 1972-04-24;60.34 1972-04-25;59.75 1972-04-26;59.62 1972-04-27;59.69 1972-04-28;60 1972-05-01;59.46 1972-05-02;59.12 1972-05-03;59 1972-05-04;59.1 1972-05-05;59.3 1972-05-08;59.01 1972-05-09;58.17 1972-05-10;58.58 1972-05-11;58.8 1972-05-12;59.19 1972-05-15;59.47 1972-05-16;59.35 1972-05-17;59.45 1972-05-18;59.98 1972-05-19;60.54 1972-05-22;60.88 1972-05-23;60.92 1972-05-24;61.18 1972-05-25;61.28 1972-05-26;61.38 1972-05-30;61.21 1972-05-31;60.76 1972-06-01;60.88 1972-06-02;60.95 1972-06-05;60.45 1972-06-06;60.12 1972-06-07;59.81 1972-06-08;59.63 1972-06-09;59.35 1972-06-12;59.4 1972-06-13;59.66 1972-06-14;60.11 1972-06-15;60.09 1972-06-16;60.04 1972-06-19;59.91 1972-06-20;60.13 1972-06-21;60.22 1972-06-22;60.14 1972-06-23;59.89 1972-06-26;59.46 1972-06-27;59.41 1972-06-28;59.2 1972-06-29;59.08 1972-06-30;59.31 1972-07-03;59.51 1972-07-05;59.85 1972-07-06;60.33 1972-07-07;60.15 1972-07-10;59.84 1972-07-11;59.4 1972-07-12;59.11 1972-07-13;58.76 1972-07-14;59.02 1972-07-17;58.5 1972-07-18;58.45 1972-07-19;58.6 1972-07-20;58.42 1972-07-21;58.84 1972-07-24;59.49 1972-07-25;59.34 1972-07-26;59.3 1972-07-27;59.11 1972-07-28;59.13 1972-07-31;59.09 1972-08-01;59.64 1972-08-02;60.13 1972-08-03;60.57 1972-08-04;60.75 1972-08-07;60.83 1972-08-08;60.87 1972-08-09;60.92 1972-08-10;61.08 1972-08-11;61.56 1972-08-14;61.83 1972-08-15;61.56 1972-08-16;61.4 1972-08-17;61.29 1972-08-18;61.54 1972-08-21;61.5 1972-08-22;61.85 1972-08-23;61.78 1972-08-24;61.13 1972-08-25;60.93 1972-08-28;60.65 1972-08-29;60.74 1972-08-30;60.84 1972-08-31;61.11 1972-09-01;61.34 1972-09-05;61.17 1972-09-06;60.81 1972-09-07;60.62 1972-09-08;60.53 1972-09-11;60.12 1972-09-12;59.57 1972-09-13;59.78 1972-09-14;59.8 1972-09-15;59.76 1972-09-18;59.63 1972-09-19;59.59 1972-09-20;59.57 1972-09-21;59.46 1972-09-22;59.51 1972-09-25;59.24 1972-09-26;59.31 1972-09-27;60.14 1972-09-28;60.52 1972-09-29;60.6 1972-10-02;60.42 1972-10-03;60.46 1972-10-04;60.32 1972-10-05;59.66 1972-10-06;60.03 1972-10-09;60.17 1972-10-10;60.24 1972-10-11;59.97 1972-10-12;59.48 1972-10-13;59.1 1972-10-16;58.49 1972-10-17;58.85 1972-10-18;59.21 1972-10-19;59.16 1972-10-20;59.77 1972-10-23;60.36 1972-10-24;60.57 1972-10-25;60.56 1972-10-26;60.77 1972-10-27;60.6 1972-10-30;60.57 1972-10-31;61.12 1972-11-01;61.74 1972-11-02;62.02 1972-11-03;62.52 1972-11-06;62.43 1972-11-08;62.12 1972-11-09;62.18 1972-11-10;62.33 1972-11-13;62.4 1972-11-14;62.94 1972-11-15;62.74 1972-11-16;63.06 1972-11-17;63.25 1972-11-20;63.27 1972-11-21;63.57 1972-11-22;63.94 1972-11-24;64.12 1972-11-27;63.83 1972-11-28;63.7 1972-11-29;63.73 1972-11-30;63.88 1972-12-01;64.29 1972-12-04;64.48 1972-12-05;64.36 1972-12-06;64.6 1972-12-07;64.88 1972-12-08;65.01 1972-12-11;65.14 1972-12-12;64.89 1972-12-13;64.79 1972-12-14;64.58 1972-12-15;64.63 1972-12-18;63.92 1972-12-19;63.63 1972-12-20;63.41 1972-12-21;63.01 1972-12-22;63.38 1972-12-26;63.57 1972-12-27;63.85 1972-12-29;64.48 1973-01-02;65.06 1973-01-03;65.29 1973-01-04;65.17 1973-01-05;65.37 1973-01-08;65.35 1973-01-09;65.29 1973-01-10;65.1 1973-01-11;65.48 1973-01-12;64.95 1973-01-15;64.42 1973-01-16;64.21 1973-01-17;64.49 1973-01-18;64.6 1973-01-19;64.51 1973-01-22;64.18 1973-01-23;64.11 1973-01-24;63.25 1973-01-26;63.05 1973-01-29;62.77 1973-01-30;62.67 1973-01-31;62.75 1973-02-01;62.04 1973-02-02;61.79 1973-02-05;61.68 1973-02-06;61.8 1973-02-07;61.37 1973-02-08;61.1 1973-02-09;61.9 1973-02-12;62.58 1973-02-13;62.92 1973-02-14;62.05 1973-02-15;61.66 1973-02-16;61.93 1973-02-20;62.1 1973-02-21;61.69 1973-02-22;61.51 1973-02-23;60.82 1973-02-26;60.29 1973-02-27;59.61 1973-02-28;60 1973-03-01;59.61 1973-03-02;60.17 1973-03-05;60.37 1973-03-06;61.15 1973-03-07;61.39 1973-03-08;61.26 1973-03-09;61.02 1973-03-12;61.02 1973-03-13;61.31 1973-03-14;61.52 1973-03-15;61.06 1973-03-16;60.75 1973-03-19;59.99 1973-03-20;59.83 1973-03-21;59.07 1973-03-22;58.12 1973-03-23;58.15 1973-03-26;58.65 1973-03-27;59.53 1973-03-28;59.55 1973-03-29;60.15 1973-03-30;59.58 1973-04-02;58.89 1973-04-03;58.33 1973-04-04;58.04 1973-04-05;57.82 1973-04-06;58.23 1973-04-09;59.02 1973-04-10;59.73 1973-04-11;59.97 1973-04-12;59.9 1973-04-13;59.65 1973-04-16;59.32 1973-04-17;59 1973-04-18;59.25 1973-04-19;59.59 1973-04-23;59.29 1973-04-24;58.42 1973-04-25;57.53 1973-04-26;57.74 1973-04-27;56.86 1973-04-30;56.73 1973-05-01;56.76 1973-05-02;57.46 1973-05-03;58.35 1973-05-04;58.77 1973-05-07;58.51 1973-05-08;58.9 1973-05-09;58.56 1973-05-10;58.15 1973-05-11;57.43 1973-05-14;56.2 1973-05-15;56.51 1973-05-16;56.44 1973-05-17;55.96 1973-05-18;54.96 1973-05-21;54.22 1973-05-22;54.66 1973-05-23;54.89 1973-05-24;56.45 1973-05-25;56.96 1973-05-29;56.8 1973-05-30;55.95 1973-05-31;55.42 1973-06-01;54.86 1973-06-04;54.28 1973-06-05;55.08 1973-06-06;54.91 1973-06-07;55.68 1973-06-08;56.29 1973-06-11;56.13 1973-06-12;56.95 1973-06-13;56.67 1973-06-14;56.05 1973-06-15;55.36 1973-06-18;54.56 1973-06-19;54.72 1973-06-20;54.96 1973-06-21;54.32 1973-06-22;54.56 1973-06-25;53.79 1973-06-26;54.31 1973-06-27;54.48 1973-06-28;55.04 1973-06-29;54.84 1973-07-02;54.17 1973-07-03;53.68 1973-07-05;53.59 1973-07-06;53.36 1973-07-09;53.82 1973-07-10;54.6 1973-07-11;55.86 1973-07-12;55.8 1973-07-13;55.12 1973-07-16;55.99 1973-07-17;56.13 1973-07-18;56.56 1973-07-19;56.75 1973-07-20;57.09 1973-07-23;57.29 1973-07-24;57.62 1973-07-25;58.45 1973-07-26;58.54 1973-07-27;58.36 1973-07-30;58.18 1973-07-31;57.65 1973-08-01;56.9 1973-08-02;56.84 1973-08-03;56.79 1973-08-06;56.93 1973-08-07;56.83 1973-08-08;56.29 1973-08-09;56.3 1973-08-10;55.84 1973-08-13;55.23 1973-08-14;54.71 1973-08-15;54.89 1973-08-16;54.57 1973-08-17;54.58 1973-08-20;54.19 1973-08-21;53.77 1973-08-22;53.55 1973-08-23;54.27 1973-08-24;54.18 1973-08-27;54.56 1973-08-28;54.87 1973-08-29;55.39 1973-08-30;55.39 1973-08-31;55.64 1973-09-04;55.84 1973-09-05;55.96 1973-09-06;56.26 1973-09-07;56.12 1973-09-10;55.61 1973-09-11;55.3 1973-09-12;55.19 1973-09-13;55.37 1973-09-14;55.92 1973-09-17;55.9 1973-09-18;55.78 1973-09-19;56.9 1973-09-20;57.44 1973-09-21;57.73 1973-09-24;57.91 1973-09-25;58.25 1973-09-26;58.67 1973-09-27;58.8 1973-09-28;58.51 1973-10-01;58.42 1973-10-02;58.75 1973-10-03;58.79 1973-10-04;58.6 1973-10-05;59.34 1973-10-08;59.6 1973-10-09;59.54 1973-10-10;59 1973-10-11;60.02 1973-10-12;60.25 1973-10-15;59.53 1973-10-16;59.53 1973-10-17;59.4 1973-10-18;59.39 1973-10-19;59.49 1973-10-22;58.88 1973-10-23;59.15 1973-10-24;59.34 1973-10-25;59.44 1973-10-26;59.9 1973-10-29;59.77 1973-10-30;58.85 1973-10-31;58.28 1973-11-01;57.94 1973-11-02;57.61 1973-11-05;56.71 1973-11-06;56.35 1973-11-07;56.74 1973-11-08;57.4 1973-11-09;56.51 1973-11-12;55.96 1973-11-13;55.81 1973-11-14;54.82 1973-11-15;54.78 1973-11-16;55.48 1973-11-19;53.76 1973-11-20;52.6 1973-11-21;53.2 1973-11-23;53.09 1973-11-26;51.51 1973-11-27;51.02 1973-11-28;52.05 1973-11-29;51.88 1973-11-30;51.18 1973-12-03;50.08 1973-12-04;49.88 1973-12-05;49.05 1973-12-06;50.16 1973-12-07;51.35 1973-12-10;52.15 1973-12-11;51.2 1973-12-12;49.83 1973-12-13;49.12 1973-12-14;49.62 1973-12-17;49.31 1973-12-18;50.29 1973-12-19;50.32 1973-12-20;50.19 1973-12-21;49.68 1973-12-24;49.37 1973-12-26;50.8 1973-12-27;51.85 1973-12-28;51.75 1973-12-31;51.82 1974-01-02;51.98 1974-01-03;53.21 1974-01-04;52.88 1974-01-07;52.51 1974-01-08;51.52 1974-01-09;50.05 1974-01-10;49.5 1974-01-11;50.12 1974-01-14;50.05 1974-01-15;50.43 1974-01-16;51.18 1974-01-17;52.03 1974-01-18;51.16 1974-01-21;51.03 1974-01-22;51.56 1974-01-23;51.83 1974-01-24;51.72 1974-01-25;51.66 1974-01-28;51.39 1974-01-29;51.33 1974-01-30;51.88 1974-01-31;51.64 1974-02-01;51 1974-02-04;49.92 1974-02-05;49.75 1974-02-06;49.89 1974-02-07;49.95 1974-02-08;49.43 1974-02-11;48.57 1974-02-12;48.65 1974-02-13;48.66 1974-02-14;48.67 1974-02-15;49.33 1974-02-19;49.28 1974-02-20;49.94 1974-02-21;50.58 1974-02-22;51 1974-02-25;50.87 1974-02-26;51.42 1974-02-27;51.64 1974-02-28;51.56 1974-03-01;51.23 1974-03-04;51.24 1974-03-05;52.17 1974-03-06;52.48 1974-03-07;51.97 1974-03-08;52.38 1974-03-11;52.93 1974-03-12;53.06 1974-03-13;53.37 1974-03-14;53.36 1974-03-15;53.18 1974-03-18;52.5 1974-03-19;52.05 1974-03-20;52.22 1974-03-21;52.1 1974-03-22;52.03 1974-03-25;52.16 1974-03-26;52.3 1974-03-27;51.59 1974-03-28;50.63 1974-03-29;50.21 1974-04-01;49.8 1974-04-02;49.81 1974-04-03;50.27 1974-04-04;50.25 1974-04-05;49.55 1974-04-08;49.03 1974-04-09;49.31 1974-04-10;49.23 1974-04-11;49.09 1974-04-15;49.04 1974-04-16;49.88 1974-04-17;50.24 1974-04-18;50.44 1974-04-19;49.91 1974-04-22;49.69 1974-04-23;48.81 1974-04-24;47.96 1974-04-25;47.53 1974-04-26;47.84 1974-04-29;47.78 1974-04-30;47.93 1974-05-01;48.92 1974-05-02;48.87 1974-05-03;48.46 1974-05-06;48.33 1974-05-07;48.47 1974-05-08;48.53 1974-05-09;49.09 1974-05-10;48.29 1974-05-13;47.85 1974-05-14;47.86 1974-05-15;47.73 1974-05-16;47.38 1974-05-17;46.56 1974-05-20;46.36 1974-05-21;46.37 1974-05-22;45.91 1974-05-23;45.94 1974-05-24;46.59 1974-05-28;46.49 1974-05-29;45.74 1974-05-30;46 1974-05-31;45.92 1974-06-03;46.81 1974-06-04;47.41 1974-06-05;47.53 1974-06-06;48.38 1974-06-07;48.71 1974-06-10;48.99 1974-06-11;48.56 1974-06-12;48.38 1974-06-13;48.5 1974-06-14;47.98 1974-06-17;47.33 1974-06-18;47 1974-06-19;46.66 1974-06-20;46.3 1974-06-21;45.87 1974-06-24;45.92 1974-06-25;46.55 1974-06-26;45.82 1974-06-27;45.13 1974-06-28;44.9 1974-07-01;44.86 1974-07-02;43.92 1974-07-03;43.87 1974-07-05;43.6 1974-07-08;42.25 1974-07-09;42.4 1974-07-10;41.65 1974-07-11;41.62 1974-07-12;43.36 1974-07-15;43.73 1974-07-16;43.26 1974-07-17;43.72 1974-07-18;43.82 1974-07-19;43.74 1974-07-22;43.89 1974-07-23;44.34 1974-07-24;44.52 1974-07-25;44.01 1974-07-26;43.2 1974-07-29;42.41 1974-07-30;42.16 1974-07-31;41.55 1974-08-01;41.26 1974-08-02;41.17 1974-08-05;41.53 1974-08-06;42.17 1974-08-07;43.26 1974-08-08;42.73 1974-08-09;42.39 1974-08-12;41.85 1974-08-13;41.19 1974-08-14;40.28 1974-08-15;40.06 1974-08-16;39.76 1974-08-19;39.16 1974-08-20;39.32 1974-08-21;38.59 1974-08-22;38.2 1974-08-23;37.55 1974-08-26;37.82 1974-08-27;37.18 1974-08-28;37.06 1974-08-29;36.62 1974-08-30;37.7 1974-09-03;36.9 1974-09-04;35.93 1974-09-05;37.04 1974-09-06;37.33 1974-09-09;36.46 1974-09-10;36.17 1974-09-11;35.82 1974-09-12;34.88 1974-09-13;34.11 1974-09-16;34.63 1974-09-17;35.25 1974-09-18;35.39 1974-09-19;36.63 1974-09-20;36.74 1974-09-23;36.45 1974-09-24;35.76 1974-09-25;35.61 1974-09-26;35.02 1974-09-27;34.25 1974-09-30;33.45 1974-10-01;33.39 1974-10-02;33.44 1974-10-03;32.89 1974-10-04;32.9 1974-10-07;34.19 1974-10-08;34.16 1974-10-09;35.69 1974-10-10;36.77 1974-10-11;37.49 1974-10-14;38.36 1974-10-15;37.67 1974-10-16;37.12 1974-10-17;37.52 1974-10-18;38.08 1974-10-21;38.72 1974-10-22;38.57 1974-10-23;37.54 1974-10-24;37.1 1974-10-25;37.07 1974-10-28;37.04 1974-10-29;38.37 1974-10-30;39.12 1974-10-31;38.97 1974-11-01;38.94 1974-11-04;38.53 1974-11-05;39.54 1974-11-06;39.46 1974-11-07;39.74 1974-11-08;39.63 1974-11-11;39.77 1974-11-12;39 1974-11-13;38.82 1974-11-14;38.7 1974-11-15;38.14 1974-11-18;36.76 1974-11-19;36.19 1974-11-20;36.03 1974-11-21;36.2 1974-11-22;36.59 1974-11-25;36.53 1974-11-26;36.86 1974-11-27;37.11 1974-11-29;37.13 1974-12-02;36.16 1974-12-03;35.65 1974-12-04;35.74 1974-12-05;35.08 1974-12-06;34.45 1974-12-09;34.7 1974-12-10;35.53 1974-12-11;35.75 1974-12-12;35.6 1974-12-13;35.39 1974-12-16;35.07 1974-12-17;35.58 1974-12-18;35.74 1974-12-19;35.62 1974-12-20;35.23 1974-12-23;34.72 1974-12-24;35.2 1974-12-26;35.51 1974-12-27;35.36 1974-12-30;35.35 1974-12-31;36.13 1975-01-02;37.06 1975-01-03;37.35 1975-01-06;37.62 1975-01-07;37.61 1975-01-08;37.16 1975-01-09;37.77 1975-01-10;38.57 1975-01-13;38.44 1975-01-14;38.12 1975-01-15;38.37 1975-01-16;38.37 1975-01-17;37.86 1975-01-20;37.87 1975-01-21;37.71 1975-01-22;38.17 1975-01-23;38.37 1975-01-24;38.84 1975-01-27;40.12 1975-01-28;40.43 1975-01-29;41.03 1975-01-30;40.52 1975-01-31;40.91 1975-02-03;41.38 1975-02-04;41.26 1975-02-05;41.95 1975-02-06;41.82 1975-02-07;41.8 1975-02-10;41.68 1975-02-11;41.77 1975-02-12;42.45 1975-02-13;43 1975-02-14;43.21 1975-02-18;42.92 1975-02-19;43.13 1975-02-20;43.53 1975-02-21;43.7 1975-02-24;43.11 1975-02-25;42.09 1975-02-26;42.48 1975-02-27;42.7 1975-02-28;43.07 1975-03-03;43.83 1975-03-04;44.13 1975-03-05;43.78 1975-03-06;44.2 1975-03-07;44.55 1975-03-10;44.88 1975-03-11;44.6 1975-03-12;44.22 1975-03-13;44.31 1975-03-14;44.87 1975-03-17;45.54 1975-03-18;45.1 1975-03-19;44.69 1975-03-20;44.36 1975-03-21;44.26 1975-03-24;43.22 1975-03-25;43.52 1975-03-26;44.31 1975-03-27;44.46 1975-03-31;44.21 1975-04-01;43.84 1975-04-02;43.72 1975-04-03;43.27 1975-04-04;42.98 1975-04-07;42.69 1975-04-08;42.98 1975-04-09;43.88 1975-04-10;44.36 1975-04-11;44.61 1975-04-14;45.33 1975-04-15;45.66 1975-04-16;45.84 1975-04-17;46.2 1975-04-18;45.76 1975-04-21;46.24 1975-04-22;46.14 1975-04-23;45.64 1975-04-24;45.63 1975-04-25;45.95 1975-04-28;45.77 1975-04-29;45.41 1975-04-30;46.19 1975-05-01;46.59 1975-05-02;47.18 1975-05-05;47.6 1975-05-06;46.91 1975-05-07;47.13 1975-05-08;47.44 1975-05-09;47.98 1975-05-12;48.01 1975-05-13;48.45 1975-05-14;48.83 1975-05-15;48.44 1975-05-16;47.96 1975-05-19;48.01 1975-05-20;47.8 1975-05-21;47.27 1975-05-22;47.45 1975-05-23;48.05 1975-05-27;47.97 1975-05-28;47.66 1975-05-29;47.67 1975-05-30;48.46 1975-06-02;49.18 1975-06-03;49.35 1975-06-04;49.24 1975-06-05;49.28 1975-06-06;49.19 1975-06-09;48.54 1975-06-10;48.12 1975-06-11;48.18 1975-06-12;47.95 1975-06-13;48.19 1975-06-16;48.69 1975-06-17;48.27 1975-06-18;48.17 1975-06-19;49.05 1975-06-20;49.39 1975-06-23;49.94 1975-06-24;50.28 1975-06-25;50.51 1975-06-26;50.62 1975-06-27;50.62 1975-06-30;50.85 1975-07-01;50.68 1975-07-02;50.29 1975-07-03;50.45 1975-07-07;50.03 1975-07-08;49.96 1975-07-09;50.73 1975-07-10;50.74 1975-07-11;50.71 1975-07-14;50.99 1975-07-15;51.24 1975-07-16;50.72 1975-07-17;50.24 1975-07-18;50.07 1975-07-21;49.68 1975-07-22;49.12 1975-07-23;48.4 1975-07-24;48.27 1975-07-25;47.87 1975-07-28;47.51 1975-07-29;47.2 1975-07-30;47.53 1975-07-31;47.52 1975-08-01;47.1 1975-08-04;46.62 1975-08-05;46.09 1975-08-06;46.08 1975-08-07;46.1 1975-08-08;45.92 1975-08-11;46.15 1975-08-12;46.48 1975-08-13;45.88 1975-08-14;45.64 1975-08-15;46.02 1975-08-18;45.94 1975-08-19;45.23 1975-08-20;44.3 1975-08-21;44.22 1975-08-22;44.85 1975-08-25;45.27 1975-08-26;44.71 1975-08-27;44.94 1975-08-28;45.99 1975-08-29;46.29 1975-09-02;45.55 1975-09-03;45.79 1975-09-04;45.86 1975-09-05;45.56 1975-09-08;45.65 1975-09-09;45 1975-09-10;44.52 1975-09-11;44.36 1975-09-12;44.26 1975-09-15;44.01 1975-09-16;43.59 1975-09-17;43.69 1975-09-18;44.53 1975-09-19;45.53 1975-09-22;45.14 1975-09-23;45.06 1975-09-24;45.51 1975-09-25;45.44 1975-09-26;45.7 1975-09-29;45.12 1975-09-30;44.49 1975-10-01;43.96 1975-10-02;44.39 1975-10-03;45.49 1975-10-06;45.98 1975-10-07;45.92 1975-10-08;46.5 1975-10-09;46.72 1975-10-10;46.67 1975-10-13;47.33 1975-10-14;47.28 1975-10-15;47.24 1975-10-16;47.33 1975-10-17;47.06 1975-10-20;47.52 1975-10-21;47.91 1975-10-22;47.98 1975-10-23;48.25 1975-10-24;47.57 1975-10-27;47.52 1975-10-28;47.89 1975-10-29;47.26 1975-10-30;47.18 1975-10-31;47.05 1975-11-03;46.56 1975-11-04;46.78 1975-11-05;47.13 1975-11-06;47.34 1975-11-07;47.24 1975-11-10;47.23 1975-11-11;47.52 1975-11-12;48.22 1975-11-13;48.2 1975-11-14;48.16 1975-11-17;48.4 1975-11-18;48.15 1975-11-19;47.62 1975-11-20;47.43 1975-11-21;47.38 1975-11-24;47.47 1975-11-25;47.95 1975-11-26;48.09 1975-11-28;48.24 1975-12-01;47.96 1975-12-02;47.22 1975-12-03;46.25 1975-12-04;46.35 1975-12-05;45.84 1975-12-08;45.91 1975-12-09;45.98 1975-12-10;46.4 1975-12-11;46.29 1975-12-12;46.26 1975-12-15;46.38 1975-12-16;46.84 1975-12-17;46.97 1975-12-18;47.13 1975-12-19;46.82 1975-12-22;46.48 1975-12-23;46.77 1975-12-24;47.18 1975-12-26;47.6 1975-12-29;47.54 1975-12-30;47.37 1975-12-31;47.64 1976-01-02;48.04 1976-01-05;48.94 1976-01-06;49.51 1976-01-07;49.75 1976-01-08;50.08 1976-01-09;50.29 1976-01-12;50.99 1976-01-13;50.61 1976-01-14;51.44 1976-01-15;51.19 1976-01-16;51.41 1976-01-19;52.07 1976-01-20;52.33 1976-01-21;52.05 1976-01-22;51.97 1976-01-23;52.59 1976-01-26;52.84 1976-01-27;52.55 1976-01-28;52.28 1976-01-29;53.12 1976-01-30;53.55 1976-02-02;53.59 1976-02-03;53.8 1976-02-04;54.24 1976-02-05;53.44 1976-02-06;52.97 1976-02-09;53.1 1976-02-10;53.56 1976-02-11;53.76 1976-02-12;53.55 1976-02-13;53.27 1976-02-17;52.95 1976-02-18;53.39 1976-02-19;54.26 1976-02-20;54.61 1976-02-23;54.39 1976-02-24;54.62 1976-02-25;54.46 1976-02-26;53.62 1976-02-27;53.35 1976-03-01;53.5 1976-03-02;53.82 1976-03-03;53.51 1976-03-04;52.95 1976-03-05;53.05 1976-03-08;53.61 1976-03-09;53.76 1976-03-10;53.97 1976-03-11;54.43 1976-03-12;53.91 1976-03-15;53.33 1976-03-16;53.9 1976-03-17;53.91 1976-03-18;53.7 1976-03-19;53.76 1976-03-22;53.81 1976-03-23;54.55 1976-03-24;55.15 1976-03-25;54.84 1976-03-26;54.87 1976-03-29;54.64 1976-03-30;54.43 1976-03-31;54.8 1976-04-01;54.54 1976-04-02;54.54 1976-04-05;55.2 1976-04-06;55.13 1976-04-07;54.5 1976-04-08;53.97 1976-04-09;53.41 1976-04-12;53.33 1976-04-13;53.73 1976-04-14;53.35 1976-04-15;53.55 1976-04-19;53.96 1976-04-20;54.76 1976-04-21;55 1976-04-22;54.84 1976-04-23;54.47 1976-04-26;54.54 1976-04-27;54.25 1976-04-28;54.35 1976-04-29;54.34 1976-04-30;54.11 1976-05-03;53.68 1976-05-04;53.97 1976-05-05;53.7 1976-05-06;53.86 1976-05-07;54.26 1976-05-10;54.9 1976-05-11;54.84 1976-05-12;54.74 1976-05-13;54.43 1976-05-14;54.01 1976-05-17;53.84 1976-05-18;53.92 1976-05-19;53.91 1976-05-20;54.31 1976-05-21;53.97 1976-05-24;53.01 1976-05-25;52.98 1976-05-26;52.91 1976-05-27;52.89 1976-05-28;53.31 1976-06-01;53.16 1976-06-02;53.33 1976-06-03;53.28 1976-06-04;52.78 1976-06-07;52.52 1976-06-08;52.62 1976-06-09;52.62 1976-06-10;53.05 1976-06-11;53.73 1976-06-14;54.27 1976-06-15;54.04 1976-06-16;54.36 1976-06-17;55.17 1976-06-18;55.28 1976-06-21;55.53 1976-06-22;55.14 1976-06-23;55.03 1976-06-24;55.35 1976-06-25;55.35 1976-06-28;55.23 1976-06-29;55.46 1976-06-30;55.71 1976-07-01;55.31 1976-07-02;55.57 1976-07-06;55.32 1976-07-07;55.48 1976-07-08;55.56 1976-07-09;56.06 1976-07-12;56.54 1976-07-13;56.43 1976-07-14;56.61 1976-07-15;56.23 1976-07-16;55.94 1976-07-19;55.75 1976-07-20;55.42 1976-07-21;55.5 1976-07-22;55.55 1976-07-23;55.63 1976-07-26;55.62 1976-07-27;55.31 1976-07-28;55.07 1976-07-29;55.02 1976-07-30;55.26 1976-08-02;55.13 1976-08-03;55.61 1976-08-04;55.78 1976-08-05;55.5 1976-08-06;55.46 1976-08-09;55.3 1976-08-10;55.76 1976-08-11;55.59 1976-08-12;55.65 1976-08-13;55.69 1976-08-16;55.79 1976-08-17;55.98 1976-08-18;55.85 1976-08-19;55.22 1976-08-20;54.71 1976-08-23;54.48 1976-08-24;54.15 1976-08-25;54.52 1976-08-26;54.16 1976-08-27;54.23 1976-08-30;54.51 1976-08-31;54.92 1976-09-01;55.5 1976-09-02;55.45 1976-09-03;55.65 1976-09-07;56.03 1976-09-08;56.01 1976-09-09;55.72 1976-09-10;55.86 1976-09-13;55.7 1976-09-14;55.54 1976-09-15;55.67 1976-09-16;56.21 1976-09-17;56.69 1976-09-20;56.74 1976-09-21;57.51 1976-09-22;57.35 1976-09-23;57.08 1976-09-24;57.02 1976-09-27;57.26 1976-09-28;56.59 1976-09-29;56.3 1976-09-30;56.23 1976-10-01;55.7 1976-10-04;55.62 1976-10-05;55.2 1976-10-06;55.04 1976-10-07;55.33 1976-10-08;54.85 1976-10-11;54.32 1976-10-12;53.87 1976-10-13;54.52 1976-10-14;53.88 1976-10-15;53.9 1976-10-18;54.21 1976-10-19;54.18 1976-10-20;54.33 1976-10-21;53.85 1976-10-22;53.42 1976-10-25;53.46 1976-10-26;53.97 1976-10-27;54.32 1976-10-28;54.24 1976-10-29;54.89 1976-11-01;55 1976-11-03;54.38 1976-11-04;54.7 1976-11-05;53.94 1976-11-08;53.29 1976-11-09;53.14 1976-11-10;52.9 1976-11-11;53.29 1976-11-12;53.1 1976-11-15;53.42 1976-11-16;53.52 1976-11-17;53.85 1976-11-18;54.55 1976-11-19;54.61 1976-11-22;54.97 1976-11-23;54.69 1976-11-24;54.96 1976-11-26;55.33 1976-11-29;54.99 1976-11-30;54.8 1976-12-01;55.03 1976-12-02;54.87 1976-12-03;55.2 1976-12-06;55.64 1976-12-07;55.63 1976-12-08;55.93 1976-12-09;56.21 1976-12-10;56.33 1976-12-13;56.35 1976-12-14;56.59 1976-12-15;56.63 1976-12-16;56.45 1976-12-17;56.24 1976-12-20;55.9 1976-12-21;56.17 1976-12-22;56.44 1976-12-23;56.49 1976-12-27;57.11 1976-12-28;57.47 1976-12-29;57.28 1976-12-30;57.56 1976-12-31;57.88 1977-01-03;57.69 1977-01-04;57.07 1977-01-05;56.59 1977-01-06;56.75 1977-01-07;56.79 1977-01-10;56.88 1977-01-11;56.34 1977-01-12;55.95 1977-01-13;56.39 1977-01-14;56.36 1977-01-17;56.23 1977-01-18;56.04 1977-01-19;56.36 1977-01-20;55.93 1977-01-21;56.15 1977-01-24;56.14 1977-01-25;56.14 1977-01-26;55.75 1977-01-27;55.44 1977-01-28;55.49 1977-01-31;55.48 1977-02-01;55.75 1977-02-02;55.68 1977-02-03;55.42 1977-02-04;55.46 1977-02-07;55.48 1977-02-08;55.33 1977-02-09;54.86 1977-02-10;54.89 1977-02-11;54.57 1977-02-14;54.8 1977-02-15;54.95 1977-02-16;55.19 1977-02-17;54.88 1977-02-18;54.68 1977-02-22;54.65 1977-02-23;54.5 1977-02-24;54.17 1977-02-25;54.09 1977-02-28;54.23 1977-03-01;54.68 1977-03-02;54.56 1977-03-03;54.79 1977-03-04;54.98 1977-03-07;55.02 1977-03-08;54.83 1977-03-09;54.42 1977-03-10;54.7 1977-03-11;54.72 1977-03-14;55.1 1977-03-15;55.37 1977-03-16;55.5 1977-03-17;55.45 1977-03-18;55.36 1977-03-21;55.09 1977-03-22;54.93 1977-03-23;54.52 1977-03-24;54.25 1977-03-25;53.92 1977-03-28;53.85 1977-03-29;54.19 1977-03-30;53.61 1977-03-31;53.53 1977-04-01;53.94 1977-04-04;53.45 1977-04-05;53.3 1977-04-06;53.26 1977-04-07;53.46 1977-04-11;53.73 1977-04-12;54.41 1977-04-13;54.45 1977-04-14;54.92 1977-04-15;54.94 1977-04-18;54.7 1977-04-19;54.5 1977-04-20;54.7 1977-04-21;54.34 1977-04-22;53.69 1977-04-25;53 1977-04-26;52.96 1977-04-27;53.42 1977-04-28;53.54 1977-04-29;53.66 1977-05-02;53.93 1977-05-03;54.21 1977-05-04;54.49 1977-05-05;54.6 1977-05-06;54.31 1977-05-09;54.15 1977-05-10;54.3 1977-05-11;53.98 1977-05-12;53.96 1977-05-13;54.13 1977-05-16;54.35 1977-05-17;54.49 1977-05-18;54.77 1977-05-19;54.59 1977-05-20;54.4 1977-05-23;53.73 1977-05-24;53.44 1977-05-25;52.95 1977-05-26;53.05 1977-05-27;52.68 1977-05-31;52.56 1977-06-01;52.97 1977-06-02;52.88 1977-06-03;53.36 1977-06-06;53.12 1977-06-07;53.37 1977-06-08;53.65 1977-06-09;53.62 1977-06-10;53.8 1977-06-13;53.94 1977-06-14;54.52 1977-06-15;54.42 1977-06-16;54.56 1977-06-17;54.64 1977-06-20;54.9 1977-06-21;55.09 1977-06-22;54.99 1977-06-23;55.11 1977-06-24;55.42 1977-06-27;55.34 1977-06-28;54.94 1977-06-29;54.9 1977-06-30;55.1 1977-07-01;54.92 1977-07-05;54.92 1977-07-06;54.67 1977-07-07;54.84 1977-07-08;54.81 1977-07-11;54.65 1977-07-12;54.6 1977-07-13;54.7 1977-07-15;54.99 1977-07-18;55.37 1977-07-19;55.76 1977-07-20;55.73 1977-07-21;55.64 1977-07-22;55.71 1977-07-25;55.29 1977-07-26;54.97 1977-07-27;54.08 1977-07-28;54.13 1977-07-29;54.12 1977-08-01;54.27 1977-08-02;53.93 1977-08-03;53.82 1977-08-04;54.02 1977-08-05;54.04 1977-08-08;53.66 1977-08-09;53.67 1977-08-10;54.09 1977-08-11;53.77 1977-08-12;53.61 1977-08-15;53.73 1977-08-16;53.53 1977-08-17;53.51 1977-08-18;53.48 1977-08-19;53.38 1977-08-22;53.49 1977-08-23;53.42 1977-08-24;53.22 1977-08-25;52.67 1977-08-26;52.6 1977-08-29;53.04 1977-08-30;52.77 1977-08-31;52.93 1977-09-01;52.99 1977-09-02;53.33 1977-09-06;53.44 1977-09-07;53.59 1977-09-08;53.22 1977-09-09;52.74 1977-09-12;52.54 1977-09-13;52.56 1977-09-14;52.79 1977-09-15;52.94 1977-09-16;52.79 1977-09-19;52.48 1977-09-20;52.49 1977-09-21;52.08 1977-09-22;52.08 1977-09-23;52.07 1977-09-26;52.2 1977-09-27;52.12 1977-09-28;52.14 1977-09-29;52.44 1977-09-30;52.81 1977-10-03;52.94 1977-10-04;52.6 1977-10-05;52.43 1977-10-06;52.61 1977-10-07;52.59 1977-10-10;52.5 1977-10-11;52.09 1977-10-12;51.57 1977-10-13;51.22 1977-10-14;51.24 1977-10-17;51.19 1977-10-18;51.19 1977-10-19;50.65 1977-10-20;50.78 1977-10-21;50.61 1977-10-24;50.24 1977-10-25;49.86 1977-10-26;50.41 1977-10-27;50.59 1977-10-28;50.77 1977-10-31;50.65 1977-11-01;50.13 1977-11-02;49.78 1977-11-03;49.8 1977-11-04;50.27 1977-11-07;50.67 1977-11-08;50.78 1977-11-09;51.04 1977-11-10;52.01 1977-11-11;52.7 1977-11-14;52.37 1977-11-15;52.72 1977-11-16;52.53 1977-11-17;52.4 1977-11-18;52.51 1977-11-21;52.49 1977-11-22;52.94 1977-11-23;53.19 1977-11-25;53.33 1977-11-28;53.02 1977-11-29;52.24 1977-11-30;52.36 1977-12-01;52.34 1977-12-02;52.34 1977-12-05;52.12 1977-12-06;51.33 1977-12-07;51.28 1977-12-08;51.37 1977-12-09;51.72 1977-12-12;51.73 1977-12-13;51.69 1977-12-14;51.9 1977-12-15;51.68 1977-12-16;51.61 1977-12-19;51.24 1977-12-20;51.11 1977-12-21;51.41 1977-12-22;51.81 1977-12-23;52.26 1977-12-27;52.25 1977-12-28;52.31 1977-12-29;52.43 1977-12-30;52.5 1978-01-03;51.82 1978-01-04;51.63 1978-01-05;51.25 1978-01-06;50.64 1978-01-09;50.05 1978-01-10;49.77 1978-01-11;49.52 1978-01-12;49.6 1978-01-13;49.57 1978-01-16;49.4 1978-01-17;49.67 1978-01-18;50.04 1978-01-19;49.82 1978-01-20;49.73 1978-01-23;49.38 1978-01-24;49.4 1978-01-25;49.47 1978-01-26;49.07 1978-01-27;49.06 1978-01-30;49.45 1978-01-31;49.41 1978-02-01;49.79 1978-02-02;49.92 1978-02-03;49.72 1978-02-06;49.64 1978-02-07;50.08 1978-02-08;50.35 1978-02-09;50.11 1978-02-10;50.01 1978-02-13;49.9 1978-02-14;49.47 1978-02-15;49.34 1978-02-16;48.94 1978-02-17;48.9 1978-02-21;48.69 1978-02-22;48.69 1978-02-23;48.73 1978-02-24;49.19 1978-02-27;48.81 1978-02-28;48.43 1978-03-01;48.49 1978-03-02;48.6 1978-03-03;48.67 1978-03-06;48.37 1978-03-07;48.62 1978-03-08;48.87 1978-03-09;48.94 1978-03-10;49.48 1978-03-13;49.54 1978-03-14;49.75 1978-03-15;49.65 1978-03-16;49.88 1978-03-17;50.25 1978-03-20;50.57 1978-03-21;50.05 1978-03-22;49.89 1978-03-23;49.86 1978-03-27;49.63 1978-03-28;49.96 1978-03-29;50.07 1978-03-30;49.95 1978-03-31;49.85 1978-04-03;49.44 1978-04-04;49.66 1978-04-05;50.09 1978-04-06;50.19 1978-04-07;50.41 1978-04-10;50.58 1978-04-11;50.47 1978-04-12;50.43 1978-04-13;50.91 1978-04-14;51.94 1978-04-17;52.69 1978-04-18;52.16 1978-04-19;52.35 1978-04-20;52.73 1978-04-21;52.65 1978-04-24;53.36 1978-04-25;53.81 1978-04-26;53.88 1978-04-27;53.4 1978-04-28;53.9 1978-05-01;54.36 1978-05-02;54.18 1978-05-03;53.72 1978-05-04;53.6 1978-05-05;53.97 1978-05-08;53.82 1978-05-09;53.68 1978-05-10;53.72 1978-05-11;54.38 1978-05-12;54.85 1978-05-15;55.18 1978-05-16;55.53 1978-05-17;55.68 1978-05-18;55.2 1978-05-19;54.95 1978-05-22;55.43 1978-05-23;54.9 1978-05-24;54.36 1978-05-25;54.24 1978-05-26;54.14 1978-05-30;54.3 1978-05-31;54.52 1978-06-01;54.59 1978-06-02;55.03 1978-06-05;55.97 1978-06-06;56.19 1978-06-07;56.11 1978-06-08;56.2 1978-06-09;56.08 1978-06-12;55.89 1978-06-13;55.91 1978-06-14;55.88 1978-06-15;55.31 1978-06-16;54.8 1978-06-19;54.76 1978-06-20;54.22 1978-06-21;53.91 1978-06-22;54.07 1978-06-23;53.9 1978-06-26;53.19 1978-06-27;53.35 1978-06-28;53.58 1978-06-29;53.69 1978-06-30;53.66 1978-07-03;53.46 1978-07-05;53 1978-07-06;53 1978-07-07;53.34 1978-07-10;53.55 1978-07-11;53.9 1978-07-12;54.09 1978-07-13;54.12 1978-07-14;54.82 1978-07-17;54.92 1978-07-18;54.45 1978-07-19;55.1 1978-07-20;55.07 1978-07-21;54.91 1978-07-24;54.88 1978-07-25;55.27 1978-07-26;55.61 1978-07-27;55.9 1978-07-28;56.18 1978-07-31;56.59 1978-08-01;56.61 1978-08-02;57.82 1978-08-03;58.12 1978-08-04;58.34 1978-08-07;58.2 1978-08-08;58.47 1978-08-09;58.75 1978-08-10;58.34 1978-08-11;58.53 1978-08-14;58.56 1978-08-15;58.48 1978-08-16;58.93 1978-08-17;59.21 1978-08-18;59.06 1978-08-21;58.56 1978-08-22;58.76 1978-08-23;59.12 1978-08-24;59.26 1978-08-25;59.22 1978-08-28;58.7 1978-08-29;58.38 1978-08-30;58.48 1978-08-31;58.35 1978-09-01;58.54 1978-09-05;58.91 1978-09-06;59.44 1978-09-07;59.5 1978-09-08;60.24 1978-09-11;60.38 1978-09-12;60.38 1978-09-13;60.06 1978-09-14;59.37 1978-09-15;58.81 1978-09-18;58.24 1978-09-19;57.84 1978-09-20;57.32 1978-09-21;57.36 1978-09-22;57.37 1978-09-25;57.38 1978-09-26;57.81 1978-09-27;57.31 1978-09-28;57.47 1978-09-29;57.78 1978-10-02;57.98 1978-10-03;57.8 1978-10-04;58.03 1978-10-05;58.19 1978-10-06;58.34 1978-10-09;58.9 1978-10-10;58.84 1978-10-11;59.29 1978-10-12;59.06 1978-10-13;58.93 1978-10-16;57.8 1978-10-17;56.89 1978-10-18;56.4 1978-10-19;55.71 1978-10-20;54.76 1978-10-23;54.79 1978-10-24;54.46 1978-10-25;54.34 1978-10-26;53.48 1978-10-27;52.52 1978-10-30;52.65 1978-10-31;51.67 1978-11-01;53.79 1978-11-02;53.2 1978-11-03;53.49 1978-11-06;53.03 1978-11-07;52.22 1978-11-08;52.49 1978-11-09;52.52 1978-11-10;52.72 1978-11-13;51.83 1978-11-14;51.36 1978-11-15;51.52 1978-11-16;52.09 1978-11-17;52.54 1978-11-20;53.04 1978-11-21;52.96 1978-11-22;53.24 1978-11-24;53.44 1978-11-27;53.56 1978-11-28;53.13 1978-11-29;52.38 1978-11-30;52.89 1978-12-01;53.77 1978-12-04;53.73 1978-12-05;54.44 1978-12-06;54.51 1978-12-07;54.3 1978-12-08;54.06 1978-12-11;54.31 1978-12-12;54.03 1978-12-13;53.72 1978-12-14;53.7 1978-12-15;53.31 1978-12-18;52.2 1978-12-19;52.58 1978-12-20;52.83 1978-12-21;52.89 1978-12-22;53.77 1978-12-26;54.36 1978-12-27;53.9 1978-12-28;53.68 1978-12-29;53.62 1979-01-02;53.93 1979-01-03;54.57 1979-01-04;55.05 1979-01-05;55.41 1979-01-08;55.24 1979-01-09;55.53 1979-01-10;55.23 1979-01-11;55.42 1979-01-12;55.91 1979-01-15;56.31 1979-01-16;55.66 1979-01-17;55.64 1979-01-18;55.81 1979-01-19;55.85 1979-01-22;55.92 1979-01-23;56.27 1979-01-24;56.07 1979-01-25;56.62 1979-01-26;56.99 1979-01-29;56.85 1979-01-30;56.6 1979-01-31;55.99 1979-02-01;56 1979-02-02;55.79 1979-02-05;55.01 1979-02-06;54.99 1979-02-07;54.47 1979-02-08;54.74 1979-02-09;54.87 1979-02-12;55.04 1979-02-13;55.46 1979-02-14;55.42 1979-02-15;55.38 1979-02-16;55.37 1979-02-20;55.74 1979-02-21;55.58 1979-02-22;55.2 1979-02-23;54.88 1979-02-26;54.78 1979-02-27;53.88 1979-02-28;53.93 1979-03-01;54.3 1979-03-02;54.37 1979-03-05;54.96 1979-03-06;54.88 1979-03-07;55.22 1979-03-08;55.81 1979-03-09;55.81 1979-03-12;55.87 1979-03-13;55.99 1979-03-14;55.95 1979-03-15;56.08 1979-03-16;56.55 1979-03-19;56.74 1979-03-20;56.45 1979-03-21;56.83 1979-03-22;57.09 1979-03-23;57.08 1979-03-26;56.76 1979-03-27;57.53 1979-03-28;57.35 1979-03-29;57.34 1979-03-30;57.13 1979-04-02;56.73 1979-04-03;57.55 1979-04-04;57.71 1979-04-05;58.06 1979-04-06;58.04 1979-04-09;57.88 1979-04-10;58.18 1979-04-11;57.65 1979-04-12;57.53 1979-04-16;57.05 1979-04-17;57.05 1979-04-18;57.33 1979-04-19;57.09 1979-04-20;57.09 1979-04-23;57.29 1979-04-24;57.62 1979-04-25;57.8 1979-04-26;57.52 1979-04-27;57.4 1979-04-30;57.36 1979-05-01;57.34 1979-05-02;57.36 1979-05-03;57.38 1979-05-04;56.76 1979-05-07;55.75 1979-05-08;55.79 1979-05-09;55.96 1979-05-10;55.45 1979-05-11;55.48 1979-05-14;55.22 1979-05-15;55.26 1979-05-16;55.38 1979-05-17;56.23 1979-05-18;56.26 1979-05-21;56.41 1979-05-22;56.65 1979-05-23;56.38 1979-05-24;56.43 1979-05-25;56.61 1979-05-29;56.53 1979-05-30;56.01 1979-05-31;55.99 1979-06-01;56.03 1979-06-04;56.13 1979-06-05;56.81 1979-06-06;57.23 1979-06-07;57.53 1979-06-08;57.42 1979-06-11;57.62 1979-06-12;58.18 1979-06-13;57.95 1979-06-14;57.87 1979-06-15;57.85 1979-06-18;57.56 1979-06-19;57.58 1979-06-20;57.65 1979-06-21;57.91 1979-06-22;58.21 1979-06-25;57.9 1979-06-26;57.67 1979-06-27;58.01 1979-06-28;58.33 1979-06-29;58.38 1979-07-02;57.86 1979-07-03;57.94 1979-07-05;58.16 1979-07-06;58.82 1979-07-09;59.32 1979-07-10;59.16 1979-07-11;58.86 1979-07-12;58.38 1979-07-13;58.17 1979-07-16;58.43 1979-07-17;57.88 1979-07-18;57.76 1979-07-19;57.76 1979-07-20;57.89 1979-07-23;57.77 1979-07-24;57.98 1979-07-25;58.62 1979-07-26;58.66 1979-07-27;58.73 1979-07-30;58.79 1979-07-31;59.14 1979-08-01;59.36 1979-08-02;59.35 1979-08-03;59.33 1979-08-06;59.45 1979-08-07;60.18 1979-08-08;60.36 1979-08-09;60.14 1979-08-10;60.64 1979-08-13;61.18 1979-08-14;61.26 1979-08-15;61.68 1979-08-16;61.56 1979-08-17;61.7 1979-08-20;62.02 1979-08-21;62.07 1979-08-22;62.13 1979-08-23;61.96 1979-08-24;61.94 1979-08-27;62.22 1979-08-28;62.16 1979-08-29;62.18 1979-08-30;62.2 1979-08-31;62.4 1979-09-04;61.35 1979-09-05;60.66 1979-09-06;60.94 1979-09-07;61.39 1979-09-10;61.69 1979-09-11;61.29 1979-09-12;61.48 1979-09-13;61.53 1979-09-14;62.08 1979-09-17;62.08 1979-09-18;61.62 1979-09-19;61.76 1979-09-20;62.85 1979-09-21;62.88 1979-09-24;62.37 1979-09-25;62.4 1979-09-26;62.57 1979-09-27;62.68 1979-09-28;62.24 1979-10-01;61.84 1979-10-02;62.36 1979-10-03;62.44 1979-10-04;62.77 1979-10-05;63.39 1979-10-08;62.58 1979-10-09;60.53 1979-10-10;59.53 1979-10-11;59.51 1979-10-12;59.29 1979-10-15;58.6 1979-10-16;58.5 1979-10-17;58.65 1979-10-18;58.8 1979-10-19;57.62 1979-10-22;56.9 1979-10-23;56.7 1979-10-24;56.83 1979-10-25;56.61 1979-10-26;56.96 1979-10-29;57.05 1979-10-30;58.11 1979-10-31;57.71 1979-11-01;58.17 1979-11-02;58.19 1979-11-05;57.81 1979-11-06;57.48 1979-11-07;56.75 1979-11-08;57.02 1979-11-09;57.74 1979-11-12;58.82 1979-11-13;58.59 1979-11-14;58.85 1979-11-15;59.27 1979-11-16;59.11 1979-11-19;59.36 1979-11-20;59.09 1979-11-21;59.18 1979-11-23;59.66 1979-11-26;60.91 1979-11-27;60.77 1979-11-28;61 1979-11-29;61.03 1979-11-30;60.71 1979-12-03;60.54 1979-12-04;61.06 1979-12-05;61.35 1979-12-06;61.8 1979-12-07;61.56 1979-12-10;61.66 1979-12-11;61.55 1979-12-12;61.58 1979-12-13;61.68 1979-12-14;62.35 1979-12-17;62.61 1979-12-18;62.06 1979-12-19;62 1979-12-20;62.08 1979-12-21;61.73 1979-12-24;61.74 1979-12-26;61.82 1979-12-27;61.91 1979-12-28;61.88 1979-12-31;61.95 1980-01-02;60.69 1980-01-03;60.34 1980-01-04;61.17 1980-01-07;61.4 1980-01-08;62.59 1980-01-09;62.72 1980-01-10;63.25 1980-01-11;63.33 1980-01-14;63.58 1980-01-15;63.95 1980-01-16;63.95 1980-01-17;63.8 1980-01-18;63.94 1980-01-21;64.51 1980-01-22;64.13 1980-01-23;65.13 1980-01-24;65.32 1980-01-25;65.27 1980-01-28;65.96 1980-01-29;65.49 1980-01-30;66.14 1980-01-31;65.61 1980-02-01;66.08 1980-02-04;65.69 1980-02-05;65.83 1980-02-06;66.39 1980-02-07;66.69 1980-02-08;67.57 1980-02-11;67.11 1980-02-12;67.51 1980-02-13;67.77 1980-02-14;66.82 1980-02-15;66.14 1980-02-19;65.62 1980-02-20;66.61 1980-02-21;66.03 1980-02-22;65.8 1980-02-25;64.79 1980-02-26;65.14 1980-02-27;64.3 1980-02-28;64.27 1980-02-29;64.95 1980-03-03;64.35 1980-03-04;64.36 1980-03-05;63.38 1980-03-06;61.94 1980-03-07;60.96 1980-03-10;60.59 1980-03-11;61.33 1980-03-12;60.86 1980-03-13;60.2 1980-03-14;60.07 1980-03-17;58.22 1980-03-18;59.09 1980-03-19;59.31 1980-03-20;58.66 1980-03-21;58.24 1980-03-24;56.47 1980-03-25;56.24 1980-03-26;55.98 1980-03-27;55.3 1980-03-28;56.82 1980-03-31;57.65 1980-04-01;57.83 1980-04-02;58.2 1980-04-03;57.95 1980-04-07;56.83 1980-04-08;57.38 1980-04-09;58.41 1980-04-10;59.05 1980-04-11;59 1980-04-14;58.42 1980-04-15;58.3 1980-04-16;57.71 1980-04-17;57.45 1980-04-18;57.21 1980-04-21;56.73 1980-04-22;58.74 1980-04-23;58.95 1980-04-24;59.38 1980-04-25;59.73 1980-04-28;60.01 1980-04-29;60.17 1980-04-30;60.36 1980-05-01;59.94 1980-05-02;60.05 1980-05-05;60.5 1980-05-06;60.49 1980-05-07;61.02 1980-05-08;60.52 1980-05-09;59.79 1980-05-12;59.78 1980-05-13;60.54 1980-05-14;60.9 1980-05-15;61.04 1980-05-16;61.23 1980-05-19;61.39 1980-05-20;61.35 1980-05-21;61.42 1980-05-22;62.19 1980-05-23;63.05 1980-05-27;63.5 1980-05-28;63.88 1980-05-29;62.97 1980-05-30;63.44 1980-06-02;63.22 1980-06-03;63.11 1980-06-04;64.24 1980-06-05;64.38 1980-06-06;64.67 1980-06-09;64.94 1980-06-10;65.43 1980-06-11;66.17 1980-06-12;65.92 1980-06-13;66.13 1980-06-16;66.26 1980-06-17;66.25 1980-06-18;66.36 1980-06-19;65.53 1980-06-20;65.2 1980-06-23;65.46 1980-06-24;65.84 1980-06-25;66.72 1980-06-26;66.44 1980-06-27;66.34 1980-06-30;65.34 1980-07-01;65.73 1980-07-02;66.16 1980-07-03;67.07 1980-07-07;67.58 1980-07-08;67.37 1980-07-09;67.46 1980-07-10;66.95 1980-07-11;67.44 1980-07-14;68.68 1980-07-15;68.35 1980-07-16;68.54 1980-07-17;69.53 1980-07-18;69.84 1980-07-21;70.1 1980-07-22;69.94 1980-07-23;69.76 1980-07-24;69.68 1980-07-25;69.1 1980-07-28;69.43 1980-07-29;69.99 1980-07-30;69.95 1980-07-31;69.64 1980-08-01;69.44 1980-08-04;69.2 1980-08-05;69.16 1980-08-06;69.63 1980-08-07;70.6 1980-08-08;70.81 1980-08-11;71.45 1980-08-12;70.92 1980-08-13;70.68 1980-08-14;71.81 1980-08-15;72.07 1980-08-18;70.75 1980-08-19;70.32 1980-08-20;71.01 1980-08-21;72.07 1980-08-22;72.47 1980-08-25;72.03 1980-08-26;71.86 1980-08-27;71.15 1980-08-28;70.35 1980-08-29;70.53 1980-09-02;71.28 1980-09-03;72.71 1980-09-04;72.41 1980-09-05;72.13 1980-09-08;71.27 1980-09-09;71.64 1980-09-10;72.12 1980-09-11;72.64 1980-09-12;72.65 1980-09-15;72.75 1980-09-16;73.41 1980-09-17;74.57 1980-09-18;74.36 1980-09-19;74.81 1980-09-22;75.43 1980-09-23;74.85 1980-09-24;75.34 1980-09-25;74.45 1980-09-26;72.99 1980-09-29;71.26 1980-09-30;72.38 1980-10-01;73.37 1980-10-02;73.96 1980-10-03;74.74 1980-10-06;76.04 1980-10-07;75.65 1980-10-08;76.02 1980-10-09;75.72 1980-10-10;75.34 1980-10-13;76.28 1980-10-14;76.32 1980-10-15;77.24 1980-10-16;76.37 1980-10-17;75.92 1980-10-20;76.44 1980-10-21;75.98 1980-10-22;76.06 1980-10-23;74.69 1980-10-24;74.9 1980-10-27;73.82 1980-10-28;73.84 1980-10-29;73.8 1980-10-30;72.85 1980-10-31;73.53 1980-11-03;74.36 1980-11-05;75.64 1980-11-06;74.29 1980-11-07;74.35 1980-11-10;74.61 1980-11-11;75.56 1980-11-12;77.44 1980-11-13;78.58 1980-11-14;78.96 1980-11-17;79.32 1980-11-18;80.48 1980-11-19;80.17 1980-11-20;80.9 1980-11-21;80.17 1980-11-24;79.67 1980-11-25;80.32 1980-11-26;80.78 1980-11-28;81.02 1980-12-01;79.16 1980-12-02;78.91 1980-12-03;78.81 1980-12-04;78.6 1980-12-05;77.16 1980-12-08;75.12 1980-12-09;75.04 1980-12-10;73.78 1980-12-11;73.11 1980-12-12;74.16 1980-12-15;74.31 1980-12-16;74.87 1980-12-17;76.13 1980-12-18;76.4 1980-12-19;76.86 1980-12-22;77.94 1980-12-23;77.64 1980-12-24;77.95 1980-12-26;78.28 1980-12-29;77.44 1980-12-30;77.58 1980-12-31;77.86 1981-01-02;78.26 1981-01-05;79.08 1981-01-06;79.14 1981-01-07;77.29 1981-01-08;76.2 1981-01-09;76.44 1981-01-12;76.52 1981-01-13;76.35 1981-01-14;76.55 1981-01-15;76.99 1981-01-16;77.33 1981-01-19;77.1 1981-01-20;75.61 1981-01-21;75.39 1981-01-22;74.76 1981-01-23;74.72 1981-01-26;74.45 1981-01-27;75.19 1981-01-28;74.78 1981-01-29;74.69 1981-01-30;74.27 1981-02-02;72.67 1981-02-03;73.48 1981-02-04;73.64 1981-02-05;74.31 1981-02-06;74.83 1981-02-09;74.05 1981-02-10;73.98 1981-02-11;73.47 1981-02-12;73.05 1981-02-13;72.8 1981-02-17;73.22 1981-02-18;73.59 1981-02-19;72.53 1981-02-20;72.45 1981-02-23;72.84 1981-02-24;72.91 1981-02-25;73.46 1981-02-26;74.39 1981-02-27;75.13 1981-03-02;75.58 1981-03-03;74.83 1981-03-04;74.98 1981-03-05;74.51 1981-03-06;74.46 1981-03-09;75.09 1981-03-10;74.73 1981-03-11;74.53 1981-03-12;76.27 1981-03-13;76.32 1981-03-16;77.19 1981-03-17;76.81 1981-03-18;76.99 1981-03-19;76.64 1981-03-20;77.09 1981-03-23;78.01 1981-03-24;77.52 1981-03-25;78.82 1981-03-26;78.43 1981-03-27;77.59 1981-03-30;77.36 1981-03-31;78.27 1981-04-01;78.62 1981-04-02;78.57 1981-04-03;78.14 1981-04-06;77.29 1981-04-07;77.3 1981-04-08;77.55 1981-04-09;77.8 1981-04-10;77.78 1981-04-13;76.94 1981-04-14;76.59 1981-04-15;77.46 1981-04-16;77.76 1981-04-20;78.17 1981-04-21;77.46 1981-04-22;77.41 1981-04-23;77.38 1981-04-24;78.05 1981-04-27;78.23 1981-04-28;77.55 1981-04-29;76.84 1981-04-30;76.81 1981-05-01;76.75 1981-05-04;75.52 1981-05-05;75.3 1981-05-06;75.6 1981-05-07;76.08 1981-05-08;76.13 1981-05-11;75.05 1981-05-12;75.6 1981-05-13;75.56 1981-05-14;76.02 1981-05-15;76.54 1981-05-18;76.73 1981-05-19;76.47 1981-05-20;76.53 1981-05-21;76.44 1981-05-22;76.26 1981-05-26;77.05 1981-05-27;77.58 1981-05-28;77.44 1981-05-29;76.99 1981-06-01;76.91 1981-06-02;75.89 1981-06-03;75.87 1981-06-04;76.02 1981-06-05;76.73 1981-06-08;76.76 1981-06-09;76.54 1981-06-10;76.78 1981-06-11;77.63 1981-06-12;77.6 1981-06-15;77.65 1981-06-16;76.8 1981-06-17;77.34 1981-06-18;76.4 1981-06-19;76.75 1981-06-22;76.59 1981-06-23;77.42 1981-06-24;77 1981-06-25;77.11 1981-06-26;76.97 1981-06-29;76.58 1981-06-30;76.15 1981-07-01;75.37 1981-07-02;74.73 1981-07-06;73.99 1981-07-07;74.39 1981-07-08;74.5 1981-07-09;75.06 1981-07-10;75.15 1981-07-13;75.28 1981-07-14;75.26 1981-07-15;75.6 1981-07-16;75.7 1981-07-17;75.96 1981-07-20;74.84 1981-07-21;74.59 1981-07-22;73.9 1981-07-23;74.01 1981-07-24;74.6 1981-07-27;75.32 1981-07-28;74.94 1981-07-29;74.95 1981-07-30;75.41 1981-07-31;75.95 1981-08-03;75.7 1981-08-04;76.04 1981-08-05;76.91 1981-08-06;77 1981-08-07;76.58 1981-08-10;76.9 1981-08-11;77.65 1981-08-12;77.42 1981-08-13;77.53 1981-08-14;77 1981-08-17;76.28 1981-08-18;75.55 1981-08-19;75.73 1981-08-20;75.88 1981-08-21;75.1 1981-08-24;72.92 1981-08-25;72.58 1981-08-26;72.49 1981-08-27;71.67 1981-08-28;71.97 1981-08-31;71.2 1981-09-01;71.28 1981-09-02;71.56 1981-09-03;70.25 1981-09-04;69.55 1981-09-08;68.24 1981-09-09;68.48 1981-09-10;69.49 1981-09-11;70.32 1981-09-14;69.79 1981-09-15;69.34 1981-09-16;68.82 1981-09-17;67.83 1981-09-18;67.27 1981-09-21;67.71 1981-09-22;67.43 1981-09-23;66.74 1981-09-24;66.42 1981-09-25;64.96 1981-09-28;66.43 1981-09-29;66.85 1981-09-30;67 1981-10-01;67.5 1981-10-02;68.86 1981-10-05;69 1981-10-06;69.03 1981-10-07;70.13 1981-10-08;70.74 1981-10-09;70.33 1981-10-12;70.21 1981-10-13;70.07 1981-10-14;68.97 1981-10-15;69.39 1981-10-16;69.13 1981-10-19;69.02 1981-10-20;69.75 1981-10-21;69.66 1981-10-22;69.39 1981-10-23;68.83 1981-10-26;68.58 1981-10-27;69.2 1981-10-28;69.34 1981-10-29;69.09 1981-10-30;70.64 1981-11-02;72.05 1981-11-03;72.38 1981-11-04;72.38 1981-11-05;71.79 1981-11-06;71.33 1981-11-09;71.67 1981-11-10;71.42 1981-11-11;71.54 1981-11-12;71.69 1981-11-13;70.85 1981-11-16;69.99 1981-11-17;70.39 1981-11-18;70.03 1981-11-19;70.36 1981-11-20;71 1981-11-23;70.91 1981-11-24;71.85 1981-11-25;72.15 1981-11-26;72.71 1981-11-30;73.37 1981-12-01;73.18 1981-12-02;72.4 1981-12-03;72.65 1981-12-04;73.24 1981-12-07;72.65 1981-12-08;72.36 1981-12-09;72.69 1981-12-10;72.84 1981-12-11;72.43 1981-12-14;71.24 1981-12-15;71.35 1981-12-16;71.06 1981-12-17;71.37 1981-12-18;71.87 1981-12-21;71.53 1981-12-22;71.27 1981-12-23;70.97 1981-12-24;71.11 1981-12-25;70.94 1981-12-29;70.58 1981-12-30;70.9 1981-12-31;71.11 1982-01-04;71.2 1982-01-05;69.72 1982-01-06;69.18 1982-01-07;69.02 1982-01-08;69.36 1982-01-11;67.76 1982-01-12;67.45 1982-01-13;66.63 1982-01-14;66.96 1982-01-15;67.41 1982-01-18;67.84 1982-01-19;67.19 1982-01-20;66.8 1982-01-21;67 1982-01-22;66.78 1982-01-25;66.64 1982-01-26;66.49 1982-01-27;66.78 1982-01-28;68.58 1982-01-29;69.39 1982-02-01;68.01 1982-02-02;68.17 1982-02-03;67.41 1982-02-04;67.3 1982-02-05;67.79 1982-02-08;66.32 1982-02-09;65.74 1982-02-10;66.21 1982-02-11;66.11 1982-02-12;66.09 1982-02-15;65.87 1982-02-17;65.71 1982-02-18;65.78 1982-02-19;65.43 1982-02-22;64.55 1982-02-23;64.44 1982-02-24;65.45 1982-02-25;65.41 1982-02-26;65.33 1982-03-01;65.44 1982-03-02;65.14 1982-03-03;64.14 1982-03-04;63.5 1982-03-05;63.14 1982-03-08;62.03 1982-03-09;62.71 1982-03-10;63.04 1982-03-11;62.98 1982-03-12;62.52 1982-03-15;62.88 1982-03-16;62.84 1982-03-17;62.74 1982-03-18;63.46 1982-03-19;63.62 1982-03-22;64.86 1982-03-23;65.3 1982-03-24;65 1982-03-25;65.15 1982-03-26;64.53 1982-03-29;64.65 1982-03-30;64.65 1982-03-31;64.52 1982-04-01;65.49 1982-04-02;66.22 1982-04-05;66.04 1982-04-06;66.41 1982-04-07;66.49 1982-04-08;66.89 1982-04-09;66.76 1982-04-13;66.76 1982-04-14;66.67 1982-04-15;66.96 1982-04-16;67.26 1982-04-19;67.2 1982-04-20;66.55 1982-04-21;66.71 1982-04-22;67.49 1982-04-23;68.25 1982-04-26;68.59 1982-04-27;67.95 1982-04-28;67.55 1982-04-29;66.95 1982-04-30;67.08 1982-05-03;67.26 1982-05-04;67.63 1982-05-05;67.75 1982-05-06;68.31 1982-05-07;68.76 1982-05-10;68.22 1982-05-11;68.8 1982-05-12;68.69 1982-05-13;68.2 1982-05-14;68.11 1982-05-17;67.36 1982-05-18;66.84 1982-05-19;66.32 1982-05-20;66.09 1982-05-21;66.26 1982-05-24;66.17 1982-05-25;65.95 1982-05-26;65.18 1982-05-27;64.88 1982-05-28;64.55 1982-06-01;64.37 1982-06-02;64.55 1982-06-03;64.42 1982-06-04;63.42 1982-06-07;63.36 1982-06-08;63.08 1982-06-09;62.68 1982-06-10;62.97 1982-06-11;63.94 1982-06-14;63.25 1982-06-15;63.05 1982-06-16;62.67 1982-06-17;61.96 1982-06-18;61.74 1982-06-21;61.73 1982-06-22;62.29 1982-06-23;63.26 1982-06-24;63.12 1982-06-25;62.72 1982-06-28;63.29 1982-06-29;63.28 1982-06-30;63.02 1982-07-01;62.51 1982-07-02;61.99 1982-07-05;61.78 1982-07-07;61.7 1982-07-08;61.81 1982-07-09;62.64 1982-07-12;62.96 1982-07-13;62.9 1982-07-14;63.36 1982-07-15;63.38 1982-07-16;63.67 1982-07-19;63.54 1982-07-20;63.95 1982-07-21;63.9 1982-07-22;63.95 1982-07-23;63.8 1982-07-26;63.35 1982-07-27;62.84 1982-07-28;61.87 1982-07-29;61.83 1982-07-30;61.51 1982-08-02;62.49 1982-08-03;61.91 1982-08-04;60.97 1982-08-05;60.44 1982-08-06;59.69 1982-08-09;59.25 1982-08-10;59.13 1982-08-11;58.95 1982-08-12;58.8 1982-08-13;59.54 1982-08-16;59.75 1982-08-17;62.41 1982-08-18;62.32 1982-08-19;62.57 1982-08-20;64.65 1982-08-23;66.36 1982-08-24;66.1 1982-08-25;67.39 1982-08-26;68.01 1982-08-27;67.23 1982-08-30;67.52 1982-08-31;68.54 1982-09-01;67.9 1982-09-02;68.98 1982-09-03;70.26 1982-09-06;69.56 1982-09-08;70.02 1982-09-09;69.97 1982-09-10;69.41 1982-09-13;70.03 1982-09-14;70.57 1982-09-15;71.19 1982-09-16;71 1982-09-17;70.34 1982-09-20;70.25 1982-09-21;71.49 1982-09-22;71.1 1982-09-23;70.98 1982-09-24;70.75 1982-09-27;70.88 1982-09-28;70.7 1982-09-29;69.78 1982-09-30;69.18 1982-10-01;70.01 1982-10-04;69.77 1982-10-05;70.06 1982-10-06;72.2 1982-10-07;73.77 1982-10-08;75 1982-10-11;76.91 1982-10-12;76.95 1982-10-13;78.3 1982-10-14;77.23 1982-10-15;76.74 1982-10-18;78.4 1982-10-19;78.35 1982-10-20;79.8 1982-10-21;79.72 1982-10-22;79.68 1982-10-25;76.65 1982-10-26;77.11 1982-10-27;77.68 1982-10-28;76.87 1982-10-29;76.95 1982-11-01;77.92 1982-11-02;79.12 1982-11-03;82.05 1982-11-04;81.59 1982-11-05;81.83 1982-11-08;80.94 1982-11-09;82.35 1982-11-10;81.43 1982-11-11;81.76 1982-11-12;80.7 1982-11-15;79.32 1982-11-16;78.3 1982-11-17;79.67 1982-11-18;79.98 1982-11-19;79.32 1982-11-22;77.85 1982-11-23;77.12 1982-11-24;77.6 1982-11-25;78.14 1982-11-29;77.73 1982-11-30;79.95 1982-12-01;80.13 1982-12-02;80.12 1982-12-03;80.05 1982-12-06;81.61 1982-12-07;82.13 1982-12-08;81.73 1982-12-09;80.77 1982-12-10;80.49 1982-12-13;80.67 1982-12-14;79.32 1982-12-15;78.09 1982-12-16;78.04 1982-12-17;79.2 1982-12-20;78.54 1982-12-21;79.74 1982-12-22;79.87 1982-12-23;80.39 1982-12-24;81.63 1982-12-28;80.94 1982-12-29;81.21 1982-12-30;80.79 1982-12-31;81.03 1983-01-03;79.79 1983-01-04;81.29 1983-01-05;81.76 1983-01-06;83.71 1983-01-07;83.67 1983-01-10;84.62 1983-01-11;84.11 1983-01-12;84.65 1983-01-13;84.16 1983-01-14;84.67 1983-01-17;84.79 1983-01-18;84.63 1983-01-19;83.99 1983-01-20;84.51 1983-01-21;83.18 1983-01-24;80.92 1983-01-25;81.82 1983-01-26;81.73 1983-01-27;83.17 1983-01-28;83.35 1983-01-31;83.75 1983-02-01;82.61 1983-02-02;82.67 1983-02-03;83.26 1983-02-04;84.29 1983-02-07;84.77 1983-02-08;84.16 1983-02-09;83.79 1983-02-10;85.1 1983-02-11;85.18 1983-02-14;85.89 1983-02-15;85.68 1983-02-16;85.18 1983-02-17;85.13 1983-02-18;85.44 1983-02-21;84.07 1983-02-23;84.74 1983-02-24;86.25 1983-02-25;86.35 1983-02-28;85.46 1983-03-01;86.93 1983-03-02;87.78 1983-03-03;88.48 1983-03-04;88.63 1983-03-07;88.66 1983-03-08;87.4 1983-03-09;88.23 1983-03-10;87.65 1983-03-11;87.29 1983-03-14;86.99 1983-03-15;87.22 1983-03-16;86.43 1983-03-17;86.22 1983-03-18;86.37 1983-03-21;86.97 1983-03-22;86.71 1983-03-23;87.85 1983-03-24;88.2 1983-03-25;87.81 1983-03-28;87.34 1983-03-29;87.24 1983-03-30;88.16 1983-03-31;88.03 1983-04-01;88.06 1983-04-05;87.47 1983-04-06;86.97 1983-04-07;87.32 1983-04-08;87.87 1983-04-11;89.07 1983-04-12;89.46 1983-04-13;90.04 1983-04-14;90.84 1983-04-15;91.18 1983-04-18;91.71 1983-04-19;91.18 1983-04-20;92.29 1983-04-21;91.95 1983-04-22;92.15 1983-04-25;91.29 1983-04-26;92.83 1983-04-27;92.68 1983-04-28;93.5 1983-04-29;94.27 1983-05-02;93.04 1983-05-03;93.14 1983-05-04;93.76 1983-05-05;94.4 1983-05-06;95.47 1983-05-09;95.35 1983-05-10;95.5 1983-05-11;94.99 1983-05-12;94.65 1983-05-13;95.07 1983-05-16;94.19 1983-05-17;94.48 1983-05-18;94.39 1983-05-19;93.67 1983-05-20;93.71 1983-05-23;94.39 1983-05-24;95.58 1983-05-25;96.01 1983-05-26;95.68 1983-05-27;95.23 1983-05-30;94.08 1983-06-01;94.13 1983-06-02;94.87 1983-06-03;95.13 1983-06-06;95.4 1983-06-07;94.37 1983-06-08;93.57 1983-06-09;93.85 1983-06-10;94.45 1983-06-13;95.62 1983-06-14;96.01 1983-06-15;96.84 1983-06-16;97.94 1983-06-17;98 1983-06-20;97.96 1983-06-21;98.71 1983-06-22;99.01 1983-06-23;98.84 1983-06-24;98.82 1983-06-27;97.74 1983-06-28;96.12 1983-06-29;96.56 1983-06-30;97.41 1983-07-01;97.91 1983-07-04;96.65 1983-07-06;97.73 1983-07-07;97.2 1983-07-08;96.89 1983-07-11;97.44 1983-07-12;96.04 1983-07-13;95.9 1983-07-14;96.23 1983-07-15;95.28 1983-07-18;94.96 1983-07-19;95.48 1983-07-20;97.84 1983-07-21;97.79 1983-07-22;97.74 1983-07-25;98.07 1983-07-26;98.58 1983-07-27;97.14 1983-07-28;95.71 1983-07-29;94.27 1983-08-01;93.91 1983-08-02;93.82 1983-08-03;94.43 1983-08-04;93.33 1983-08-05;93.6 1983-08-08;92.19 1983-08-09;92.53 1983-08-10;93.3 1983-08-11;93.4 1983-08-12;93.84 1983-08-15;94.7 1983-08-16;94.46 1983-08-17;95.51 1983-08-18;94.73 1983-08-19;94.92 1983-08-22;95.1 1983-08-23;94.27 1983-08-24;93.44 1983-08-25;93.18 1983-08-26;93.8 1983-08-29;93.8 1983-08-30;93.97 1983-08-31;94.89 1983-09-01;94.83 1983-09-02;95.28 1983-09-05;96.84 1983-09-07;96.96 1983-09-08;96.95 1983-09-09;96.54 1983-09-12;95.86 1983-09-13;95.41 1983-09-14;95.7 1983-09-15;95.23 1983-09-16;96.17 1983-09-19;97.09 1983-09-20;97.88 1983-09-21;97.46 1983-09-22;98.2 1983-09-23;98.07 1983-09-26;98.39 1983-09-27;97.47 1983-09-28;97.25 1983-09-29;96.86 1983-09-30;96.24 1983-10-03;95.99 1983-10-04;96.24 1983-10-05;97.03 1983-10-06;98.44 1983-10-07;98.72 1983-10-10;99.63 1983-10-11;98.39 1983-10-12;97.96 1983-10-13;98.02 1983-10-14;98 1983-10-17;98.27 1983-10-18;96.81 1983-10-19;96.16 1983-10-20;96.32 1983-10-21;95.74 1983-10-24;95.72 1983-10-25;95.98 1983-10-26;95.41 1983-10-27;95.06 1983-10-28;94.28 1983-10-31;94.29 1983-11-01;94.33 1983-11-02;95.02 1983-11-03;94.33 1983-11-04;93.77 1983-11-07;93.46 1983-11-08;93.33 1983-11-09;94.44 1983-11-10;94.75 1983-11-11;95.82 1983-11-14;96.05 1983-11-15;95.49 1983-11-16;95.89 1983-11-17;95.93 1983-11-18;96.46 1983-11-21;95.92 1983-11-22;96.33 1983-11-23;96.4 1983-11-24;96.55 1983-11-28;96.19 1983-11-29;96.94 1983-11-30;96.19 1983-12-01;96.19 1983-12-02;95.66 1983-12-05;95.77 1983-12-06;95.61 1983-12-07;95.86 1983-12-08;95.45 1983-12-09;95.4 1983-12-12;95.64 1983-12-13;95.28 1983-12-14;94.41 1983-12-15;93.53 1983-12-16;93.86 1983-12-19;93.8 1983-12-20;93.64 1983-12-21;94.44 1983-12-22;94.27 1983-12-23;94.17 1983-12-26;94.93 1983-12-28;95.23 1983-12-29;95.03 1983-12-30;95.18 1984-01-03;94.69 1984-01-04;96.17 1984-01-05;97.34 1984-01-06;97.71 1984-01-09;97.58 1984-01-10;97.09 1984-01-11;97.03 1984-01-12;97.05 1984-01-13;96.66 1984-01-16;96.75 1984-01-17;97.05 1984-01-18;96.9 1984-01-19;96.6 1984-01-20;96.13 1984-01-23;96.32 1984-01-24;96.86 1984-01-25;95.26 1984-01-26;94.88 1984-01-27;94.77 1984-01-30;94.12 1984-01-31;94.32 1984-02-01;93.93 1984-02-02;94.28 1984-02-03;92.98 1984-02-06;91.43 1984-02-07;91.66 1984-02-08;90.09 1984-02-09;89.72 1984-02-10;90.07 1984-02-13;89.28 1984-02-14;90.12 1984-02-15;89.95 1984-02-16;89.83 1984-02-17;89.59 1984-02-20;88.97 1984-02-22;88.77 1984-02-23;88.69 1984-02-24;90.49 1984-02-27;91.54 1984-02-28;90.24 1984-02-29;90.44 1984-03-01;91.07 1984-03-02;91.67 1984-03-05;90.96 1984-03-06;90.07 1984-03-07;89.09 1984-03-08;89.39 1984-03-09;88.94 1984-03-12;89.95 1984-03-13;90.32 1984-03-14;90.32 1984-03-15;90.67 1984-03-16;91.73 1984-03-19;90.87 1984-03-20;91.4 1984-03-21;91.3 1984-03-22;90.3 1984-03-23;90.35 1984-03-26;90.24 1984-03-27;90.55 1984-03-28;91.9 1984-03-29;91.78 1984-03-30;91.67 1984-04-02;91.03 1984-04-03;90.79 1984-04-04;90.71 1984-04-05;89.33 1984-04-06;89.48 1984-04-09;89.48 1984-04-10;89.71 1984-04-11;89.24 1984-04-12;90.64 1984-04-13;90.51 1984-04-16;91 1984-04-17;91.41 1984-04-18;90.83 1984-04-19;90.89 1984-04-20;90.23 1984-04-24;90.85 1984-04-25;91.18 1984-04-26;92.09 1984-04-27;91.94 1984-04-30;91.98 1984-05-01;92.87 1984-05-02;93.09 1984-05-03;92.83 1984-05-04;91.75 1984-05-07;91.87 1984-05-08;92.44 1984-05-09;92.14 1984-05-10;92.03 1984-05-11;91.23 1984-05-14;90.66 1984-05-15;90.9 1984-05-16;90.92 1984-05-17;90.07 1984-05-18;89.56 1984-05-21;88.98 1984-05-22;88.43 1984-05-23;88.09 1984-05-24;86.95 1984-05-25;87.12 1984-05-28;86.45 1984-05-30;86.46 1984-05-31;86.71 1984-06-01;88.16 1984-06-04;88.85 1984-06-05;88.49 1984-06-06;89.15 1984-06-07;89.17 1984-06-08;89.33 1984-06-11;88.23 1984-06-12;87.81 1984-06-13;87.74 1984-06-14;86.86 1984-06-15;86.17 1984-06-18;87.55 1984-06-19;88.07 1984-06-20;89.16 1984-06-21;89.06 1984-06-22;89.06 1984-06-25;88.81 1984-06-26;88.15 1984-06-27;87.58 1984-06-28;88.19 1984-06-29;88.38 1984-07-02;88.33 1984-07-03;88.62 1984-07-06;88.17 1984-07-09;87.9 1984-07-10;88.41 1984-07-11;88.19 1984-07-12;86.96 1984-07-13;86.64 1984-07-16;87.08 1984-07-17;87.34 1984-07-18;87.76 1984-07-19;87.25 1984-07-20;86.68 1984-07-23;86.21 1984-07-24;85.73 1984-07-25;85.13 1984-07-26;85.64 1984-07-27;86.34 1984-07-30;87.01 1984-07-31;86.51 1984-08-01;86.73 1984-08-02;88.58 1984-08-03;90.77 1984-08-06;93.23 1984-08-07;93.45 1984-08-08;93.43 1984-08-09;92.96 1984-08-10;94.97 1984-08-13;95.08 1984-08-14;95.02 1984-08-15;94.54 1984-08-16;93.71 1984-08-17;94.23 1984-08-20;94.42 1984-08-21;94.76 1984-08-22;96.3 1984-08-23;95.96 1984-08-24;96.01 1984-08-27;96.24 1984-08-28;95.67 1984-08-29;96.14 1984-08-30;96.05 1984-08-31;95.81 1984-09-03;95.86 1984-09-05;94.96 1984-09-06;94.6 1984-09-07;95.3 1984-09-10;94.69 1984-09-11;94.61 1984-09-12;94.76 1984-09-13;94.81 1984-09-14;96.48 1984-09-17;97.05 1984-09-18;97.12 1984-09-19;96.55 1984-09-20;96.21 1984-09-21;96.51 1984-09-24;95.67 1984-09-25;95.38 1984-09-26;95.47 1984-09-27;95.82 1984-09-28;96.19 1984-10-01;95.77 1984-10-02;94.96 1984-10-03;94.38 1984-10-04;93.74 1984-10-05;93.95 1984-10-08;93.89 1984-10-09;93.58 1984-10-10;93.42 1984-10-11;93.57 1984-10-12;93.97 1984-10-15;94.79 1984-10-16;95.6 1984-10-17;95.16 1984-10-18;94.84 1984-10-19;96.81 1984-10-22;96.86 1984-10-23;96.53 1984-10-24;96.38 1984-10-25;96.4 1984-10-26;95.93 1984-10-29;95.34 1984-10-30;95.06 1984-10-31;96.11 1984-11-01;95.74 1984-11-02;96.48 1984-11-05;96.51 1984-11-06;97.14 1984-11-07;98.12 1984-11-08;97.46 1984-11-09;97.2 1984-11-12;96.73 1984-11-13;96.51 1984-11-14;95.78 1984-11-15;95.74 1984-11-16;95.68 1984-11-19;94.7 1984-11-20;94.1 1984-11-21;94.59 1984-11-22;94.79 1984-11-26;96.1 1984-11-27;95.42 1984-11-28;95.81 1984-11-29;95.14 1984-11-30;94.53 1984-12-03;94.3 1984-12-04;93.91 1984-12-05;94.13 1984-12-06;93.47 1984-12-07;93.74 1984-12-10;93.52 1984-12-11;93.81 1984-12-12;94 1984-12-13;93.79 1984-12-14;93.42 1984-12-17;93.92 1984-12-18;94.43 1984-12-19;96.78 1984-12-20;96.39 1984-12-21;96 1984-12-24;95.56 1984-12-25;96.18 1984-12-27;96.04 1984-12-28;95.64 1984-12-31;95.89 1985-01-02;95.43 1985-01-03;95.05 1985-01-04;94.6 1985-01-07;94.89 1985-01-08;94.81 1985-01-09;95.44 1985-01-10;97.13 1985-01-11;96.98 1985-01-14;98.38 1985-01-15;98.59 1985-01-16;98.9 1985-01-17;98.75 1985-01-18;99.04 1985-01-21;101.12 1985-01-22;101.28 1985-01-23;102.27 1985-01-24;102.03 1985-01-25;102.42 1985-01-28;102.53 1985-01-29;103.43 1985-01-30;103.65 1985-01-31;103.75 1985-02-01;103.23 1985-02-04;104.16 1985-02-05;104.42 1985-02-06;104.4 1985-02-07;105.18 1985-02-08;105.39 1985-02-11;104.5 1985-02-12;104.57 1985-02-13;106.08 1985-02-14;105.7 1985-02-15;105.27 1985-02-19;105.12 1985-02-20;105.11 1985-02-21;104.51 1985-02-22;104.01 1985-02-25;103.82 1985-02-26;104.82 1985-02-27;104.66 1985-02-28;104.93 1985-03-01;106.04 1985-03-04;105.43 1985-03-05;105.47 1985-03-06;104.64 1985-03-07;104.07 1985-03-08;103.82 1985-03-11;103.59 1985-03-12;104.03 1985-03-13;103.24 1985-03-14;103.11 1985-03-15;102.46 1985-03-18;102.51 1985-03-19;103.91 1985-03-20;103.69 1985-03-21;103.85 1985-03-22;103.65 1985-03-25;103.05 1985-03-26;103.28 1985-03-27;103.93 1985-03-28;103.98 1985-03-29;104.6 1985-04-01;104.9 1985-04-02;104.53 1985-04-03;103.77 1985-04-04;103.71 1985-04-08;103.28 1985-04-09;103.32 1985-04-10;103.99 1985-04-11;104.43 1985-04-12;104.64 1985-04-15;104.87 1985-04-16;105.02 1985-04-17;105.29 1985-04-18;104.86 1985-04-19;105 1985-04-22;104.8 1985-04-23;105.43 1985-04-24;105.6 1985-04-25;106.15 1985-04-26;105.52 1985-04-29;104.63 1985-04-30;104.12 1985-05-01;103.35 1985-05-02;103.62 1985-05-03;104.17 1985-05-06;104.18 1985-05-07;104.59 1985-05-08;104.56 1985-05-09;105.31 1985-05-10;106.64 1985-05-13;106.85 1985-05-14;106.48 1985-05-15;106.87 1985-05-16;107.5 1985-05-17;108.48 1985-05-20;109.72 1985-05-21;109.65 1985-05-22;108.99 1985-05-23;108.47 1985-05-24;108.87 1985-05-28;108.73 1985-05-29;108.66 1985-05-30;108.73 1985-05-31;109.63 1985-06-03;109.61 1985-06-04;110.06 1985-06-05;110.24 1985-06-06;110.69 1985-06-07;109.97 1985-06-10;109.83 1985-06-11;109.59 1985-06-12;108.87 1985-06-13;107.96 1985-06-14;108.56 1985-06-17;108.28 1985-06-18;108.75 1985-06-19;108.45 1985-06-20;108.46 1985-06-21;109.85 1985-06-24;109.65 1985-06-25;109.97 1985-06-26;110.13 1985-06-27;110.72 1985-06-28;111.11 1985-07-01;111.45 1985-07-02;111.28 1985-07-03;111.02 1985-07-05;111.73 1985-07-08;111.29 1985-07-09;110.88 1985-07-10;111.6 1985-07-11;111.95 1985-07-12;112.13 1985-07-15;111.93 1985-07-16;113.05 1985-07-17;113.49 1985-07-18;112.81 1985-07-19;113.26 1985-07-22;112.71 1985-07-23;111.69 1985-07-24;111.13 1985-07-25;111.24 1985-07-26;111.35 1985-07-29;109.8 1985-07-30;109.88 1985-07-31;110.47 1985-08-01;111.18 1985-08-02;110.85 1985-08-05;110.27 1985-08-06;108.81 1985-08-07;108.58 1985-08-08;109.4 1985-08-09;109.06 1985-08-12;108.67 1985-08-13;108.54 1985-08-14;108.62 1985-08-15;108.59 1985-08-16;107.91 1985-08-19;108.1 1985-08-20;108.92 1985-08-21;109.49 1985-08-22;108.57 1985-08-23;108.49 1985-08-26;108.59 1985-08-27;109.01 1985-08-28;109.39 1985-08-29;109.47 1985-08-30;109.39 1985-09-03;108.91 1985-09-04;108.61 1985-09-05;108.55 1985-09-06;109.05 1985-09-09;109.12 1985-09-10;108.32 1985-09-11;107.22 1985-09-12;106.36 1985-09-13;105.85 1985-09-16;105.79 1985-09-17;104.89 1985-09-18;105 1985-09-19;106 1985-09-20;105.39 1985-09-23;106.51 1985-09-24;105.6 1985-09-25;104.55 1985-09-26;104.82 1985-09-30;105.19 1985-10-01;106.77 1985-10-02;106.36 1985-10-03;106.52 1985-10-04;105.95 1985-10-07;105.25 1985-10-08;105.19 1985-10-09;105.54 1985-10-10;105.75 1985-10-11;106.56 1985-10-14;107.64 1985-10-15;107.5 1985-10-16;108.48 1985-10-17;108.41 1985-10-18;108.15 1985-10-21;108.05 1985-10-22;108.65 1985-10-23;109.17 1985-10-24;108.88 1985-10-25;108.36 1985-10-28;108.42 1985-10-29;109.19 1985-10-30;109.69 1985-10-31;109.65 1985-11-01;110.55 1985-11-04;110.45 1985-11-05;111.07 1985-11-06;111.31 1985-11-07;111.3 1985-11-08;111.94 1985-11-11;113.82 1985-11-12;114.33 1985-11-13;113.79 1985-11-14;114.82 1985-11-15;114.38 1985-11-18;114.53 1985-11-19;114.63 1985-11-20;114.78 1985-11-21;116.13 1985-11-22;116.25 1985-11-25;115.59 1985-11-26;115.75 1985-11-27;116.69 1985-11-29;116.53 1985-12-02;115.63 1985-12-03;115.88 1985-12-04;117.69 1985-12-05;117.56 1985-12-06;116.97 1985-12-09;117.63 1985-12-10;117.72 1985-12-11;118.81 1985-12-12;119.13 1985-12-13;120.81 1985-12-16;121.91 1985-12-17;121.16 1985-12-18;120.69 1985-12-19;120.75 1985-12-20;121.31 1985-12-23;120 1985-12-24;119.25 1985-12-26;119.53 1985-12-27;120.63 1985-12-30;121.19 1985-12-31;121.59 1986-01-02;120.74 1986-01-03;121.5 1986-01-06;121.38 1986-01-07;123.13 1986-01-08;120.19 1986-01-09;118.88 1986-01-10;118.81 1986-01-13;119.19 1986-01-14;119.19 1986-01-15;120.13 1986-01-16;120.63 1986-01-17;120.34 1986-01-20;119.88 1986-01-21;118.94 1986-01-22;117.75 1986-01-23;118.13 1986-01-24;119.31 1986-01-27;119.88 1986-01-28;121.09 1986-01-29;121.28 1986-01-30;120.88 1986-01-31;122.13 1986-02-03;123.28 1986-02-04;122.72 1986-02-05;122.75 1986-02-06;123.13 1986-02-07;123.69 1986-02-10;124.59 1986-02-11;124.53 1986-02-12;124.66 1986-02-13;125.41 1986-02-14;126.63 1986-02-18;128.09 1986-02-19;126.75 1986-02-20;128 1986-02-21;129.41 1986-02-24;129.19 1986-02-25;128.91 1986-02-26;129.06 1986-02-27;130.53 1986-02-28;130.75 1986-03-03;130.09 1986-03-04;129.75 1986-03-05;129.63 1986-03-06;130.13 1986-03-07;130.38 1986-03-10;130.88 1986-03-11;133.59 1986-03-12;134.16 1986-03-13;134.47 1986-03-14;136.16 1986-03-17;135.06 1986-03-18;135.69 1986-03-19;135.56 1986-03-20;136.13 1986-03-21;134.81 1986-03-24;135.53 1986-03-25;135.22 1986-03-26;136.69 1986-03-27;137.69 1986-03-31;137.69 1986-04-01;135.88 1986-04-02;136.09 1986-04-03;134.41 1986-04-04;132.28 1986-04-07;132.06 1986-04-08;134.72 1986-04-09;135.03 1986-04-10;136.41 1986-04-11;136.22 1986-04-14;136.91 1986-04-15;137.13 1986-04-16;139.59 1986-04-17;140.09 1986-04-18;139.88 1986-04-21;141.06 1986-04-22;139.88 1986-04-23;139.34 1986-04-24;139.47 1986-04-25;139.53 1986-04-28;139.81 1986-04-29;138.41 1986-04-30;135.75 1986-05-01;135.47 1986-05-02;135.38 1986-05-05;136.91 1986-05-06;136.75 1986-05-07;136.09 1986-05-08;136.75 1986-05-09;137.13 1986-05-12;136.91 1986-05-13;136.34 1986-05-14;136.91 1986-05-15;135.28 1986-05-16;134.44 1986-05-19;134.59 1986-05-20;136.06 1986-05-21;135.75 1986-05-22;138.16 1986-05-23;138.88 1986-05-27;140.69 1986-05-28;141.72 1986-05-29;142.38 1986-05-30;142.06 1986-06-02;140.88 1986-06-03;141.03 1986-06-04;140.19 1986-06-05;140.94 1986-06-06;140.97 1986-06-09;138.03 1986-06-10;137.69 1986-06-11;138.59 1986-06-12;138.81 1986-06-13;141 1986-06-16;141.16 1986-06-17;140.38 1986-06-18;140.63 1986-06-19;140.19 1986-06-20;141.63 1986-06-23;140.69 1986-06-24;141.72 1986-06-25;142.75 1986-06-26;142.66 1986-06-27;143.19 1986-06-30;143.97 1986-07-01;144.68 1986-07-02;145.15 1986-07-03;144.67 1986-07-07;140.43 1986-07-08;138.72 1986-07-09;139.55 1986-07-10;139.68 1986-07-11;139.51 1986-07-14;137.27 1986-07-15;134.91 1986-07-16;135.62 1986-07-17;136.2 1986-07-18;136.35 1986-07-21;136.25 1986-07-22;137.38 1986-07-23;137.67 1986-07-24;137.25 1986-07-25;138.41 1986-07-28;136.11 1986-07-29;135.19 1986-07-30;136.09 1986-07-31;135.89 1986-08-01;135.29 1986-08-04;135.65 1986-08-05;136.29 1986-08-06;136.19 1986-08-07;136.42 1986-08-08;136.41 1986-08-11;138.45 1986-08-12;140.02 1986-08-13;141.33 1986-08-14;141.79 1986-08-15;142.22 1986-08-18;142.32 1986-08-19;141.91 1986-08-20;143.64 1986-08-21;143.61 1986-08-22;143.88 1986-08-25;142.66 1986-08-26;145.16 1986-08-27;145.41 1986-08-28;145.24 1986-08-29;145.32 1986-09-02;143.12 1986-09-03;143.74 1986-09-04;145.75 1986-09-05;143.89 1986-09-08;142.42 1986-09-09;142.07 1986-09-10;141.62 1986-09-11;135.25 1986-09-12;132.81 1986-09-15;133.38 1986-09-16;133.21 1986-09-17;133.45 1986-09-18;133.65 1986-09-19;133.49 1986-09-22;135.05 1986-09-23;135.6 1986-09-24;136.06 1986-09-25;133.77 1986-09-26;133.94 1986-09-29;132.61 1986-09-30;133.44 1986-10-01;134.69 1986-10-02;134.89 1986-10-03;134.81 1986-10-06;135.32 1986-10-07;135.14 1986-10-08;136.29 1986-10-09;135.9 1986-10-10;135.7 1986-10-13;135.89 1986-10-14;135.55 1986-10-15;137.36 1986-10-16;137.82 1986-10-17;137.48 1986-10-20;136.02 1986-10-21;135.99 1986-10-22;136.18 1986-10-23;137.76 1986-10-24;137.28 1986-10-27;137.58 1986-10-28;137.89 1986-10-29;138.8 1986-10-30;140.26 1986-10-31;140.42 1986-11-03;141.37 1986-11-04;141.6 1986-11-05;141.91 1986-11-06;141.55 1986-11-07;141.5 1986-11-10;141.71 1986-11-11;142.14 1986-11-12;141.89 1986-11-13;140.03 1986-11-14;140.72 1986-11-17;139.9 1986-11-18;136.48 1986-11-19;136.62 1986-11-20;139.02 1986-11-21;140.94 1986-11-24;141.69 1986-11-25;142.05 1986-11-26;142.33 1986-11-28;142.57 1986-12-01;142.39 1986-12-02;145.09 1986-12-03;145.05 1986-12-04;144.68 1986-12-05;143.69 1986-12-08;143.59 1986-12-09;142.57 1986-12-10;143.46 1986-12-11;142.02 1986-12-12;141.53 1986-12-15;141.87 1986-12-16;142.87 1986-12-17;141.56 1986-12-18;141.1 1986-12-19;142.65 1986-12-22;142.02 1986-12-23;140.72 1986-12-24;141 1986-12-26;141.14 1986-12-29;139.89 1986-12-30;139.12 1986-12-31;138.58 1987-01-02;141.01 1987-01-05;144.39 1987-01-06;144.81 1987-01-07;146.43 1987-01-08;147.55 1987-01-09;148.39 1987-01-12;149.31 1987-01-13;149.14 1987-01-14;150.58 1987-01-15;152.09 1987-01-16;152.19 1987-01-19;153.71 1987-01-20;153.62 1987-01-21;152.9 1987-01-22;155.97 1987-01-23;154.02 1987-01-26;153.63 1987-01-27;155.85 1987-01-28;156.72 1987-01-29;156.19 1987-01-30;156.11 1987-02-02;157.45 1987-02-03;157.28 1987-02-04;159.31 1987-02-05;160.36 1987-02-06;159.93 1987-02-09;158.83 1987-02-10;157.18 1987-02-11;158.47 1987-02-12;157.58 1987-02-13;159.56 1987-02-17;162.48 1987-02-18;162.56 1987-02-19;162.76 1987-02-20;162.82 1987-02-23;161.12 1987-02-24;161.38 1987-02-25;161.97 1987-02-26;161.41 1987-02-27;162.01 1987-03-02;161.59 1987-03-03;162.16 1987-03-04;164.41 1987-03-05;165.41 1987-03-06;165.45 1987-03-09;164.25 1987-03-10;165.57 1987-03-11;165.39 1987-03-12;165.96 1987-03-13;165.31 1987-03-16;164.34 1987-03-17;166.41 1987-03-18;166.64 1987-03-19;167.28 1987-03-20;169.37 1987-03-23;170.83 1987-03-24;171.08 1987-03-25;170.5 1987-03-26;170.77 1987-03-27;168.37 1987-03-30;164.56 1987-03-31;165.89 1987-04-01;166.04 1987-04-02;166.76 1987-04-03;170.2 1987-04-06;170.96 1987-04-07;168.35 1987-04-08;168.51 1987-04-09;166.09 1987-04-10;165.72 1987-04-13;162.14 1987-04-14;158.31 1987-04-15;161.03 1987-04-16;162.59 1987-04-20;162.19 1987-04-21;165.5 1987-04-22;162.55 1987-04-23;162.23 1987-04-24;159.37 1987-04-27;159.27 1987-04-28;159.8 1987-04-29;160.94 1987-04-30;162.86 1987-05-01;162.64 1987-05-04;163.22 1987-05-05;166.34 1987-05-06;166.47 1987-05-07;166.13 1987-05-08;165.49 1987-05-11;164.69 1987-05-12;165.39 1987-05-13;165.7 1987-05-14;165.76 1987-05-15;162.25 1987-05-18;161.45 1987-05-19;157.93 1987-05-20;157.02 1987-05-21;158.07 1987-05-22;159.06 1987-05-26;162.72 1987-05-27;162.64 1987-05-28;163.61 1987-05-29;163.48 1987-06-01;163.48 1987-06-02;162.77 1987-06-03;165.27 1987-06-04;166.16 1987-06-05;165.49 1987-06-08;167.13 1987-06-09;167.38 1987-06-10;167.53 1987-06-11;168.24 1987-06-12;169.85 1987-06-15;170.6 1987-06-16;171.35 1987-06-17;171.44 1987-06-18;171.84 1987-06-19;172.53 1987-06-22;173.77 1987-06-23;173.22 1987-06-24;172.4 1987-06-25;173.55 1987-06-26;172.67 1987-06-29;172.99 1987-06-30;171.07 1987-07-01;170.52 1987-07-02;171.83 1987-07-06;171.55 1987-07-07;172.89 1987-07-08;173.42 1987-07-09;173.15 1987-07-10;173.57 1987-07-13;173.18 1987-07-14;174.67 1987-07-15;174.58 1987-07-16;175.7 1987-07-17;176.67 1987-07-20;175.08 1987-07-21;173.59 1987-07-22;173.45 1987-07-23;173.03 1987-07-24;173.7 1987-07-27;174.47 1987-07-28;175.24 1987-07-29;177 1987-07-30;178.32 1987-07-31;178.64 1987-08-03;178.07 1987-08-04;177.39 1987-08-05;178.54 1987-08-06;180.37 1987-08-07;180.87 1987-08-10;183.45 1987-08-11;186.13 1987-08-12;185.7 1987-08-13;186.95 1987-08-14;186.69 1987-08-17;186.76 1987-08-18;184.12 1987-08-19;184.36 1987-08-20;187.04 1987-08-21;187.51 1987-08-24;186.27 1987-08-25;187.99 1987-08-26;186.94 1987-08-27;185.26 1987-08-28;182.99 1987-08-31;184.46 1987-09-01;181.21 1987-09-02;180.12 1987-09-03;179.34 1987-09-04;177.58 1987-09-08;175.99 1987-09-09;175.79 1987-09-10;177.47 1987-09-11;180.02 1987-09-14;180.54 1987-09-15;177.98 1987-09-16;176.51 1987-09-17;176.48 1987-09-18;176.36 1987-09-21;174.25 1987-09-22;178.47 1987-09-23;179.93 1987-09-24;178.86 1987-09-25;179.14 1987-09-28;180.75 1987-09-29;180.06 1987-09-30;180.24 1987-10-01;182.97 1987-10-02;183.43 1987-10-05;183.44 1987-10-06;178.98 1987-10-07;178.55 1987-10-08;176.32 1987-10-09;174.64 1987-10-12;173.52 1987-10-13;176.02 1987-10-14;171.26 1987-10-15;167.45 1987-10-16;159.13 1987-10-19;128.62 1987-10-20;133.04 1987-10-21;145.02 1987-10-22;139.45 1987-10-23;139.22 1987-10-26;127.88 1987-10-27;130.51 1987-10-28;130.31 1987-10-29;136.28 1987-10-30;140.8 1987-11-02;142.74 1987-11-03;140.11 1987-11-04;139.11 1987-11-05;141.81 1987-11-06;140.04 1987-11-09;136.35 1987-11-10;134.06 1987-11-11;135.46 1987-11-12;138.88 1987-11-13;137.6 1987-11-16;138.16 1987-11-17;136.21 1987-11-18;137.58 1987-11-19;134.72 1987-11-20;135.56 1987-11-23;136.13 1987-11-24;137.93 1987-11-25;136.9 1987-11-27;135.16 1987-11-30;129.69 1987-12-01;130.5 1987-12-02;131.21 1987-12-03;127.01 1987-12-04;125.91 1987-12-07;128.23 1987-12-08;131.42 1987-12-09;133.56 1987-12-10;131.07 1987-12-11;131.79 1987-12-14;135.26 1987-12-15;135.61 1987-12-16;138.34 1987-12-17;136.02 1987-12-18;139.15 1987-12-21;139.49 1987-12-22;139.54 1987-12-23;141.36 1987-12-24;140.85 1987-12-28;137.5 1987-12-29;136.84 1987-12-30;138.52 1987-12-31;138.23 1988-01-04;142.9 1988-01-05;144.54 1988-01-06;144.82 1988-01-07;145.89 1988-01-08;137.03 1988-01-11;138.81 1988-01-12;137.74 1988-01-13;137.95 1988-01-14;137.97 1988-01-15;141.16 1988-01-18;141.24 1988-01-19;140.13 1988-01-20;136.72 1988-01-21;136.97 1988-01-22;138.69 1988-01-25;141.51 1988-01-26;140.26 1988-01-27;140.23 1988-01-28;142.22 1988-01-29;144.13 1988-02-01;143.33 1988-02-02;143.61 1988-02-03;141.97 1988-02-04;141.89 1988-02-05;141.35 1988-02-08;140.34 1988-02-09;141.63 1988-02-10;144.24 1988-02-11;143.99 1988-02-12;144.86 1988-02-16;145.96 1988-02-17;145.72 1988-02-18;145.14 1988-02-19;146.96 1988-02-22;148.96 1988-02-23;148.73 1988-02-24;148.54 1988-02-25;147.3 1988-02-26;147.7 1988-02-29;150.46 1988-03-01;150.18 1988-03-02;150.68 1988-03-03;150.7 1988-03-04;150.43 1988-03-07;150.53 1988-03-08;151.62 1988-03-09;151.48 1988-03-10;148.92 1988-03-11;149.45 1988-03-14;150.06 1988-03-15;149.99 1988-03-16;151.28 1988-03-17;152.68 1988-03-18;152.65 1988-03-21;151.47 1988-03-22;151.52 1988-03-23;151.82 1988-03-24;149 1988-03-27;146.58 1988-03-28;146.11 1988-03-29;147.22 1988-03-30;146.22 1988-03-31;146.6 1988-04-04;145.17 1988-04-05;146.29 1988-04-06;149.76 1988-04-07;150.28 1988-04-08;152.03 1988-04-11;152.47 1988-04-12;153.19 1988-04-13;153.2 1988-04-14;147.14 1988-04-15;147 1988-04-18;146.77 1988-04-19;146.17 1988-04-20;145.13 1988-04-21;145.24 1988-04-22;147.03 1988-04-25;148.21 1988-04-26;148.93 1988-04-27;148.94 1988-04-28;148.33 1988-04-29;147.87 1988-05-02;147.83 1988-05-03;148.57 1988-05-04;147.3 1988-05-05;146.51 1988-05-06;145.88 1988-05-09;145.28 1988-05-10;145.75 1988-05-11;143.48 1988-05-12;143.78 1988-05-13;145.3 1988-05-16;146.21 1988-05-17;144.65 1988-05-18;142.51 1988-05-19;143.01 1988-05-20;143.3 1988-05-23;142.21 1988-05-24;143.53 1988-05-25;143.77 1988-05-26;144.23 1988-05-27;143.66 1988-05-31;148.04 1988-06-01;150.34 1988-06-02;149.67 1988-06-03;150.31 1988-06-06;150.55 1988-06-07;149.68 1988-06-08;152.87 1988-06-09;152.36 1988-06-10;152.89 1988-06-13;153.02 1988-06-14;154.52 1988-06-15;154.67 1988-06-16;152.44 1988-06-17;152.84 1988-06-20;151.96 1988-06-21;153.29 1988-06-22;155.35 1988-06-23;155.03 1988-06-24;154.56 1988-06-27;152.22 1988-06-28;153.77 1988-06-29;153.13 1988-06-30;154.47 1988-07-01;153.68 1988-07-05;155.57 1988-07-06;153.76 1988-07-07;153.62 1988-07-08;152.81 1988-07-11;153.02 1988-07-12;151.62 1988-07-13;152.27 1988-07-14;152.76 1988-07-15;153.65 1988-07-18;152.83 1988-07-19;151.8 1988-07-20;152.56 1988-07-21;150.9 1988-07-22;149.25 1988-07-25;149.74 1988-07-26;150.03 1988-07-27;148.74 1988-07-28;150.4 1988-07-29;153.35 1988-08-01;153.52 1988-08-02;153.54 1988-08-03;154.03 1988-08-04;153.55 1988-08-05;153.09 1988-08-08;152.52 1988-08-09;150.66 1988-08-10;148.23 1988-08-11;148.6 1988-08-12;148.53 1988-08-15;146.58 1988-08-16;147.49 1988-08-17;147.64 1988-08-18;147.81 1988-08-19;147.54 1988-08-22;145.94 1988-08-23;145.94 1988-08-24;147.93 1988-08-25;146.94 1988-08-26;147.24 1988-08-29;148.55 1988-08-30;148.66 1988-08-31;148.29 1988-09-01;146.68 1988-09-02;149.66 1988-09-06;150.2 1988-09-07;150.38 1988-09-08;150.46 1988-09-09;150.84 1988-09-12;150.63 1988-09-13;151.15 1988-09-14;152.13 1988-09-15;151.6 1988-09-16;152.79 1988-09-19;151.92 1988-09-20;152.44 1988-09-21;152.64 1988-09-22;152.08 1988-09-23;152.38 1988-09-26;151.96 1988-09-27;151.64 1988-09-28;152.03 1988-09-29;153.78 1988-09-30;153.57 1988-10-03;153.23 1988-10-04;152.93 1988-10-05;153.62 1988-10-06;153.93 1988-10-07;156.81 1988-10-10;156.96 1988-10-11;156.77 1988-10-12;154.77 1988-10-13;155.34 1988-10-14;155.46 1988-10-17;155.87 1988-10-18;157.32 1988-10-19;156.18 1988-10-20;159.01 1988-10-21;159.42 1988-10-24;158.85 1988-10-25;158.87 1988-10-26;158.37 1988-10-27;156.17 1988-10-28;156.79 1988-10-31;156.94 1988-11-01;156.98 1988-11-02;157 1988-11-03;157.08 1988-11-04;155.7 1988-11-07;154.28 1988-11-08;154.84 1988-11-09;153.92 1988-11-10;154.09 1988-11-11;151.24 1988-11-14;151.04 1988-11-15;151.33 1988-11-16;148.96 1988-11-17;149.24 1988-11-18;150.18 1988-11-21;150.1 1988-11-22;150.55 1988-11-23;151.41 1988-11-25;150.63 1988-11-28;151.25 1988-11-29;152.43 1988-11-30;153.9 1988-12-01;153.37 1988-12-02;153.02 1988-12-05;154.48 1988-12-06;155.78 1988-12-07;156.14 1988-12-08;155.37 1988-12-09;155.59 1988-12-12;155.34 1988-12-13;155.24 1988-12-14;154.72 1988-12-15;154.17 1988-12-16;155.16 1988-12-19;156.38 1988-12-20;155.74 1988-12-21;155.73 1988-12-22;155.5 1988-12-23;156.06 1988-12-27;155.58 1988-12-28;155.81 1988-12-29;156.9 1988-12-30;156.26 1989-01-03;154.98 1989-01-04;157.06 1989-01-05;157.49 1989-01-06;157.96 1989-01-09;158.15 1989-01-10;157.85 1989-01-11;158.65 1989-01-12;159.26 1989-01-13;159.58 1989-01-16;159.78 1989-01-17;159.48 1989-01-18;161.01 1989-01-19;161.25 1989-01-20;161.16 1989-01-23;160.13 1989-01-24;161.99 1989-01-25;162.33 1989-01-26;163.6 1989-01-27;164.78 1989-01-30;165.36 1989-01-31;166.63 1989-02-01;166.47 1989-02-02;166.35 1989-02-03;166.5 1989-02-06;166.19 1989-02-07;168.02 1989-02-08;167.69 1989-02-09;166.13 1989-02-10;164.01 1989-02-13;164.15 1989-02-14;163.94 1989-02-15;165.21 1989-02-16;165.51 1989-02-17;166.45 1989-02-21;166.06 1989-02-22;163.55 1989-02-23;164.09 1989-02-24;161.72 1989-02-27;161.95 1989-02-28;162.49 1989-03-01;161.74 1989-03-02;163.21 1989-03-03;163.9 1989-03-06;165.63 1989-03-07;165.28 1989-03-08;165.45 1989-03-09;165.36 1989-03-10;164.85 1989-03-13;166 1989-03-14;165.93 1989-03-15;166.67 1989-03-16;168.1 1989-03-17;164.66 1989-03-20;163.13 1989-03-21;163.8 1989-03-22;163.41 1989-03-23;162.64 1989-03-27;163.32 1989-03-28;163.88 1989-03-29;164.25 1989-03-30;164.38 1989-03-31;165.63 1989-04-03;166.43 1989-04-04;165.95 1989-04-05;166.45 1989-04-06;166.02 1989-04-07;166.93 1989-04-10;166.89 1989-04-11;167.58 1989-04-12;167.54 1989-04-13;166.54 1989-04-14;168.89 1989-04-17;169.05 1989-04-18;171.13 1989-04-19;171.7 1989-04-20;171.3 1989-04-21;172.9 1989-04-24;172.49 1989-04-25;171.6 1989-04-26;171.75 1989-04-27;173.06 1989-04-28;173.13 1989-05-01;172.82 1989-05-02;172.37 1989-05-03;172.35 1989-05-04;172.21 1989-05-05;172.14 1989-05-08;171.26 1989-05-09;170.8 1989-05-10;171.13 1989-05-11;171.71 1989-05-12;175.13 1989-05-15;176.25 1989-05-16;175.92 1989-05-17;176.98 1989-05-18;177.29 1989-05-19;178.92 1989-05-22;179.35 1989-05-23;177.61 1989-05-24;177.97 1989-05-25;178.05 1989-05-26;179.31 1989-05-30;178.11 1989-05-31;178.85 1989-06-01;179.63 1989-06-02;181.49 1989-06-05;179.89 1989-06-06;180.93 1989-06-07;182.34 1989-06-08;182.39 1989-06-09;182.37 1989-06-12;182.12 1989-06-13;180.94 1989-06-14;180.83 1989-06-15;178.97 1989-06-16;179.59 1989-06-19;179.79 1989-06-20;179.49 1989-06-21;179.18 1989-06-22;180.05 1989-06-23;182.86 1989-06-26;182.2 1989-06-27;183.18 1989-06-28;181.87 1989-06-29;178.75 1989-06-30;177.9 1989-07-03;178.51 1989-07-05;179.25 1989-07-06;179.02 1989-07-07;181.56 1989-07-10;182.7 1989-07-11;183.62 1989-07-12;184.15 1989-07-13;184.31 1989-07-14;185.06 1989-07-17;185.37 1989-07-18;184.91 1989-07-19;187.1 1989-07-20;186.11 1989-07-21;187.15 1989-07-24;186.03 1989-07-25;186.1 1989-07-26;188.14 1989-07-27;190.22 1989-07-28;190.38 1989-07-30;192.41 1989-08-01;191.38 1989-08-02;191.78 1989-08-03;192.09 1989-08-04;191.64 1989-08-07;194.19 1989-08-08;194.23 1989-08-09;193.2 1989-08-10;193.97 1989-08-11;192.27 1989-08-14;191.37 1989-08-15;192.08 1989-08-16;192.64 1989-08-17;191.95 1989-08-18;192.64 1989-08-21;189.97 1989-08-22;190.11 1989-08-23;191.84 1989-08-24;195.29 1989-08-25;194.79 1989-08-28;195.45 1989-08-29;194.47 1989-08-30;194.91 1989-08-31;195.27 1989-09-01;196.37 1989-09-05;195.84 1989-09-06;194.18 1989-09-07;193.78 1989-09-08;193.95 1989-09-11;193.3 1989-09-12;193.29 1989-09-13;192.29 1989-09-14;190.95 1989-09-15;191.59 1989-09-18;192.43 1989-09-19;192.46 1989-09-20;192.45 1989-09-21;192.16 1989-09-22;192.73 1989-09-25;191.28 1989-09-26;191.47 1989-09-27;191.82 1989-09-28;193.55 1989-09-29;193.97 1989-10-02;194.9 1989-10-03;196.84 1989-10-04;197.98 1989-10-05;198.05 1989-10-06;198.94 1989-10-09;199.34 1989-10-10;199 1989-10-11;197.81 1989-10-12;196.98 1989-10-13;185.56 1989-10-16;189.76 1989-10-17;188.89 1989-10-18;189.32 1989-10-19;192.17 1989-10-20;192.12 1989-10-23;190.9 1989-10-24;190.05 1989-10-25;189.52 1989-10-26;187.22 1989-10-27;185.6 1989-10-30;185.59 1989-10-31;188.24 1989-11-01;188.84 1989-11-02;187.64 1989-11-03;187.28 1989-11-06;184.77 1989-11-07;185.74 1989-11-08;187.48 1989-11-09;185.75 1989-11-10;187.9 1989-11-13;188.22 1989-11-14;187.51 1989-11-15;188.76 1989-11-16;188.75 1989-11-17;189.28 1989-11-20;188.03 1989-11-21;188.05 1989-11-22;189.21 1989-11-24;190.29 1989-11-27;191.13 1989-11-28;191.34 1989-11-29;190.25 1989-11-30;191.3 1989-12-01;193.66 1989-12-04;194.07 1989-12-05;193.19 1989-12-06;192.82 1989-12-07;192.38 1989-12-08;192.92 1989-12-11;192.83 1989-12-12;194.44 1989-12-13;195.01 1989-12-14;193.01 1989-12-15;193.45 1989-12-18;190.17 1989-12-19;189.4 1989-12-20;189.54 1989-12-21;190.5 1989-12-22;191.95 1989-12-26;191.72 1989-12-27;192.69 1989-12-28;193.59 1989-12-29;195.04 1990-01-02;198 1990-01-03;197.8 1990-01-04;196.29 1990-01-05;194.64 1990-01-08;195.33 1990-01-09;193.35 1990-01-10;192.12 1990-01-11;192.78 1990-01-12;188.32 1990-01-15;186.71 1990-01-16;188.37 1990-01-17;186.86 1990-01-18;187.07 1990-01-19;187.56 1990-01-22;183.2 1990-01-23;183.6 1990-01-24;182.64 1990-01-25;180.61 1990-01-26;180.21 1990-01-29;179.73 1990-01-30;178.43 1990-01-31;181.5 1990-02-01;181.52 1990-02-02;182.75 1990-02-05;183.35 1990-02-06;182.33 1990-02-07;184.31 1990-02-08;184.09 1990-02-09;184.39 1990-02-12;182.55 1990-02-13;182.85 1990-02-14;183.21 1990-02-15;184.7 1990-02-16;183.75 1990-02-20;181.37 1990-02-21;181.07 1990-02-22;180.28 1990-02-23;179.35 1990-02-26;181.26 1990-02-27;182.16 1990-02-28;183.07 1990-03-01;183.52 1990-03-02;184.97 1990-03-05;184.15 1990-03-06;186.17 1990-03-07;185.77 1990-03-08;187.35 1990-03-09;186.18 1990-03-12;186.51 1990-03-13;185.25 1990-03-14;185.68 1990-03-15;186.2 1990-03-16;187.92 1990-03-19;188.66 1990-03-20;187.71 1990-03-21;186.82 1990-03-22;184.7 1990-03-23;185.45 1990-03-26;185.6 1990-03-27;187.4 1990-03-28;187.77 1990-03-29;187.17 1990-03-30;186.85 1990-04-02;186.08 1990-04-03;188.55 1990-04-04;187.31 1990-04-05;187.15 1990-04-06;186.78 1990-04-09;187.35 1990-04-10;187.63 1990-04-11;187.57 1990-04-12;188.8 1990-04-16;188.94 1990-04-17;188.91 1990-04-18;186.93 1990-04-19;185.57 1990-04-20;184.06 1990-04-23;181.93 1990-04-24;181.51 1990-04-25;182.3 1990-04-26;182.66 1990-04-27;180.74 1990-04-30;181.49 1990-05-01;182.22 1990-05-02;183.34 1990-05-03;183.97 1990-05-04;185.38 1990-05-07;186.45 1990-05-08;187.11 1990-05-09;187.49 1990-05-10;188.14 1990-05-11;192.24 1990-05-14;193.65 1990-05-15;193.31 1990-05-16;193.14 1990-05-17;193.49 1990-05-18;193.55 1990-05-21;195.28 1990-05-22;195.58 1990-05-23;195.85 1990-05-24;195.47 1990-05-25;193.71 1990-05-29;196.57 1990-05-30;196.75 1990-05-31;196.94 1990-06-01;198.03 1990-06-04;200.21 1990-06-05;199.93 1990-06-06;199.15 1990-06-07;198.21 1990-06-08;196.05 1990-06-11;197.42 1990-06-12;199.66 1990-06-13;199 1990-06-14;197.98 1990-06-15;197.86 1990-06-18;194.93 1990-06-19;195.61 1990-06-20;195.84 1990-06-21;196.49 1990-06-22;194.24 1990-06-25;192.6 1990-06-26;192.47 1990-06-27;193.87 1990-06-28;195.18 1990-06-29;195.48 1990-07-02;196.22 1990-07-03;196.61 1990-07-05;194.45 1990-07-06;195.78 1990-07-09;196.23 1990-07-10;194.76 1990-07-11;197.11 1990-07-12;199.32 1990-07-13;200.33 1990-07-16;201.13 1990-07-17;200.49 1990-07-18;199.83 1990-07-19;199.38 1990-07-20;197.65 1990-07-23;194.22 1990-07-24;194.45 1990-07-25;195.1 1990-07-26;194.55 1990-07-27;193.32 1990-07-30;194.18 1990-07-31;194.6 1990-08-01;194.38 1990-08-02;192.36 1990-08-03;188.82 1990-08-06;183.32 1990-08-07;183.45 1990-08-08;185.4 1990-08-09;186.24 1990-08-10;184.15 1990-08-13;185.63 1990-08-14;186.1 1990-08-15;186.54 1990-08-16;182.73 1990-08-17;180.19 1990-08-20;180.42 1990-08-21;176.94 1990-08-22;174.22 1990-08-23;168.88 1990-08-24;171.05 1990-08-27;176.18 1990-08-28;176.26 1990-08-29;177.78 1990-08-30;175.23 1990-08-31;176.97 1990-09-04;177.13 1990-09-05;177.93 1990-09-06;176.06 1990-09-07;177.51 1990-09-10;176.7 1990-09-11;176.39 1990-09-12;177.09 1990-09-13;175.16 1990-09-14;174.15 1990-09-17;174.62 1990-09-18;174.88 1990-09-19;173.91 1990-09-20;171.22 1990-09-21;171.03 1990-09-24;167.51 1990-09-25;169.2 1990-09-26;167.52 1990-09-27;165.36 1990-09-28;167.85 1990-10-01;172.22 1990-10-02;172.59 1990-10-03;170.8 1990-10-04;171.33 1990-10-05;170.7 1990-10-08;171.65 1990-10-09;167.41 1990-10-10;164.97 1990-10-11;162.2 1990-10-12;164.42 1990-10-15;165.84 1990-10-16;163.64 1990-10-17;163.59 1990-10-18;167.05 1990-10-19;170.4 1990-10-22;171.52 1990-10-23;170.5 1990-10-24;170.6 1990-10-25;169.51 1990-10-26;166.71 1990-10-29;165.24 1990-10-30;166.08 1990-10-31;166.17 1990-11-01;167.59 1990-11-02;170.07 1990-11-05;171.49 1990-11-06;170.21 1990-11-07;167.47 1990-11-08;168.14 1990-11-09;171.17 1990-11-12;174.07 1990-11-13;173.31 1990-11-14;174.68 1990-11-15;173.12 1990-11-16;173.3 1990-11-19;174.34 1990-11-20;172.48 1990-11-21;172.73 1990-11-23;172.39 1990-11-26;172.96 1990-11-27;173.87 1990-11-28;173.91 1990-11-29;173.14 1990-11-30;176.06 1990-12-03;177.07 1990-12-04;178.19 1990-12-05;180.11 1990-12-06;179.71 1990-12-07;179.07 1990-12-10;179.58 1990-12-11;178.42 1990-12-12;180.25 1990-12-13;180.06 1990-12-14;178.71 1990-12-17;178.22 1990-12-18;180.19 1990-12-19;180.35 1990-12-20;180.32 1990-12-21;180.87 1990-12-24;180.01 1990-12-26;180.6 1990-12-27;179.48 1990-12-28;179.65 1990-12-31;180.49 1991-01-02;178.62 1991-01-03;176.41 1991-01-04;175.95 1991-01-07;173.07 1991-01-08;172.61 1991-01-09;170.97 1991-01-10;172.43 1991-01-11;172.78 1991-01-14;171.21 1991-01-15;171.7 1991-01-16;173 1991-01-17;178.98 1991-01-18;180.87 1991-01-21;180.38 1991-01-22;179.2 1991-01-23;180.16 1991-01-24;182.64 1991-01-25;183.38 1991-01-28;183.47 1991-01-29;183.37 1991-01-30;186.02 1991-01-31;187.59 1991-02-01;187.4 1991-02-04;190.28 1991-02-05;191.89 1991-02-06;195.38 1991-02-07;194.74 1991-02-08;196.1 1991-02-11;200.85 1991-02-12;199.43 1991-02-13;201.18 1991-02-14;198.92 1991-02-15;201.29 1991-02-19;201.4 1991-02-20;199.26 1991-02-21;199.27 1991-02-22;199.65 1991-02-25;200.5 1991-02-26;198.22 1991-02-27;200.74 1991-02-28;200.7 1991-03-01;202.39 1991-03-04;202.08 1991-03-05;205.74 1991-03-06;205.53 1991-03-07;205.36 1991-03-08;204.95 1991-03-11;204.04 1991-03-12;202.49 1991-03-13;204.6 1991-03-14;204.28 1991-03-15;204.08 1991-03-18;203.31 1991-03-19;200.66 1991-03-20;201.31 1991-03-21;200.79 1991-03-22;201.13 1991-03-25;202.39 1991-03-26;205.55 1991-03-27;205.32 1991-03-28;205.3 1991-04-01;203.41 1991-04-02;207.42 1991-04-03;207.4 1991-04-04;207.73 1991-04-05;205.66 1991-04-08;207.17 1991-04-09;204.74 1991-04-10;204.42 1991-04-11;206.64 1991-04-12;208.08 1991-04-15;208.59 1991-04-16;211.71 1991-04-17;213.21 1991-04-18;212.26 1991-04-19;210.23 1991-04-22;208.39 1991-04-23;208.68 1991-04-24;209.17 1991-04-25;207.5 1991-04-26;207.27 1991-04-29;204.62 1991-04-30;205.37 1991-05-01;208.03 1991-05-02;208.26 1991-05-03;208.4 1991-05-06;207.99 1991-05-07;206.65 1991-05-08;207.13 1991-05-09;209.48 1991-05-10;205.87 1991-05-13;206.28 1991-05-14;203.67 1991-05-15;202.1 1991-05-16;204.04 1991-05-17;204.15 1991-05-20;204.07 1991-05-21;205.6 1991-05-22;205.94 1991-05-23;205.45 1991-05-24;206.66 1991-05-28;208.87 1991-05-29;209.39 1991-05-30;211.5 1991-05-31;212.99 1991-06-03;212.18 1991-06-04;212.05 1991-06-05;210.88 1991-06-06;210.24 1991-06-07;208.19 1991-06-10;207.74 1991-06-11;208.83 1991-06-12;206.58 1991-06-13;207.08 1991-06-14;209.34 1991-06-17;208.38 1991-06-18;207.63 1991-06-19;205.78 1991-06-20;205.87 1991-06-21;206.87 1991-06-24;203.5 1991-06-25;203.21 1991-06-26;203.54 1991-06-27;204.94 1991-06-28;203.47 1991-07-01;206.67 1991-07-02;206.52 1991-07-03;204.47 1991-07-05;204.92 1991-07-08;206.73 1991-07-09;205.98 1991-07-10;205.87 1991-07-11;206.54 1991-07-12;208.16 1991-07-15;209.39 1991-07-16;209.12 1991-07-17;209.09 1991-07-18;211.09 1991-07-19;210.63 1991-07-22;209.95 1991-07-23;208.22 1991-07-24;207.69 1991-07-25;208.78 1991-07-26;208.78 1991-07-29;209.85 1991-07-30;211.64 1991-07-31;212.34 1991-08-01;211.97 1991-08-02;212.03 1991-08-05;210.99 1991-08-06;213.71 1991-08-07;213.75 1991-08-08;213.23 1991-08-09;212.17 1991-08-12;212.53 1991-08-13;213.36 1991-08-14;213.63 1991-08-15;213.38 1991-08-16;211.62 1991-08-19;206.84 1991-08-20;208.27 1991-08-21;213.89 1991-08-22;214.34 1991-08-23;215.75 1991-08-26;215.61 1991-08-27;215.26 1991-08-28;217.17 1991-08-29;217.12 1991-08-30;216.69 1991-09-03;215.13 1991-09-04;213.95 1991-09-05;213.47 1991-09-06;213.51 1991-09-09;213.14 1991-09-10;211 1991-09-11;211.21 1991-09-12;212.42 1991-09-13;210.58 1991-09-16;211.65 1991-09-17;211.54 1991-09-18;212.23 1991-09-19;212.74 1991-09-20;212.98 1991-09-23;212.02 1991-09-24;212.9 1991-09-25;212.53 1991-09-26;212.44 1991-09-27;212.21 1991-09-30;213.34 1991-10-01;214.01 1991-10-02;213.6 1991-10-03;211.73 1991-10-04;210.22 1991-10-07;209.16 1991-10-08;209.79 1991-10-09;207.95 1991-10-10;209.55 1991-10-11;210.07 1991-10-14;212.57 1991-10-15;214.9 1991-10-16;216.05 1991-10-17;215.8 1991-10-18;216.15 1991-10-21;214.88 1991-10-22;213.87 1991-10-23;213.81 1991-10-24;212.32 1991-10-25;211.82 1991-10-28;214.44 1991-10-29;215.58 1991-10-30;216.48 1991-10-31;216.54 1991-11-01;216.01 1991-11-04;215.43 1991-11-05;214.68 1991-11-06;215.3 1991-11-07;217.14 1991-11-08;216.82 1991-11-11;217.07 1991-11-12;219 1991-11-13;219.37 1991-11-14;219.22 1991-11-15;211.92 1991-11-18;213.03 1991-11-19;209.91 1991-11-20;209.43 1991-11-21;210.21 1991-11-22;208.16 1991-11-25;207.57 1991-11-26;208.77 1991-11-27;208.22 1991-11-29;207.75 1991-12-02;210.65 1991-12-03;210.55 1991-12-04;210.13 1991-12-05;208.96 1991-12-06;209.74 1991-12-09;209.21 1991-12-10;208.86 1991-12-11;208.53 1991-12-12;210.44 1991-12-13;211.9 1991-12-16;212.08 1991-12-17;211.21 1991-12-18;211.44 1991-12-19;210.91 1991-12-20;213.13 1991-12-23;218.13 1991-12-24;219.65 1991-12-26;222.61 1991-12-27;223.75 1991-12-30;228.22 1991-12-31;229.44 1992-01-02;229.17 1992-01-03;230.35 1992-01-06;229.85 1992-01-07;229.69 1992-01-08;230.23 1992-01-09;230.23 1992-01-10;228.95 1992-01-13;228.47 1992-01-14;231.57 1992-01-15;231.84 1992-01-16;230.55 1992-01-17;230.89 1992-01-20;229.67 1992-01-21;227.64 1992-01-22;230.19 1992-01-23;228.89 1992-01-24;229.17 1992-01-27;228.94 1992-01-28;228.95 1992-01-29;226.64 1992-01-30;227.37 1992-01-31;226.2 1992-02-03;226.61 1992-02-04;228.79 1992-02-05;228.87 1992-02-06;228.96 1992-02-07;227.65 1992-02-10;228.93 1992-02-11;228.94 1992-02-12;230.54 1992-02-13;228.73 1992-02-14;228.16 1992-02-18;225.65 1992-02-19;225.85 1992-02-20;228.6 1992-02-21;227.46 1992-02-24;227.62 1992-02-25;226.68 1992-02-26;229.23 1992-02-27;228.75 1992-02-28;228.21 1992-03-02;228.2 1992-03-03;228.43 1992-03-04;226.66 1992-03-05;224.92 1992-03-06;223.79 1992-03-09;224.15 1992-03-10;225.02 1992-03-11;223.55 1992-03-12;223.3 1992-03-13;224.3 1992-03-16;224.44 1992-03-17;226.01 1992-03-18;225.94 1992-03-19;226.25 1992-03-20;226.96 1992-03-23;226.39 1992-03-24;225.89 1992-03-25;225.39 1992-03-26;225.49 1992-03-27;223.31 1992-03-30;222.99 1992-03-31;223.25 1992-04-01;223.42 1992-04-02;221.51 1992-04-03;221.86 1992-04-06;223.79 1992-04-07;220 1992-04-08;217.92 1992-04-09;221.1 1992-04-10;223.27 1992-04-13;224.16 1992-04-14;227.31 1992-04-15;229.15 1992-04-16;228.9 1992-04-20;225.77 1992-04-21;225.7 1992-04-22;225.42 1992-04-23;226.16 1992-04-24;225.12 1992-04-27;224.94 1992-04-28;225.12 1992-04-29;226.58 1992-04-30;228.3 1992-05-01;227.2 1992-05-04;229.42 1992-05-05;229.5 1992-05-06;229.56 1992-05-07;229.08 1992-05-08;230.33 1992-05-11;230.47 1992-05-12;229.45 1992-05-13;229.44 1992-05-14;227.72 1992-05-15;226.31 1992-05-18;227.59 1992-05-19;229.32 1992-05-20;228.94 1992-05-21;227.47 1992-05-22;228.2 1992-05-26;226.86 1992-05-27;227.15 1992-05-28;229.24 1992-05-29;228.87 1992-06-01;229.9 1992-06-02;228.2 1992-06-03;228.65 1992-06-04;227.9 1992-06-05;227.88 1992-06-08;227.71 1992-06-09;225.95 1992-06-10;224.36 1992-06-11;225.1 1992-06-12;225.51 1992-06-15;225.62 1992-06-16;224.72 1992-06-17;221.45 1992-06-18;220.61 1992-06-19;221.96 1992-06-22;221.56 1992-06-23;221.99 1992-06-24;221.81 1992-06-25;221.53 1992-06-26;221.68 1992-06-29;224.44 1992-06-30;224.33 1992-07-01;226.75 1992-07-02;226.41 1992-07-06;227.44 1992-07-07;225.15 1992-07-08;225.49 1992-07-09;227.55 1992-07-10;227.88 1992-07-13;228.04 1992-07-14;229.51 1992-07-15;229.2 1992-07-16;229.49 1992-07-17;228.51 1992-07-20;227.51 1992-07-21;227.47 1992-07-22;226.13 1992-07-23;226.66 1992-07-24;226.48 1992-07-27;226.5 1992-07-28;229.54 1992-07-29;231.95 1992-07-30;232.89 1992-07-31;233.15 1992-08-03;233.66 1992-08-04;233.39 1992-08-05;232.29 1992-08-06;231.5 1992-08-07;230.79 1992-08-10;230.86 1992-08-11;230.61 1992-08-12;229.99 1992-08-13;229.95 1992-08-14;231.06 1992-08-17;231.6 1992-08-18;231.9 1992-08-19;230.41 1992-08-20;230.38 1992-08-21;228.61 1992-08-24;226.34 1992-08-25;226.47 1992-08-26;227.48 1992-08-27;227.73 1992-08-28;228.43 1992-08-31;228.03 1992-09-01;229.02 1992-09-02;230.01 1992-09-03;230.12 1992-09-04;229.75 1992-09-08;228.37 1992-09-09;229.1 1992-09-10;230.78 1992-09-11;230.8 1992-09-14;233.73 1992-09-15;231.04 1992-09-16;231.07 1992-09-17;230.97 1992-09-18;232.39 1992-09-21;231.89 1992-09-22;229.48 1992-09-23;229.42 1992-09-24;229.98 1992-09-25;227.73 1992-09-28;228.7 1992-09-29;228.9 1992-09-30;229.46 1992-10-01;228.73 1992-10-02;225.81 1992-10-05;224.14 1992-10-06;224.09 1992-10-07;222.84 1992-10-08;224.62 1992-10-09;222.11 1992-10-12;224.28 1992-10-13;225.31 1992-10-14;225.39 1992-10-15;225.54 1992-10-16;226.44 1992-10-19;228.24 1992-10-20;228.58 1992-10-21;228.6 1992-10-22;228.1 1992-10-23;227.83 1992-10-26;229.78 1992-10-27;230.01 1992-10-28;230.91 1992-10-29;231.42 1992-10-30;230.57 1992-11-02;232.48 1992-11-03;231.24 1992-11-04;229.79 1992-11-05;230.37 1992-11-06;230.09 1992-11-09;230.63 1992-11-10;230.66 1992-11-11;232.58 1992-11-12;232.83 1992-11-13;232.64 1992-11-16;231.78 1992-11-17;231.09 1992-11-18;232.87 1992-11-19;233.25 1992-11-20;234.78 1992-11-23;234.11 1992-11-24;235.27 1992-11-25;236.13 1992-11-27;236.72 1992-11-30;237.45 1992-12-01;237.2 1992-12-02;236.74 1992-12-03;236.76 1992-12-04;237.77 1992-12-07;239.36 1992-12-08;240.24 1992-12-09;239.44 1992-12-10;238.97 1992-12-11;238.63 1992-12-14;238.16 1992-12-15;238.02 1992-12-16;237.26 1992-12-17;239.12 1992-12-18;242.08 1992-12-21;241.72 1992-12-22;241.68 1992-12-23;241 1992-12-24;241.23 1992-12-28;241.01 1992-12-29;240.66 1992-12-30;241.16 1992-12-31;240.21 1993-01-04;239.88 1993-01-05;239.25 1993-01-06;239.15 1993-01-07;237.26 1993-01-08;236.21 1993-01-11;237.09 1993-01-12;237.2 1993-01-13;238.12 1993-01-14;239.6 1993-01-15;240.47 1993-01-18;240.33 1993-01-19;239.66 1993-01-20;238.89 1993-01-21;239.82 1993-01-22;240.41 1993-01-25;242.47 1993-01-26;242.53 1993-01-27;241.45 1993-01-28;241.7 1993-01-29;241.92 1993-02-01;243.81 1993-02-02;243.98 1993-02-03;246.45 1993-02-04;247.98 1993-02-05;247.6 1993-02-08;247.07 1993-02-09;245.54 1993-02-10;245.93 1993-02-11;246.72 1993-02-12;245.3 1993-02-16;239.49 1993-02-17;238.74 1993-02-18;238.08 1993-02-19;239.27 1993-02-22;239.52 1993-02-23;239.37 1993-02-24;242.5 1993-02-25;243.38 1993-02-26;244.08 1993-03-01;243.76 1993-03-02;246.54 1993-03-03;247.41 1993-03-04;246.53 1993-03-05;245.99 1993-03-08;250.15 1993-03-09;250.21 1993-03-10;251.36 1993-03-11;250.2 1993-03-12;248.16 1993-03-15;248.97 1993-03-16;248.81 1993-03-17;247.33 1993-03-18;249.12 1993-03-19;248.18 1993-03-22;247.34 1993-03-23;247.26 1993-03-24;246.91 1993-03-25;248.33 1993-03-26;247.07 1993-03-29;248.48 1993-03-30;249.18 1993-03-31;249.42 1993-04-01;248.74 1993-04-02;244.19 1993-04-05;244.4 1993-04-06;243.62 1993-04-07;244.32 1993-04-08;243.84 1993-04-12;246.91 1993-04-13;247.85 1993-04-14;247.73 1993-04-15;247.39 1993-04-16;247.74 1993-04-19;247.02 1993-04-20;245.72 1993-04-21;245.07 1993-04-22;243.08 1993-04-23;241.85 1993-04-26;239.91 1993-04-27;241.93 1993-04-28;241.9 1993-04-29;242.48 1993-04-30;243.46 1993-05-03;244.54 1993-05-04;245.23 1993-05-05;245.72 1993-05-06;245.22 1993-05-07;244.68 1993-05-10;245.03 1993-05-11;245.88 1993-05-12;246.06 1993-05-13;243.27 1993-05-14;243.34 1993-05-17;243.58 1993-05-18;243.53 1993-05-19;246.86 1993-05-20;248.42 1993-05-21;246.27 1993-05-24;247.07 1993-05-25;247.7 1993-05-26;249.9 1993-05-27;249.43 1993-05-28;248.6 1993-06-01;250.28 1993-06-02;250.27 1993-06-03;249.59 1993-06-04;248.22 1993-06-07;246.8 1993-06-08;245.15 1993-06-09;245.77 1993-06-10;245.53 1993-06-11;246.24 1993-06-14;246.42 1993-06-15;245.92 1993-06-16;246.6 1993-06-17;247.21 1993-06-18;244.94 1993-06-21;246.19 1993-06-22;246.09 1993-06-23;244.92 1993-06-24;246.6 1993-06-25;247.2 1993-06-28;249.52 1993-06-29;249.06 1993-06-30;249.1 1993-07-01;248.64 1993-07-02;247.12 1993-07-06;245.07 1993-07-07;245.68 1993-07-08;248.33 1993-07-09;248.19 1993-07-12;248.64 1993-07-13;248.38 1993-07-14;249.35 1993-07-15;248.96 1993-07-16;247.45 1993-07-19;247.33 1993-07-20;247.71 1993-07-21;247.6 1993-07-22;246.26 1993-07-23;247.46 1993-07-26;248.68 1993-07-27;248.34 1993-07-28;247.86 1993-07-29;249.34 1993-07-30;248.49 1993-08-02;249.53 1993-08-03;249.25 1993-08-04;248.93 1993-08-05;248.54 1993-08-06;248.91 1993-08-09;250.08 1993-08-10;249.63 1993-08-11;249.99 1993-08-12;249.17 1993-08-13;249.7 1993-08-16;250.56 1993-08-17;251.27 1993-08-18;252.87 1993-08-19;253.23 1993-08-20;253.25 1993-08-23;252.91 1993-08-24;255.15 1993-08-25;255.35 1993-08-26;255.83 1993-08-27;255.4 1993-08-30;256.04 1993-08-31;256.88 1993-09-01;256.88 1993-09-02;256.11 1993-09-03;256.22 1993-09-07;254.59 1993-09-08;253.16 1993-09-09;253.74 1993-09-10;255.93 1993-09-13;256.06 1993-09-14;254.97 1993-09-15;255.67 1993-09-16;254.94 1993-09-17;254.66 1993-09-20;252.77 1993-09-21;251.59 1993-09-22;253.27 1993-09-23;254.13 1993-09-24;254.18 1993-09-27;256.21 1993-09-28;256.16 1993-09-29;255.6 1993-09-30;255.23 1993-10-01;256.29 1993-10-04;256.35 1993-10-05;256.4 1993-10-06;256.26 1993-10-07;255.44 1993-10-08;255.81 1993-10-11;256.3 1993-10-12;256.67 1993-10-13;256.75 1993-10-14;259.12 1993-10-15;260.48 1993-10-18;260 1993-10-19;258.56 1993-10-20;258.28 1993-10-21;257.91 1993-10-22;257.06 1993-10-25;257.33 1993-10-26;257.27 1993-10-27;257.46 1993-10-28;258.99 1993-10-29;259.38 1993-11-01;259.94 1993-11-02;259.47 1993-11-03;256.5 1993-11-04;253.47 1993-11-05;254.2 1993-11-08;254.72 1993-11-09;254.97 1993-11-10;256.57 1993-11-11;256.08 1993-11-12;257.57 1993-11-15;256.58 1993-11-16;257.8 1993-11-17;256.81 1993-11-18;256.2 1993-11-19;255.53 1993-11-22;253.25 1993-11-23;254.24 1993-11-24;255.13 1993-11-26;255.61 1993-11-29;255.07 1993-11-30;254.79 1993-12-01;255.27 1993-12-02;255.84 1993-12-03;256.74 1993-12-06;257.65 1993-12-07;257.98 1993-12-08;257.97 1993-12-09;257 1993-12-10;256.93 1993-12-13;257.59 1993-12-14;256.19 1993-12-15;255.43 1993-12-16;256.15 1993-12-17;257.79 1993-12-20;257.59 1993-12-21;257.14 1993-12-22;258.15 1993-12-23;258.49 1993-12-27;260.07 1993-12-28;260.5 1993-12-29;260.67 1993-12-30;259.77 1993-12-31;259.08 1994-01-03;258.27 1994-01-04;258.87 1994-01-05;259.31 1994-01-06;259 1994-01-07;260.34 1994-01-10;262.76 1994-01-11;262.26 1994-01-12;262.37 1994-01-13;261.73 1994-01-14;262.9 1994-01-17;262.31 1994-01-18;262.76 1994-01-19;262.95 1994-01-20;263.23 1994-01-21;263.12 1994-01-24;261.75 1994-01-25;261.13 1994-01-26;262.26 1994-01-27;264.38 1994-01-28;265.42 1994-01-31;267.1 1994-02-01;266.44 1994-02-02;267.71 1994-02-03;267.18 1994-02-04;261.21 1994-02-07;262.01 1994-02-08;261.96 1994-02-09;262.9 1994-02-10;261.04 1994-02-11;261.31 1994-02-14;261.26 1994-02-15;262.36 1994-02-16;262.55 1994-02-17;261.38 1994-02-18;259.87 1994-02-22;261.48 1994-02-23;261.13 1994-02-24;257.75 1994-02-25;258.57 1994-02-28;259.23 1994-03-01;257.81 1994-03-02;257.47 1994-03-03;256.68 1994-03-04;257.7 1994-03-07;259.07 1994-03-08;258.48 1994-03-09;258.78 1994-03-10;257.22 1994-03-11;258.53 1994-03-14;259.01 1994-03-15;258.99 1994-03-16;260.34 1994-03-17;261.11 1994-03-18;261.35 1994-03-21;259.91 1994-03-22;260.24 1994-03-23;260.28 1994-03-24;257.96 1994-03-25;256.29 1994-03-28;255.5 1994-03-29;251.3 1994-03-30;247.34 1994-03-31;247.06 1994-04-04;243.14 1994-04-05;248.41 1994-04-06;248.66 1994-04-07;250.22 1994-04-08;248.29 1994-04-11;249.45 1994-04-12;248.35 1994-04-13;247.46 1994-04-14;247.56 1994-04-15;247.66 1994-04-18;245.7 1994-04-19;245.37 1994-04-20;244.66 1994-04-21;248.18 1994-04-22;247.95 1994-04-25;250.47 1994-04-26;250.41 1994-04-28;249.13 1994-04-29;250.36 1994-05-02;251.4 1994-05-03;251.36 1994-05-04;250.75 1994-05-05;250.49 1994-05-06;248.47 1994-05-09;245.33 1994-05-10;246.94 1994-05-11;244.51 1994-05-12;245.55 1994-05-13;245.76 1994-05-16;245.78 1994-05-17;248.13 1994-05-18;250.73 1994-05-19;252.16 1994-05-20;251.58 1994-05-23;250.78 1994-05-24;251.4 1994-05-25;252.06 1994-05-26;252.61 1994-05-27;252.79 1994-05-31;252.24 1994-06-01;252.85 1994-06-02;253.08 1994-06-03;254.34 1994-06-06;254.17 1994-06-07;253.7 1994-06-08;253.08 1994-06-09;253.09 1994-06-10;253.59 1994-06-13;253.76 1994-06-14;255.1 1994-06-15;254.14 1994-06-16;254.99 1994-06-17;253.29 1994-06-20;251.4 1994-06-21;249.1 1994-06-22;249.97 1994-06-23;248.29 1994-06-24;244.55 1994-06-27;246.45 1994-06-28;245.8 1994-06-29;246.72 1994-06-30;245.16 1994-07-01;246.34 1994-07-05;246.51 1994-07-06;246.54 1994-07-07;247.57 1994-07-08;248.11 1994-07-11;247.5 1994-07-12;247.47 1994-07-13;247.85 1994-07-14;250.56 1994-07-15;251.06 1994-07-18;251.44 1994-07-19;250.89 1994-07-20;249.7 1994-07-21;250.06 1994-07-22;250.24 1994-07-25;250.72 1994-07-26;250.24 1994-07-27;249.84 1994-07-28;250.6 1994-07-29;252.62 1994-08-01;254.05 1994-08-02;254.15 1994-08-03;254.58 1994-08-04;253.27 1994-08-05;252.5 1994-08-08;252.99 1994-08-09;252.96 1994-08-10;254.2 1994-08-11;253.31 1994-08-12;254.77 1994-08-15;254.52 1994-08-16;256.25 1994-08-17;256.4 1994-08-18;255.49 1994-08-19;255.81 1994-08-22;255.27 1994-08-23;256.44 1994-08-24;258.61 1994-08-25;258.18 1994-08-26;260.82 1994-08-29;261.28 1994-08-30;262.1 1994-08-31;261.99 1994-09-01;260.98 1994-09-02;259.93 1994-09-06;260.11 1994-09-07;259.78 1994-09-08;260.82 1994-09-09;258.38 1994-09-12;257.32 1994-09-13;257.84 1994-09-14;258.48 1994-09-15;261.42 1994-09-16;259.77 1994-09-19;259.63 1994-09-20;255.91 1994-09-21;254.71 1994-09-22;254.52 1994-09-23;253.81 1994-09-26;254.39 1994-09-27;254.87 1994-09-28;256.37 1994-09-29;255.15 1994-09-30;255.52 1994-10-03;254.94 1994-10-04;251.46 1994-10-05;250.36 1994-10-06;249.93 1994-10-07;251.33 1994-10-10;253.14 1994-10-11;256.38 1994-10-12;256.35 1994-10-13;257.43 1994-10-14;257.99 1994-10-17;257.96 1994-10-18;257.25 1994-10-19;258.32 1994-10-20;256.54 1994-10-21;255.59 1994-10-24;253.5 1994-10-25;253.51 1994-10-26;253.91 1994-10-27;255.57 1994-10-28;259.43 1994-10-31;258.69 1994-11-01;256.74 1994-11-02;255.98 1994-11-03;256.66 1994-11-04;254.21 1994-11-07;254.29 1994-11-08;255.28 1994-11-09;255.01 1994-11-10;254.35 1994-11-11;253.25 1994-11-14;254.84 1994-11-15;254.52 1994-11-16;254.71 1994-11-17;253.49 1994-11-18;252.3 1994-11-21;250.58 1994-11-22;246.32 1994-11-23;246.18 1994-11-25;247.6 1994-11-28;248.46 1994-11-29;248.9 1994-11-30;248.41 1994-12-01;246.04 1994-12-02;248.01 1994-12-05;248.08 1994-12-06;247.85 1994-12-07;246.85 1994-12-08;243.8 1994-12-09;244.17 1994-12-12;245.26 1994-12-13;245.72 1994-12-14;248.33 1994-12-15;248.96 1994-12-16;250.54 1994-12-19;250.04 1994-12-20;249.8 1994-12-21;250.94 1994-12-22;250.71 1994-12-23;250.95 1994-12-27;251.99 1994-12-28;251.29 1994-12-29;251.44 1994-12-30;250.94 1995-01-03;250.73 1995-01-04;251.46 1995-01-05;251.39 1995-01-06;251.59 1995-01-09;251.58 1995-01-10;251.69 1995-01-11;251.72 1995-01-12;251.72 1995-01-13;253.95 1995-01-16;255.81 1995-01-17;256.25 1995-01-18;255.97 1995-01-19;254.38 1995-01-20;253.38 1995-01-23;253.47 1995-01-24;253.7 1995-01-25;254.41 1995-01-26;254.92 1995-01-27;255.89 1995-01-30;254.9 1995-01-31;255.93 1995-02-01;256 1995-02-02;257.18 1995-02-03;260.44 1995-02-06;261.75 1995-02-07;261.64 1995-02-08;261.67 1995-02-09;261.21 1995-02-10;261.8 1995-02-13;261.85 1995-02-14;262.13 1995-02-15;263.19 1995-02-16;263.27 1995-02-17;261.83 1995-02-21;261.98 1995-02-22;263.04 1995-02-23;264.24 1995-02-24;264.86 1995-02-27;262.68 1995-02-28;264.65 1995-03-01;263.76 1995-03-02;263.36 1995-03-03;263.29 1995-03-06;263.11 1995-03-07;261.25 1995-03-08;261.6 1995-03-09;261.61 1995-03-10;264.83 1995-03-13;265.17 1995-03-14;266.53 1995-03-15;266.15 1995-03-16;267.92 1995-03-17;267.84 1995-03-20;268.05 1995-03-21;267.58 1995-03-22;267.8 1995-03-23;267.92 1995-03-24;270.5 1995-03-27;271.72 1995-03-28;271.92 1995-03-29;271.84 1995-03-30;271.83 1995-03-31;271.04 1995-04-03;271.49 1995-04-04;273.29 1995-04-05;273.48 1995-04-06;273.78 1995-04-07;273.73 1995-04-10;273.98 1995-04-11;273.29 1995-04-12;274.04 1995-04-13;275 1995-04-17;273.54 1995-04-18;273.03 1995-04-19;272.72 1995-04-20;273.09 1995-04-21;274.76 1995-04-24;276.84 1995-04-25;276.39 1995-04-26;276.49 1995-04-27;276.87 1995-04-28;277.31 1995-05-01;277.14 1995-05-02;277.43 1995-05-03;279.94 1995-05-04;279.91 1995-05-05;279.9 1995-05-08;281.68 1995-05-09;281.74 1995-05-10;282.41 1995-05-11;282.46 1995-05-12;282.9 1995-05-15;284.01 1995-05-16;284.27 1995-05-17;283.52 1995-05-18;279.8 1995-05-19;279.49 1995-05-22;281.52 1995-05-23;283.8 1995-05-24;283.98 1995-05-25;283.93 1995-05-26;281.58 1995-05-30;281.87 1995-05-31;286.44 1995-06-01;286.73 1995-06-02;286.53 1995-06-05;288.05 1995-06-06;288.23 1995-06-07;286.96 1995-06-08;286.45 1995-06-09;284.05 1995-06-12;285.56 1995-06-13;288.18 1995-06-14;288.35 1995-06-15;288.76 1995-06-16;289.96 1995-06-19;292.18 1995-06-20;291.76 1995-06-21;291.61 1995-06-22;294.93 1995-06-23;294.17 1995-06-26;291.48 1995-06-27;290.75 1995-06-28;291.68 1995-06-29;291.26 1995-06-30;291.84 1995-07-03;292.99 1995-07-05;293.21 1995-07-06;296.43 1995-07-07;297.71 1995-07-10;298.03 1995-07-11;297.19 1995-07-12;299.93 1995-07-13;299.79 1995-07-14;298.9 1995-07-17;300.01 1995-07-18;298.38 1995-07-19;294.91 1995-07-20;296.36 1995-07-21;296.67 1995-07-24;297.99 1995-07-25;299.92 1995-07-26;300.27 1995-07-27;302.13 1995-07-28;301.38 1995-07-31;301.32 1995-08-01;300.28 1995-08-02;300.16 1995-08-03;299.93 1995-08-04;299.91 1995-08-07;300.54 1995-08-08;300.59 1995-08-09;300.06 1995-08-10;299.25 1995-08-11;297.77 1995-08-14;299.75 1995-08-15;299.23 1995-08-16;299.84 1995-08-17;299.63 1995-08-18;299.79 1995-08-21;299.91 1995-08-22;300.16 1995-08-23;299.01 1995-08-24;299.35 1995-08-25;300.85 1995-08-28;300.69 1995-08-29;300.96 1995-08-30;301.4 1995-08-31;302 1995-09-01;303.23 1995-09-05;305.47 1995-09-06;306.39 1995-09-07;306.25 1995-09-08;307.39 1995-09-11;307.89 1995-09-12;309.34 1995-09-13;310.38 1995-09-14;312.75 1995-09-15;313 1995-09-18;312.56 1995-09-19;313.11 1995-09-20;314.33 1995-09-21;312.71 1995-09-22;311.88 1995-09-25;311.76 1995-09-26;311.82 1995-09-27;311.32 1995-09-28;313.29 1995-09-29;313.26 1995-10-02;312.08 1995-10-03;312.09 1995-10-04;311.74 1995-10-05;312.01 1995-10-06;312.38 1995-10-09;310.35 1995-10-10;309.41 1995-10-11;310.51 1995-10-12;312.37 1995-10-13;313.65 1995-10-16;312.99 1995-10-17;314.1 1995-10-18;314.29 1995-10-19;315.39 1995-10-20;313.83 1995-10-23;312.32 1995-10-24;312.9 1995-10-25;310.71 1995-10-26;307.56 1995-10-27;308.63 1995-10-30;310.14 1995-10-31;309.61 1995-11-01;311.02 1995-11-02;313.69 1995-11-03;314.27 1995-11-06;313.62 1995-11-07;312.99 1995-11-08;315.55 1995-11-09;315.97 1995-11-10;315.78 1995-11-13;315.63 1995-11-14;314.46 1995-11-15;316.47 1995-11-16;318.48 1995-11-17;320.12 1995-11-20;318.92 1995-11-21;320.23 1995-11-22;319.71 1995-11-24;320.4 1995-11-27;321.23 1995-11-28;322.99 1995-11-29;323.99 1995-11-30;323.59 1995-12-01;324.43 1995-12-04;327.6 1995-12-05;329.79 1995-12-06;330.83 1995-12-07;328.77 1995-12-08;329.02 1995-12-11;330.17 1995-12-12;329.8 1995-12-13;331.17 1995-12-14;329.1 1995-12-15;328.66 1995-12-18;323.66 1995-12-19;325.71 1995-12-20;323.61 1995-12-21;325.61 1995-12-22;326.35 1995-12-26;327.64 1995-12-27;328.13 1995-12-28;328.35 1995-12-29;329.51 1996-01-02;331.71 1996-01-03;332.63 1996-01-04;330.72 1996-01-05;330.18 1996-01-08;331.26 1996-01-09;327.48 1996-01-10;321.41 1996-01-11;323.28 1996-01-12;322.95 1996-01-15;322.29 1996-01-16;325.83 1996-01-17;325.29 1996-01-18;326.15 1996-01-19;327.86 1996-01-22;328.7 1996-01-23;328.53 1996-01-24;331.72 1996-01-25;330.55 1996-01-26;332.84 1996-01-29;334.2 1996-01-30;337.28 1996-01-31;340.03 1996-02-01;341.23 1996-02-02;340.09 1996-02-05;342.26 1996-02-06;344.68 1996-02-07;346.32 1996-02-08;349.15 1996-02-09;349.44 1996-02-12;351.7 1996-02-13;351.29 1996-02-14;349.35 1996-02-15;347.76 1996-02-16;346.19 1996-02-20;342.27 1996-02-21;345.66 1996-02-22;350.85 1996-02-23;350.94 1996-02-26;346.95 1996-02-27;345.59 1996-02-28;344.62 1996-02-29;342.8 1996-03-01;345.18 1996-03-04;348.87 1996-03-05;350.75 1996-03-06;349.48 1996-03-07;350.14 1996-03-08;339.74 1996-03-11;342.75 1996-03-12;341.39 1996-03-13;341.86 1996-03-14;343.4 1996-03-15;343.39 1996-03-18;348.78 1996-03-19;348.55 1996-03-20;348.2 1996-03-21;348.06 1996-03-22;348.77 1996-03-25;348.77 1996-03-26;350.03 1996-03-27;348.09 1996-03-28;348.28 1996-03-29;346.92 1996-04-01;350.94 1996-04-02;351.6 1996-04-03;351.81 1996-04-04;351.92 1996-04-08;345.65 1996-04-09;345.13 1996-04-10;340.93 1996-04-11;339.38 1996-04-12;342.41 1996-04-15;345.2 1996-04-16;346.28 1996-04-17;344.56 1996-04-18;345.39 1996-04-19;346.4 1996-04-22;347.82 1996-04-23;349.6 1996-04-24;348.96 1996-04-25;350.29 1996-04-26;350.82 1996-04-29;351.24 1996-04-30;351.24 1996-05-01;351.53 1996-05-02;346.21 1996-05-03;345.4 1996-05-06;344.74 1996-05-07;343.33 1996-05-08;345.98 1996-05-09;346.61 1996-05-10;350.02 1996-05-13;354.33 1996-05-14;356.52 1996-05-15;356.64 1996-05-16;356.41 1996-05-17;358.78 1996-05-20;361.09 1996-05-21;361.05 1996-05-22;363.69 1996-05-23;362.43 1996-05-24;363.74 1996-05-28;360.52 1996-05-29;358.44 1996-05-30;360.24 1996-05-31;358.83 1996-06-03;358.27 1996-06-04;360.8 1996-06-05;363.38 1996-06-06;361.1 1996-06-07;360.61 1996-06-10;360.17 1996-06-11;359.55 1996-06-12;358.68 1996-06-13;358.08 1996-06-14;357.2 1996-06-17;356.92 1996-06-18;355.58 1996-06-19;355.32 1996-06-20;354.96 1996-06-21;357.02 1996-06-24;358.01 1996-06-25;358.03 1996-06-26;355.87 1996-06-27;357.58 1996-06-28;359.2 1996-07-01;361.7 1996-07-02;361.01 1996-07-03;360.37 1996-07-05;353.24 1996-07-08;350.33 1996-07-09;351.57 1996-07-10;351.75 1996-07-11;346.64 1996-07-12;346.84 1996-07-15;338.67 1996-07-16;336.8 1996-07-17;340.1 1996-07-18;345.1 1996-07-19;342.91 1996-07-22;340.22 1996-07-23;337.14 1996-07-24;336.07 1996-07-25;338.37 1996-07-26;340.87 1996-07-29;338.64 1996-07-30;340.36 1996-07-31;342.7 1996-08-01;347.78 1996-08-02;353.87 1996-08-05;352.81 1996-08-06;353.65 1996-08-07;354.43 1996-08-08;353.91 1996-08-09;353.44 1996-08-12;355.13 1996-08-13;352.62 1996-08-14;353.64 1996-08-15;354.22 1996-08-16;355.96 1996-08-19;356.64 1996-08-20;356.61 1996-08-21;356.11 1996-08-22;358.72 1996-08-23;357.23 1996-08-26;355.89 1996-08-27;357.15 1996-08-28;356.79 1996-08-29;353.36 1996-08-30;350.99 1996-09-03;351.76 1996-09-04;352.37 1996-09-05;349.64 1996-09-06;352.67 1996-09-09;356.28 1996-09-10;356.49 1996-09-11;358 1996-09-12;359.73 1996-09-13;363.7 1996-09-16;365.42 1996-09-17;364.43 1996-09-18;363.44 1996-09-19;363.94 1996-09-20;365.77 1996-09-23;365.51 1996-09-24;365.23 1996-09-25;365.3 1996-09-26;365.99 1996-09-27;366.27 1996-09-30;367.33 1996-10-01;368.18 1996-10-02;370.54 1996-10-03;370.14 1996-10-04;374.16 1996-10-07;374.74 1996-10-08;373.51 1996-10-09;371.35 1996-10-10;370.35 1996-10-11;372.89 1996-10-14;374.23 1996-10-15;373.6 1996-10-16;374.53 1996-10-17;376.41 1996-10-18;378.32 1996-10-21;377.92 1996-10-22;376.22 1996-10-23;375.91 1996-10-24;373.78 1996-10-25;373.26 1996-10-28;370.98 1996-10-29;373.13 1996-10-30;372.72 1996-10-31;374.5 1996-11-01;373.68 1996-11-04;375.07 1996-11-05;378.43 1996-11-06;383.55 1996-11-07;384.91 1996-11-08;386.32 1996-11-11;386.83 1996-11-12;386.18 1996-11-13;386.91 1996-11-14;389.01 1996-11-15;390.02 1996-11-18;389.9 1996-11-19;391.8 1996-11-20;392.8 1996-11-21;392.25 1996-11-22;394.66 1996-11-25;398.86 1996-11-26;397.98 1996-11-27;397.48 1996-11-29;398.43 1996-12-02;398.14 1996-12-03;394.85 1996-12-04;393.23 1996-12-05;392.75 1996-12-06;390.15 1996-12-09;394.69 1996-12-10;393.9 1996-12-11;389.54 1996-12-12;384.29 1996-12-13;384.07 1996-12-16;380.85 1996-12-17;382.77 1996-12-18;385.17 1996-12-19;392.16 1996-12-20;394.11 1996-12-23;393.29 1996-12-24;395 1996-12-26;397.07 1996-12-27;398.1 1996-12-30;397.42 1996-12-31;392.3 1997-01-02;389.53 1997-01-03;394.06 1997-01-06;394.28 1997-01-07;396.9 1997-01-08;395.25 1997-01-09;398.58 1997-01-10;400.76 1997-01-13;400.71 1997-01-14;405.07 1997-01-15;405.04 1997-01-16;406.12 1997-01-17;409.31 1997-01-20;409.31 1997-01-21;411.57 1997-01-22;412.8 1997-01-23;409.15 1997-01-24;405.51 1997-01-27;402.78 1997-01-28;402.86 1997-01-29;406.09 1997-01-30;411.2 1997-01-31;411.98 1997-02-03;412.48 1997-02-04;413.34 1997-02-05;408.74 1997-02-06;409.89 1997-02-07;413.8 1997-02-10;412.35 1997-02-11;414.09 1997-02-12;419.88 1997-02-13;424.42 1997-02-14;423.48 1997-02-18;427.07 1997-02-19;425.57 1997-02-20;421.09 1997-02-21;421.01 1997-02-24;424.48 1997-02-25;425.53 1997-02-26;422.14 1997-02-27;417.89 1997-02-28;415.51 1997-03-03;417.34 1997-03-04;415.68 1997-03-05;420.67 1997-03-06;420.24 1997-03-07;423.83 1997-03-10;427.7 1997-03-11;427.06 1997-03-12;423.54 1997-03-13;415.87 1997-03-14;417.7 1997-03-17;418.37 1997-03-18;415.4 1997-03-19;413.59 1997-03-20;411.78 1997-03-21;412.8 1997-03-24;416 1997-03-25;415.41 1997-03-26;415.37 1997-03-27;407.43 1997-03-31;398.55 1997-04-01;399.8 1997-04-02;395.37 1997-04-03;394.4 1997-04-04;398.02 1997-04-07;400.68 1997-04-08;402.31 1997-04-09;400.29 1997-04-10;399.36 1997-04-11;389.47 1997-04-14;391.49 1997-04-15;397.62 1997-04-16;401.75 1997-04-17;400.65 1997-04-18;402.64 1997-04-21;399.4 1997-04-22;405.84 1997-04-23;404.71 1997-04-24;403.62 1997-04-25;400.38 1997-04-28;403.69 1997-04-29;413.62 1997-04-30;416.94 1997-05-01;415.71 1997-05-02;422.97 1997-05-05;431.43 1997-05-06;430.77 1997-05-07;424.95 1997-05-08;426.9 1997-05-09;429.23 1997-05-12;435.57 1997-05-13;433.97 1997-05-14;435.6 1997-05-15;437.65 1997-05-16;432.44 1997-05-19;434.14 1997-05-20;437.2 1997-05-21;436.21 1997-05-22;434.66 1997-05-23;440.28 1997-05-27;440.67 1997-05-28;439.66 1997-05-29;438.86 1997-05-30;441.78 1997-06-02;441.54 1997-06-03;442.36 1997-06-04;440.18 1997-06-05;441.64 1997-06-06;448.13 1997-06-09;450.17 1997-06-10;451.76 1997-06-11;453.5 1997-06-12;460.64 1997-06-13;465.17 1997-06-16;465.01 1997-06-17;465.09 1997-06-18;463.41 1997-06-19;467.76 1997-06-20;467.84 1997-06-23;458.49 1997-06-24;466.17 1997-06-25;462.9 1997-06-26;460.93 1997-06-27;463.3 1997-06-30;462.44 1997-07-01;466.01 1997-07-02;471.71 1997-07-03;477.68 1997-07-07;475.55 1997-07-08;478.49 1997-07-09;473.03 1997-07-10;476.27 1997-07-11;478.12 1997-07-14;478.11 1997-07-15;480.99 1997-07-16;485.24 1997-07-17;482.96 1997-07-18;475.97 1997-07-21;474.5 1997-07-22;483.89 1997-07-23;485.51 1997-07-24;487.31 1997-07-25;486.8 1997-07-28;485.93 1997-07-29;488.43 1997-07-30;493.57 1997-07-31;494.5 1997-08-01;490.98 1997-08-04;491.93 1997-08-05;492.96 1997-08-06;497 1997-08-07;492.62 1997-08-08;483.79 1997-08-11;485.21 1997-08-12;480.76 1997-08-13;478.42 1997-08-14;479.66 1997-08-15;469.1 1997-08-18;473.55 1997-08-19;479.54 1997-08-20;485.7 1997-08-21;479.76 1997-08-22;478.93 1997-08-25;478.03 1997-08-26;475.36 1997-08-27;476.05 1997-08-28;472.36 1997-08-29;470.48 1997-09-02;482.9 1997-09-03;483.71 1997-09-04;485.11 1997-09-05;484.64 1997-09-08;485.78 1997-09-09;486.69 1997-09-10;480.63 1997-09-11;477.06 1997-09-12;483.3 1997-09-15;482.6 1997-09-16;493.69 1997-09-17;493.21 1997-09-18;495.41 1997-09-19;496.56 1997-09-22;499.16 1997-09-23;496.95 1997-09-24;494.27 1997-09-25;491.52 1997-09-26;495.2 1997-09-29;498.98 1997-09-30;497.23 1997-10-01;501.08 1997-10-02;503.43 1997-10-03;505.69 1997-10-06;509.7 1997-10-07;514.21 1997-10-08;509.57 1997-10-09;508.16 1997-10-10;506.85 1997-10-13;507.4 1997-10-14;508.57 1997-10-15;506.89 1997-10-16;502.3 1997-10-17;496.57 1997-10-20;502.26 1997-10-21;510.19 1997-10-22;508.8 1997-10-23;499.49 1997-10-24;495.76 1997-10-27;463.21 1997-10-28;482.66 1997-10-29;482.93 1997-10-30;475.83 1997-10-31;481.14 1997-11-03;492.63 1997-11-04;494.06 1997-11-05;495.77 1997-11-06;493.75 1997-11-07;487.29 1997-11-10;484.87 1997-11-11;485.66 1997-11-12;476.93 1997-11-13;480.69 1997-11-14;486.06 1997-11-17;494.88 1997-11-18;491.18 1997-11-19;493.9 1997-11-20;500.54 1997-11-21;502.85 1997-11-24;495.14 1997-11-25;496.98 1997-11-26;497.31 1997-11-28;499.1 1997-12-01;507.73 1997-12-02;507.64 1997-12-03;510.15 1997-12-04;509.44 1997-12-05;514.31 1997-12-08;513.44 1997-12-09;510.86 1997-12-10;507.7 1997-12-11;500.42 1997-12-12;500 1997-12-15;504.12 1997-12-16;506.75 1997-12-17;506.59 1997-12-18;501.69 1997-12-19;497.39 1997-12-22;500.48 1997-12-23;494.85 1997-12-24;492.32 1997-12-26;493.6 1997-12-29;501.49 1997-12-30;510.28 1997-12-31;511.19 1998-01-02;512.15 1998-01-05;512.77 1998-01-06;507.33 1998-01-07;506.18 1998-01-08;501.64 1998-01-09;487.47 1998-01-12;491.61 1998-01-13;497.75 1998-01-14;501.35 1998-01-15;497.95 1998-01-16;503.67 1998-01-20;511.92 1998-01-21;507.9 1998-01-22;503.79 1998-01-23;500.68 1998-01-26;500.28 1998-01-27;505.2 1998-01-28;509.22 1998-01-29;513.13 1998-01-30;510.63 1998-02-02;520.72 1998-02-03;523 1998-02-04;523.58 1998-02-05;522.97 1998-02-06;526.31 1998-02-09;525.97 1998-02-10;529.96 1998-02-11;530.75 1998-02-12;532.61 1998-02-13;531.28 1998-02-17;532.79 1998-02-18;537.23 1998-02-19;535.01 1998-02-20;537.49 1998-02-23;538.41 1998-02-24;534.82 1998-02-25;540.38 1998-02-26;543.39 1998-02-27;544.26 1998-03-02;544.63 1998-03-03;546.89 1998-03-04;544.46 1998-03-05;540.31 1998-03-06;549.64 1998-03-09;549.44 1998-03-10;555 1998-03-11;557.3 1998-03-12;557.9 1998-03-13;557.17 1998-03-16;561.94 1998-03-17;563.09 1998-03-18;565.62 1998-03-19;567.38 1998-03-20;572.61 1998-03-23;570.54 1998-03-24;574.96 1998-03-25;572.76 1998-03-26;572.21 1998-03-27;569.8 1998-03-30;568.89 1998-03-31;572.78 1998-04-01;576.41 1998-04-02;582.04 1998-04-03;583.08 1998-04-06;583.17 1998-04-07;577.75 1998-04-08;573.68 1998-04-09;578.35 1998-04-13;577.77 1998-04-14;581.31 1998-04-15;582.77 1998-04-16;576.91 1998-04-17;584.11 1998-04-20;584.01 1998-04-21;584.8 1998-04-22;585.62 1998-04-23;580.55 1998-04-24;574.47 1998-04-27;563.05 1998-04-28;563.56 1998-04-29;568.3 1998-04-30;577.37 1998-05-01;581.91 1998-05-04;582.73 1998-05-05;579.75 1998-05-06;574.57 1998-05-07;570.22 1998-05-08;575.72 1998-05-11;575.27 1998-05-12;578.28 1998-05-13;579.2 1998-05-14;578.31 1998-05-15;574.4 1998-05-18;572.08 1998-05-19;573.92 1998-05-20;578.63 1998-05-21;576.9 1998-05-22;574.78 1998-05-26;566.26 1998-05-27;563.93 1998-05-28;567.1 1998-05-29;565.28 1998-06-01;565.14 1998-06-02;565.35 1998-06-03;561.43 1998-06-04;566.35 1998-06-05;575.37 1998-06-08;576.82 1998-06-09;577.5 1998-06-10;574.37 1998-06-11;565.5 1998-06-12;566.67 1998-06-15;554.89 1998-06-16;558.92 1998-06-17;568.65 1998-06-18;567.49 1998-06-19;563.92 1998-06-22;564.88 1998-06-23;571.63 1998-06-24;577.18 1998-06-25;576.14 1998-06-26;577.53 1998-06-29;580.17 1998-06-30;578.73 1998-07-01;585.6 1998-07-02;585.8 1998-07-06;590.82 1998-07-07;589.76 1998-07-08;594.35 1998-07-09;590.23 1998-07-10;592.18 1998-07-13;591.42 1998-07-14;597.61 1998-07-15;595.49 1998-07-16;599.99 1998-07-17;600.75 1998-07-20;599.21 1998-07-21;590.67 1998-07-22;588.81 1998-07-23;576.68 1998-07-24;576.32 1998-07-27;577.43 1998-07-28;569.49 1998-07-29;567.42 1998-07-30;575.26 1998-07-31;565.27 1998-08-03;560.89 1998-08-04;541.36 1998-08-05;544.01 1998-08-06;547.8 1998-08-07;549.5 1998-08-10;545.72 1998-08-11;537.95 1998-08-12;545.46 1998-08-13;541.06 1998-08-14;535.71 1998-08-17;543.99 1998-08-18;552.03 1998-08-19;550.05 1998-08-20;546.22 1998-08-21;540.82 1998-08-24;543.72 1998-08-25;545.01 1998-08-26;539.56 1998-08-27;518.82 1998-08-28;512.12 1998-08-31;480.6 1998-09-01;495.93 1998-09-02;494.63 1998-09-03;489.89 1998-09-04;486.31 1998-09-08;508.59 1998-09-09;500.57 1998-09-10;487.77 1998-09-11;500.03 1998-09-14;510.21 1998-09-15;513.92 1998-09-16;518.05 1998-09-17;506.31 1998-09-18;507.54 1998-09-21;507.43 1998-09-22;510.6 1998-09-23;526.95 1998-09-24;516.59 1998-09-25;515.68 1998-09-28;518.03 1998-09-29;518.28 1998-09-30;504.47 1998-10-01;490.22 1998-10-02;498.16 1998-10-05;492.44 1998-10-06;491.51 1998-10-07;484.68 1998-10-08;477.2 1998-10-09;486.7 1998-10-12;492.95 1998-10-13;492.14 1998-10-14;496.98 1998-10-15;516.46 1998-10-16;522.24 1998-10-19;525.5 1998-10-20;528.28 1998-10-21;529.4 1998-10-22;533 1998-10-23;529.82 1998-10-26;530 1998-10-27;527.76 1998-10-28;527.65 1998-10-29;536.31 1998-10-30;543.35 1998-11-02;551.24 1998-11-03;551.8 1998-11-04;555.14 1998-11-05;562.18 1998-11-06;565.1 1998-11-09;559.14 1998-11-10;557.42 1998-11-11;553.36 1998-11-12;552.56 1998-11-13;556.17 1998-11-16;560.28 1998-11-17;561.02 1998-11-18;563.46 1998-11-19;566.75 1998-11-20;572.08 1998-11-23;582.25 1998-11-24;579.69 1998-11-25;581.04 1998-11-27;583 1998-11-30;571.5 1998-12-01;573.33 1998-12-02;571.79 1998-12-03;563.45 1998-12-04;573.49 1998-12-07;577.33 1998-12-08;574.92 1998-12-09;574.79 1998-12-10;566.08 1998-12-11;564.82 1998-12-14;554.53 1998-12-15;562.74 1998-12-16;562.89 1998-12-17;570.15 1998-12-18;572.07 1998-12-21;577.7 1998-12-22;578.75 1998-12-23;588.95 1998-12-24;589.07 1998-12-28;589.01 1998-12-29;597.05 1998-12-30;594.27 1998-12-31;595.81 1999-01-04;594.12 1999-01-05;599.91 1999-01-06;611.01 1999-01-07;609.19 1999-01-08;611.06 1999-01-11;604.04 1999-01-12;594.59 1999-01-13;590.72 1999-01-14;581.07 1999-01-15;593.39 1999-01-19;594.83 1999-01-20;596.09 1999-01-21;588.03 1999-01-22;583.75 1999-01-25;586.06 1999-01-26;591.45 1999-01-27;588.08 1999-01-28;595.4 1999-01-29;600.44 1999-02-01;597.46 1999-02-02;594.1 1999-02-03;598.58 1999-02-04;591.05 1999-02-05;587.29 1999-02-08;586.64 1999-02-09;576.62 1999-02-10;578.61 1999-02-11;589.74 1999-02-12;581.46 1999-02-16;586.73 1999-02-17;580.35 1999-02-18;586.46 1999-02-19;586.56 1999-02-22;600.23 1999-02-23;598.02 1999-02-24;591.57 1999-02-25;587.43 1999-02-26;586.46 1999-03-01;585.43 1999-03-02;582.94 1999-03-03;582.55 1999-03-04;590.75 1999-03-05;603.14 1999-03-08;604.1 1999-03-09;602.93 1999-03-10;606.48 1999-03-11;611.67 1999-03-12;611.54 1999-03-15;615.22 1999-03-16;614.08 1999-03-17;610.65 1999-03-18;617.61 1999-03-19;610.68 1999-03-22;610.49 1999-03-23;595.45 1999-03-24;596.59 1999-03-25;604.86 1999-03-26;602.35 1999-03-29;613.16 1999-03-30;608.65 1999-03-31;603.59 1999-04-01;604.99 1999-04-05;614.63 1999-04-06;612.32 1999-04-07;616.23 1999-04-08;624.28 1999-04-09;626.59 1999-04-12;633.13 1999-04-13;631.67 1999-04-14;625.67 1999-04-15;622.89 1999-04-16;624.9 1999-04-19;615.88 1999-04-20;620.84 1999-04-21;633.71 1999-04-22;640.97 1999-04-23;639.3 1999-04-26;638.83 1999-04-27;643.27 1999-04-28;640.32 1999-04-29;638.09 1999-04-30;634.3 1999-05-03;644.18 1999-05-04;636.1 1999-05-05;640.54 1999-05-06;636.22 1999-05-07;641.24 1999-05-10;639.34 1999-05-11;645.77 1999-05-12;647.68 1999-05-13;651.35 1999-05-14;638.45 1999-05-17;636.92 1999-05-18;634.19 1999-05-19;639.54 1999-05-20;639.42 1999-05-21;636.87 1999-05-24;626.05 1999-05-25;617.34 1999-05-26;624.84 1999-05-27;614.02 1999-05-28;622.26 1999-06-01;621.28 1999-06-02;620.5 1999-06-03;624.2 1999-06-04;634.52 1999-06-07;636.94 1999-06-08;630.77 1999-06-09;629.28 1999-06-10;622.85 1999-06-11;619.5 1999-06-14;619.6 1999-06-15;622.28 1999-06-16;632.17 1999-06-17;636.07 1999-06-18;636.55 1999-06-21;636.94 1999-06-22;633.11 1999-06-23;630.75 1999-06-24;623.97 1999-06-25;623.34 1999-06-28;628.89 1999-06-29;637.99 1999-06-30;648.13 1999-07-01;651.33 1999-07-02;655.12 1999-07-06;654.77 1999-07-07;656.47 1999-07-08;654.05 1999-07-09;657.68 1999-07-12;655.79 1999-07-13;653.64 1999-07-14;654.9 1999-07-15;660.75 1999-07-16;663.12 1999-07-19;658.57 1999-07-20;647.27 1999-07-21;647.48 1999-07-22;641.78 1999-07-23;638.87 1999-07-26;635.9 1999-07-27;640.69 1999-07-28;640.4 1999-07-29;630.81 1999-07-30;626.07 1999-08-02;625.34 1999-08-03;622.4 1999-08-04;614.46 1999-08-05;617.39 1999-08-06;611.04 1999-08-09;610.46 1999-08-10;603.37 1999-08-11;610.22 1999-08-12;610.63 1999-08-13;621.38 1999-08-16;622.89 1999-08-17;628.71 1999-08-18;623.65 1999-08-19;620.36 1999-08-20;626.09 1999-08-23;634.81 1999-08-24;633.88 1999-08-25;639.96 1999-08-26;632.34 1999-08-27;625.71 1999-08-30;615.13 1999-08-31;612.33 1999-09-01;617.29 1999-09-02;611.33 1999-09-03;625.89 1999-09-07;623.71 1999-09-08;621.87 1999-09-09;621.99 1999-09-10;622.9 1999-09-13;620.81 1999-09-14;615.11 1999-09-15;608.47 1999-09-16;607.32 1999-09-17;613.1 1999-09-20;612.1 1999-09-21;600.99 1999-09-22;601.16 1999-09-23;590.98 1999-09-24;589.54 1999-09-27;591.62 1999-09-28;590.08 1999-09-29;586.24 1999-09-30;592.79 1999-10-01;592.48 1999-10-04;600.59 1999-10-05;599.3 1999-10-06;609.9 1999-10-07;606.61 1999-10-08;613.51 1999-10-11;613.33 1999-10-12;603.38 1999-10-13;592.09 1999-10-14;591.33 1999-10-15;576.17 1999-10-18;579.62 1999-10-19;585.05 1999-10-20;593.79 1999-10-21;591.29 1999-10-22;601.16 1999-10-25;597.31 1999-10-26;591.24 1999-10-27;598.14 1999-10-28;618.15 1999-10-29;625.47 1999-11-01;621.72 1999-11-02;618.46 1999-11-03;621.46 1999-11-04;624.72 1999-11-05;627.36 1999-11-08;630.37 1999-11-09;625.99 1999-11-10;629.02 1999-11-11;629.39 1999-11-12;636.67 1999-11-15;637.31 1999-11-16;647.62 1999-11-17;644.51 1999-11-18;648.9 1999-11-19;646.12 1999-11-22;644.64 1999-11-23;637.14 1999-11-24;639.63 1999-11-26;639.95 1999-11-29;636.5 1999-11-30;631.18 1999-12-01;634.77 1999-12-02;637.16 1999-12-03;646.73 1999-12-06;641.66 1999-12-07;635.08 1999-12-08;634.31 1999-12-09;636.05 1999-12-10;639.49 1999-12-13;636.51 1999-12-14;632.07 1999-12-15;631.93 1999-12-16;631.76 1999-12-17;631.65 1999-12-20;629.44 1999-12-21;632.89 1999-12-22;634.16 1999-12-23;644.06 1999-12-27;642.24 1999-12-28;644.3 1999-12-29;646.03 1999-12-30;647.21 1999-12-31;650.3 2000-01-03;639.52 2000-01-04;618.87 2000-01-05;621.07 2000-01-06;627.54 2000-01-07;642.41 2000-01-10;646.74 2000-01-11;640.69 2000-01-12;639.94 2000-01-13;646.58 2000-01-14;649.77 2000-01-18;643.92 2000-01-19;645.37 2000-01-20;640.51 2000-01-21;639.58 2000-01-24;625.24 2000-01-25;624.83 2000-01-26;628.43 2000-01-27;626.76 2000-01-28;611.81 2000-01-31;621.73 2000-02-01;624.84 2000-02-02;625.93 2000-02-03;629.63 2000-02-04;626.9 2000-02-07;623.84 2000-02-08;629.04 2000-02-09;616.98 2000-02-10;614.43 2000-02-11;604.46 2000-02-14;605.09 2000-02-15;610.88 2000-02-16;604.97 2000-02-17;601.26 2000-02-18;586.67 2000-02-22;590.12 2000-02-23;588.63 2000-02-24;583.57 2000-02-25;576.42 2000-02-28;584.2 2000-02-29;592.64 2000-03-01;599.48 2000-03-02;601.5 2000-03-03;610.47 2000-03-06;604.02 2000-03-07;588.57 2000-03-08;591.23 2000-03-09;603 2000-03-10;599.34 2000-03-13;594.61 2000-03-14;588.43 2000-03-15;605.02 2000-03-16;634.44 2000-03-17;632.98 2000-03-20;631.14 2000-03-21;642.79 2000-03-22;643.24 2000-03-23;652.31 2000-03-24;652.5 2000-03-27;649.14 2000-03-28;645.46 2000-03-29;649.36 2000-03-30;645.67 2000-03-31;647.7 2000-04-03;659.66 2000-04-04;652.3 2000-04-05;650.53 2000-04-06;658.79 2000-04-07;659.43 2000-04-10;659.71 2000-04-11;661.2 2000-04-12;654.25 2000-04-13;644.61 2000-04-14;611.49 2000-04-17;620.21 2000-04-18;634.81 2000-04-19;633.27 2000-04-20;639.41 2000-04-24;642.18 2000-04-25;658.77 2000-04-26;654.31 2000-04-27;650.45 2000-04-28;644.16 2000-05-01;650.57 2000-05-02;645.75 2000-05-03;631.91 2000-05-04;631.47 2000-05-05;638.33 2000-05-08;640.3 2000-05-09;636.29 2000-05-10;628.36 2000-05-11;636.89 2000-05-12;642.86 2000-05-15;655.78 2000-05-16;658.83 2000-05-17;650.98 2000-05-18;649.59 2000-05-19;639.55 2000-05-22;634.92 2000-05-23;630.28 2000-05-24;635.18 2000-05-25;629.8 2000-05-26;628.89 2000-05-30;641.38 2000-05-31;643.6 2000-06-01;651.46 2000-06-02;659.69 2000-06-05;655.16 2000-06-06;653 2000-06-07;655.88 2000-06-08;651.94 2000-06-09;648.44 2000-06-12;646.78 2000-06-13;653.63 2000-06-14;656.73 2000-06-15;657.44 2000-06-16;649.68 2000-06-19;654.35 2000-06-20;649.26 2000-06-21;648.98 2000-06-22;641.54 2000-06-23;639.96 2000-06-26;643.94 2000-06-27;643.71 2000-06-28;644.21 2000-06-29;642.75 2000-06-30;642.93 2000-07-03;650.19 2000-07-05;644.9 2000-07-06;645.75 2000-07-07;654.36 2000-07-10;656.29 2000-07-11;659.9 2000-07-12;661.13 2000-07-13;659.71 2000-07-14;663.8 2000-07-17;663.2 2000-07-18;658.21 2000-07-19;656.95 2000-07-20;660.19 2000-07-21;655.38 2000-07-24;651 2000-07-25;652.56 2000-07-26;644.81 2000-07-27;647.2 2000-07-28;639.16 2000-07-31;640.63 2000-08-01;647.96 2000-08-02;650.31 2000-08-03;651.71 2000-08-04;657.79 2000-08-07;663.52 2000-08-08;665.7 2000-08-09;660.57 2000-08-10;659.25 2000-08-11;664.74 2000-08-14;672.05 2000-08-15;668.01 2000-08-16;666.25 2000-08-17;671.19 2000-08-18;668.95 2000-08-21;671.16 2000-08-22;671.62 2000-08-23;672.22 2000-08-24;671.94 2000-08-25;672.53 2000-08-28;675.26 2000-08-29;673.44 2000-08-30;670.46 2000-08-31;674.53 2000-09-01;677.58 2000-09-05;676.2 2000-09-06;674.46 2000-09-07;675.49 2000-09-08;675.73 2000-09-11;677.24 2000-09-12;675.84 2000-09-13;675.22 2000-09-14;674.42 2000-09-15;669.42 2000-09-18;659.78 2000-09-19;661.11 2000-09-20;653.84 2000-09-21;654.23 2000-09-22;659.34 2000-09-25;659.48 2000-09-26;654.83 2000-09-27;656.05 2000-09-28;667.75 2000-09-29;663.04 2000-10-02;666.37 2000-10-03;664.62 2000-10-04;665.14 2000-10-05;667.87 2000-10-06;656.12 2000-10-09;653.55 2000-10-10;650.36 2000-10-11;640.42 2000-10-12;624.12 2000-10-13;637.61 2000-10-16;641.67 2000-10-17;629.46 2000-10-18;625.11 2000-10-19;638.66 2000-10-20;642.17 2000-10-23;642.29 2000-10-24;646.54 2000-10-25;636.5 2000-10-26;633.48 2000-10-27;641.01 2000-10-30;654.53 2000-10-31;666.02 2000-11-01;664.5 2000-11-02;663.23 2000-11-03;661.35 2000-11-06;665.39 2000-11-07;664.52 2000-11-08;661.8 2000-11-09;656.2 2000-11-10;646.44 2000-11-13;639.05 2000-11-14;648.52 2000-11-15;651.09 2000-11-16;647.02 2000-11-17;643.74 2000-11-20;634.34 2000-11-21;635.23 2000-11-22;626.46 2000-11-24;632.09 2000-11-27;636.93 2000-11-28;634.33 2000-11-29;637.42 2000-11-30;629.78 2000-12-01;631.49 2000-12-04;637.41 2000-12-05;653.27 2000-12-06;645.72 2000-12-07;644.78 2000-12-08;655.37 2000-12-11;657.53 2000-12-12;655 2000-12-13;653.3 2000-12-14;645.58 2000-12-15;635.86 2000-12-18;643.23 2000-12-19;639.86 2000-12-20;624.97 2000-12-21;629.28 2000-12-22;639.55 2000-12-26;646.09 2000-12-27;653.66 2000-12-28;659.9 2000-12-29;656.87 2001-01-02;641.75 2001-01-03;659.07 2001-01-04;652.07 2001-01-05;640.65 2001-01-08;639.23 2001-01-09;638.83 2001-01-10;643.33 2001-01-11;646.46 2001-01-12;644.36 2001-01-16;650.18 2001-01-17;648.06 2001-01-18;651.52 2001-01-19;646.57 2001-01-22;648.19 2001-01-23;655.22 2001-01-24;656.26 2001-01-25;658.37 2001-01-26;655.51 2001-01-29;658.18 2001-01-30;664.19 2001-01-31;663.64 2001-02-01;666.57 2001-02-02;660.22 2001-02-05;663.6 2001-02-06;662.26 2001-02-07;659.6 2001-02-08;657.76 2001-02-09;653.28 2001-02-12;660.99 2001-02-13;657.72 2001-02-14;652.03 2001-02-15;654.45 2001-02-16;647.88 2001-02-20;641.34 2001-02-21;629.74 2001-02-22;627.62 2001-02-23;623 2001-02-26;634.49 2001-02-27;633.46 2001-02-28;626.94 2001-03-01;625.15 2001-03-02;626.87 2001-03-05;628.85 2001-03-06;632.18 2001-03-07;635.71 2001-03-08;639.25 2001-03-09;628.99 2001-03-12;605.97 2001-03-13;609.34 2001-03-14;593.76 2001-03-15;598.85 2001-03-16;587.66 2001-03-19;596.17 2001-03-20;586.54 2001-03-21;575.14 2001-03-22;566.35 2001-03-23;577.87 2001-03-26;587.01 2001-03-27;599.69 2001-03-28;590.06 2001-03-29;588.68 2001-03-30;595.66 2001-04-02;589.29 2001-04-03;572.08 2001-04-04;572.71 2001-04-05;592.55 2001-04-06;583.03 2001-04-09;587.69 2001-04-10;599.83 2001-04-11;595 2001-04-12;601.74 2001-04-16;602.32 2001-04-17;608.78 2001-04-18;626.02 2001-04-19;628.83 2001-04-20;623.35 2001-04-23;618.77 2001-04-24;613.97 2001-04-25;623.5 2001-04-26;629.36 2001-04-27;637.64 2001-04-30;634.83 2001-05-01;641.04 2001-05-02;638.83 2001-05-03;632.42 2001-05-04;640.05 2001-05-07;639.02 2001-05-08;636.51 2001-05-09;636.29 2001-05-10;637.99 2001-05-11;633.64 2001-05-14;636.53 2001-05-15;637.43 2001-05-16;652.73 2001-05-17;655.25 2001-05-18;657.15 2001-05-21;663.56 2001-05-22;661.39 2001-05-23;652.9 2001-05-24;652.98 2001-05-25;647.13 2001-05-29;645.12 2001-05-30;638.11 2001-05-31;641.67 2001-06-01;642.81 2001-06-04;646.51 2001-06-05;652.03 2001-06-06;645.05 2001-06-07;645.81 2001-06-08;641.8 2001-06-11;637.37 2001-06-12;637.08 2001-06-13;632.72 2001-06-14;623.96 2001-06-15;621.94 2001-06-18;619.85 2001-06-19;620.79 2001-06-20;625.52 2001-06-21;631.08 2001-06-22;625.37 2001-06-25;620.13 2001-06-26;618.82 2001-06-27;616 2001-06-28;621.7 2001-06-29;621.76 2001-07-02;627.27 2001-07-03;626.01 2001-07-05;620.9 2001-07-06;609.34 2001-07-09;611.89 2001-07-10;605.93 2001-07-11;603.22 2001-07-12;612.76 2001-07-13;616.16 2001-07-16;611.58 2001-07-17;616.65 2001-07-18;615.53 2001-07-19;617.44 2001-07-20;616.69 2001-07-23;608.48 2001-07-24;598.12 2001-07-25;606.32 2001-07-26;611.98 2001-07-27;613.56 2001-07-30;613.85 2001-07-31;616.94 2001-08-01;617.15 2001-08-02;618.4 2001-08-03;616.31 2001-08-06;610.13 2001-08-07;612.5 2001-08-08;604.42 2001-08-09;604.26 2001-08-10;608.34 2001-08-13;608.03 2001-08-14;607.54 2001-08-15;605.9 2001-08-16;606.36 2001-08-17;599.18 2001-08-20;603.17 2001-08-21;598.7 2001-08-22;601.77 2001-08-23;600.89 2001-08-24;608.57 2001-08-27;605.94 2001-08-28;598.84 2001-08-29;593.53 2001-08-30;586.1 2001-08-31;587.84 2001-09-04;589.55 2001-09-05;588.47 2001-09-06;577.31 2001-09-07;566.17 2001-09-10;568.08 2001-09-17;541.99 2001-09-18;538.37 2001-09-19;529.38 2001-09-20;514.16 2001-09-21;504.21 2001-09-24;521.42 2001-09-25;525.99 2001-09-26;524.56 2001-09-27;532.3 2001-09-28;543.84 2001-10-01;542.05 2001-10-02;548.82 2001-10-03;556.15 2001-10-04;554.78 2001-10-05;554.4 2001-10-08;549.16 2001-10-09;548.63 2001-10-10;559.87 2001-10-11;565.79 2001-10-12;561.98 2001-10-15;561.82 2001-10-16;565.27 2001-10-17;557.92 2001-10-18;552.23 2001-10-19;554.32 2001-10-22;561.45 2001-10-23;558.63 2001-10-24;557.08 2001-10-25;562.96 2001-10-26;566.58 2001-10-29;555.85 2001-10-30;546.74 2001-10-31;546.34 2001-11-01;555.96 2001-11-02;557.6 2001-11-05;563.79 2001-11-06;570.29 2001-11-07;568.48 2001-11-08;570.07 2001-11-09;570.61 2001-11-12;569.12 2001-11-13;578.31 2001-11-14;579.48 2001-11-15;579.79 2001-11-16;578.83 2001-11-19;584.29 2001-11-20;582.32 2001-11-21;579.56 2001-11-23;585.82 2001-11-26;588.23 2001-11-27;584.58 2001-11-28;575.2 2001-11-29;579.75 2001-11-30;579.27 2001-12-03;575.29 2001-12-04;581.16 2001-12-05;591.32 2001-12-06;589.85 2001-12-07;587.19 2001-12-10;578.25 2001-12-11;576.11 2001-12-12;575.39 2001-12-13;569.27 2001-12-14;571.15 2001-12-17;575.85 2001-12-18;580.56 2001-12-19;585.12 2001-12-20;583.26 2001-12-21;585.7 2001-12-24;586.05 2001-12-26;588.63 2001-12-27;592.08 2001-12-28;594.38 2001-12-31;589.8 2002-01-02;590.54 2002-01-03;592.63 2002-01-04;596.57 2002-01-07;593.15 2002-01-08;589.71 2002-01-09;587.06 2002-01-10;587.39 2002-01-11;582.67 2002-01-14;579.04 2002-01-15;582.63 2002-01-16;575.16 2002-01-17;579.26 2002-01-18;576.19 2002-01-22;574.27 2002-01-23;577.62 2002-01-24;578.92 2002-01-25;580.1 2002-01-28;579.63 2002-01-29;564.93 2002-01-30;570.54 2002-01-31;578.5 2002-02-01;575.76 2002-02-04;562.64 2002-02-05;560.6 2002-02-06;557.81 2002-02-07;557.49 2002-02-08;565.34 2002-02-11;572.68 2002-02-12;571.48 2002-02-13;576.09 2002-02-14;575.66 2002-02-15;571.25 2002-02-19;562.08 2002-02-20;569.14 2002-02-21;563.58 2002-02-22;568.28 2002-02-25;576.36 2002-02-26;577.34 2002-02-27;579.2 2002-02-28;578.6 2002-03-01;588.63 2002-03-04;598.89 2002-03-05;594.61 2002-03-06;603.11 2002-03-07;600.9 2002-03-08;602.1 2002-03-11;604.22 2002-03-12;604.61 2002-03-13;600.39 2002-03-14;600.8 2002-03-15;607.13 2002-03-18;607.24 2002-03-19;609.53 2002-03-20;602.37 2002-03-21;601.82 2002-03-22;600.09 2002-03-25;592.43 2002-03-26;595.68 2002-03-27;599.85 2002-03-28;600.43 2002-04-01;598.38 2002-04-02;596.32 2002-04-03;590.68 2002-04-04;591.01 2002-04-05;590.76 2002-04-08;591.64 2002-04-09;590.84 2002-04-10;597.32 2002-04-11;584.58 2002-04-12;588 2002-04-15;583.85 2002-04-16;594.73 2002-04-17;593.48 2002-04-18;592.95 2002-04-19;593.78 2002-04-22;586.05 2002-04-23;584.3 2002-04-24;581.13 2002-04-25;579.97 2002-04-26;574.32 2002-04-29;568.43 2002-04-30;574.18 2002-05-01;580.35 2002-05-02;581.65 2002-05-03;577.79 2002-05-06;567.68 2002-05-07;565.35 2002-05-08;579.22 2002-05-09;572.72 2002-05-10;565.73 2002-05-13;573.18 2002-05-14;582.66 2002-05-15;579.54 2002-05-16;581.68 2002-05-17;585.78 2002-05-20;580.22 2002-05-21;575.08 2002-05-22;576.98 2002-05-23;582.31 2002-05-24;577.16 2002-05-28;572.58 2002-05-29;570.3 2002-05-30;567.8 2002-05-31;570.78 2002-06-03;558.16 2002-06-04;556 2002-06-05;559.96 2002-06-06;550.05 2002-06-07;551.57 2002-06-10;553.39 2002-06-11;545.27 2002-06-12;546.56 2002-06-13;541.54 2002-06-14;540.25 2002-06-17;554.19 2002-06-18;555.2 2002-06-19;548.32 2002-06-20;542.3 2002-06-21;534.35 2002-06-24;533.91 2002-06-25;526.64 2002-06-26;524.25 2002-06-27;532.16 2002-06-28;533.07 2002-07-01;523.49 2002-07-02;512.88 2002-07-03;513.24 2002-07-05;529.49 2002-07-08;525.32 2002-07-09;512.93 2002-07-10;496.94 2002-07-11;497.7 2002-07-12;494.44 2002-07-15;490.73 2002-07-16;482.42 2002-07-17;484.34 2002-07-18;472.33 2002-07-19;455.67 2002-07-22;441.33 2002-07-23;430.28 2002-07-24;453.15 2002-07-25;454.36 2002-07-26;460.84 2002-07-29;484.71 2002-07-30;486.35 2002-07-31;491.37 2002-08-01;479.29 2002-08-02;468.58 2002-08-05;453.31 2002-08-06;465.43 2002-08-07;473.54 2002-08-08;488.01 2002-08-09;490.43 2002-08-12;487.8 2002-08-13;478.34 2002-08-14;493.99 2002-08-15;500.02 2002-08-16;499.17 2002-08-19;509.35 2002-08-20;503.13 2002-08-21;508.78 2002-08-22;515.66 2002-08-23;505.35 2002-08-26;509.61 2002-08-27;504.16 2002-08-28;495.86 2002-08-29;495.2 2002-08-30;495.55 2002-09-03;476.33 2002-09-04;484.03 2002-09-05;478.03 2002-09-06;484.64 2002-09-09;489.14 2002-09-10;491.79 2002-09-11;492.33 2002-09-12;481.34 2002-09-13;482.35 2002-09-16;483.55 2002-09-17;473.91 2002-09-18;471.69 2002-09-19;457.99 2002-09-20;458.97 2002-09-23;453.78 2002-09-24;445.38 2002-09-25;455.08 2002-09-26;464.8 2002-09-27;450.23 2002-09-30;445.44 2002-10-01;460.93 2002-10-02;450.37 2002-10-03;446.24 2002-10-04;436.31 2002-10-07;427.59 2002-10-08;434.22 2002-10-09;421.09 2002-10-10;434.17 2002-10-11;449.67 2002-10-14;452.63 2002-10-15;472.19 2002-10-16;462.31 2002-10-17;472.42 2002-10-18;473.94 2002-10-21;481.69 2002-10-22;476.35 2002-10-23;478.45 2002-10-24;472.22 2002-10-25;479.15 2002-10-28;475.57 2002-10-29;471.49 2002-10-30;475.45 2002-10-31;472.9 2002-11-01;480.41 2002-11-04;482.22 2002-11-05;485.8 2002-11-06;490.11 2002-11-07;480.39 2002-11-08;476.66 2002-11-11;467.95 2002-11-12;470.17 2002-11-13;468.9 2002-11-14;478.7 2002-11-15;482.34 2002-11-18;478.28 2002-11-19;477.11 2002-11-20;484.43 2002-11-21;493.12 2002-11-22;491.63 2002-11-25;492.62 2002-11-26;483.4 2002-11-27;496.29 2002-11-29;495.27 2002-12-02;494.59 2002-12-03;488.44 2002-12-04;487.57 2002-12-05;482.78 2002-12-06;485.34 2002-12-09;476.72 2002-12-10;482.77 2002-12-11;482.82 2002-12-12;481.09 2002-12-13;476.19 2002-12-16;485.93 2002-12-17;481.83 2002-12-18;476.46 2002-12-19;473 2002-12-20;479.22 2002-12-23;479.27 2002-12-24;477.06 2002-12-26;476.33 2002-12-27;468.9 2002-12-30;471.56 2002-12-31;472.87 fBasics/data/HedgeFund.R0000644000176200001440000000626413202116740014515 0ustar liggesusers# ############################################################################## # http://www.hennesseegroup.com/indices/returns/year/2005.html .HedgeFund1 = c( # JAN FEB MAR APR MAY JUN -0.91, 1.26, -1.18, -1.95, 1.88, 1.87, # LongShortEquity -0.10, 0.90, -0.31, -1.55, 0.05, 1.22, # ArbitrageEventDriven 0.59, 2.28, -1.07, -0.73, 1.00, 1.33, # GlobalMacro -0.91, -0.48, -1.37, -2.89, -1.42, 1.07, # ConvertibleArbitrage 0.33, 1.36, 0.34, -0.60, -0.09, 1.14, # Distressed -0.18, 1.69, -0.40, -2.15, 0.83, 1.80, # EventDriven 0.30, 1.48, -0.85, -0.99, 0.46, 1.33, # HighYield 0.55, 0.73, 0.03, -0.20, 0.43, 0.70, # MarketNeutral 0.13, 0.91, 0.44, -1.04, 0.75, 0.86, # MergerArbitrage 0.06, 0.96, -0.17, -1.38, -0.29, 0.92, # MultipleArbitrage -0.89, 1.65, -0.74, -2.04, 0.77, 2.13, # Opportunistic 4.33, 2.01, 1.93, 3.59, -3.97, -0.57, # ShortBiased -1.88, 4.14, -2.89, -2.73, -0.38, 1.12, # MSCI.EAFE -5.20, -0.52, -2.56, -3.88, 7.63, -0.54, # NASDAQ -4.17, 1.69, -2.86, -5.73, 6.55, 3.86, # Russell2000 -2.53, 1.89, -1.91, -2.01, 3.00, -0.01) # SP500 .HedgeFund2 = c( # JUL AUG SEP OCT NOV DEC 2.65, 0.39, 1.33, -1.65, 1.64, 1.37, # LongShortEquity 1.75, 0.89, 1.10, -0.82, 0.82, 1.20, # ArbitrageEventDriven 1.87, 1.21, 3.48, -1.72, 2.23, 3.05, # GlobalMacro 1.21, 0.73, 1.23, -0.21, -0.09, 0.75, # ConvertibleArbitrage 1.70, 1.16, 1.43, -0.42, 1.20, 1.62, # Distressed 2.42, 1.18, 1.37, -2.62, 1.42, 1.62, # EventDriven 1.73, 1.16, 0.65, -0.29, 0.75, 1.15, # HighYield 0.44, 0.26, 0.91, -0.16, 0.65, 0.31, # MarketNeutral 1.24, 0.57, 0.01, -1.51, 1.25, 1.03, # MergerArbitrage 2.01, 0.97, 0.96, -0.58, 0.56, 1.38, # MultipleArbitrage 2.01, 1.10, 2.57, -1.94, 1.14, 1.79, # Opportunistic -1.53, 2.25, 2.35, 2.69, -2.84, -0.20, # ShortBiased 3.02, 2.26, 4.27, -2.97, 2.25, 4.61, # MSCI,EAFE 6.22, -1.50, -0.02, -1.46, 5.31, -1.23, # NASDAQ 6.34, -1.85, 0.31, -3.10, 4.85, -0.46, # Russell2000 3.60, -1.12, 0.70, -1.77, 3.52, -0.10) # SP500 HedgeFund = cbind( matrix( .HedgeFund1, byrow = TRUE, ncol = 6), matrix( .HedgeFund2, byrow = TRUE, ncol = 6)) colnames(HedgeFund) = paste(c( "JAN", "FEB", "MAR", "APR", "MAY", "JUN", "JUL", "AUG", "SEP", "OCT", "NOV", "DEC"), "05", sep = "") rownames(HedgeFund) = c( "LongShortEquity", "ArbitrageEventDriven", "GlobalMacro", "ConvertibleArbitrage", "Distressed", "EventDriven", "HighYield", "MarketNeutral", "MergerArbitrage", "MultipleArbitrage", "Opportunistic", "ShortBiased", "MSCI.EAFE", "NASDAQ", "Russell2000", "SP500") fBasics/data/Capitalization.R0000644000176200001440000000274113202116740015633 0ustar liggesusers# \emph{World Federation of Stock Exchanges}, # http://www.world-exchanges.org/statistics Capitalization <- matrix(c( # 2003, 2004, 2005, 2006, 2007, 2008, Year / 1328953, 12707578, 3632303, 15421167, 15650832, 9208934, # Euronext US 888677, 1177517, 1482184, 1700708, 2186550, 1033448, # TSX Group 585431, 776402, 804014, 1095858, 1298315, 683871, # Australian SE 278662, 386321, 553073, 818878, 1819100, 647204, # Bombay SE 714597, 861462, 1054999, 1714953, 2654416, 1328768, # Hong Kong SE 252893, 363276, 515972, 774115, 1660096, 600281, # NSE India 360106, 314315, 286190, 917507, 3694348, 1425354, # Shanghai SE 2953098, 3557674, 4572901, 4614068, 4330921, 3115803, # Tokyo SE 726243, 940672, 959910, 1322915, 1781132, 948352, # BME Spanish SE 1079026, 1194516, 1221106, 1637609, 2105197, 1110579, # Deutsche Boerse 2460064, 2865243, 3058182, 3794310, 3851705, 1868153, # London SE 2076410, 2441261, 2706803, 3712680, 4222679, 2101745, # Euronext EU 727103, 826040, 935448, 1212308, 1271047, 857306),# SIX SE byrow = TRUE, ncol = 6, dimnames = list( c("Euronext US", "TSX Group", "Australian SE", "Bombay SE", "Hong Kong SE", "NSE India", "Shanghai SE", "Tokyo SE", "BME Spanish SE", "Deutsche Boerse", "London SE", "Euronext EU", "SIX SE"), as.character(2003:2008))) fBasics/data/usdthb.csv0000644000176200001440000034327313202116740014553 0ustar liggesusersXDATE;DELAY;CONTRIBUTOR;BID;ASK;FLAG 199706011928;01;ANZM;+24.800;+25.000;0 199706011931;01;CBAP;+24.820;+25.020;0 199706012126;01;ANZM;+24.850;+25.005;0 199706012134;01;CBAP;+24.830;+25.030;0 199706012134;01;CBAP;+24.800;+25.000;0 199706012136;01;ANZM;+24.800;+25.000;0 199706012138;01;CBAP;+24.810;+25.010;0 199706012218;01;ANZM;+24.850;+25.050;0 199706012224;01;CBAP;+24.800;+25.000;0 199706012330;01;ANZM;+24.800;+25.000;0 199706012338;01;AIGH;+24.700;+24.900;0 199706012340;01;AIGH;+24.650;+24.850;0 199706012343;01;MBRC;+24.800;+25.000;0 199706012343;01;AIGH;+24.800;+24.950;0 199706012344;01;AIGH;+24.800;+24.900;0 199706012345;01;SIME;+24.700;+24.800;0 199706012350;02;AIGH;+24.750;+24.850;0 199706012353;01;AIGH;+24.800;+24.850;0 199706012358;01;AIGH;+24.750;+24.820;0 199706012359;01;AIGH;+24.770;+24.820;0 199706020002;01;AIGH;+24.800;+24.820;0 199706020004;01;BBLS;+24.800;+24.850;0 199706020005;02;AIGH;+24.750;+24.800;0 199706020018;01;HKBK;+24.750;+24.850;0 199706020019;01;AIGH;+24.800;+24.850;0 199706020022;01;AIGH;+24.700;+24.800;0 199706020022;01;BBLS;+24.750;+24.900;0 199706020023;01;AIGH;+24.700;+24.750;0 199706020024;01;MBRC;+24.700;+24.800;0 199706020025;01;SUMS;+24.750;+24.850;0 199706020026;01;AIGH;+24.750;+24.800;0 199706020027;01;AIGH;+24.700;+24.800;0 199706020032;01;AIGH;+24.750;+24.800;0 199706020036;01;AIGH;+24.700;+24.750;0 199706020037;02;AIGH;+24.750;+24.770;0 199706020039;01;ANZS;+24.700;+24.800;0 199706020040;01;BBLH;+24.700;+24.800;0 199706020042;01;AIGH;+24.800;+24.900;0 199706020043;01;AIGH;+24.800;+24.850;0 199706020044;01;UOBX;+24.800;+24.900;0 199706020045;01;AIGH;+24.750;+24.850;0 199706020045;01;AIGH;+24.800;+24.850;0 199706020049;01;HKBK;+24.770;+24.870;0 199706020051;01;AIGH;+24.750;+24.850;0 199706020051;01;AIGH;+24.800;+24.850;0 199706020102;01;AIGH;+24.820;+24.870;0 199706020106;01;AIGH;+24.800;+24.850;0 199706020106;01;UOBX;+24.780;+24.980;0 199706020107;01;AIGH;+24.720;+24.820;0 199706020108;01;ANZM;+24.620;+24.820;0 199706020108;01;AIGH;+24.800;+24.820;0 199706020111;01;AIGH;+24.800;+24.810;0 199706020115;01;AIGH;+24.700;+24.800;0 199706020116;01;AIGH;+24.770;+24.800;0 199706020120;01;MBRC;+24.750;+24.850;0 199706020120;01;AIGH;+24.850;+25.000;0 199706020121;01;AIGH;+24.750;+24.850;0 199706020121;01;UOBX;+24.780;+25.780;0 199706020121;01;AIGH;+24.850;+24.900;0 199706020123;01;AIGH;+24.820;+24.870;0 199706020123;01;AIGH;+24.850;+24.870;0 199706020124;01;AIGH;+24.750;+24.850;0 199706020126;01;HKBK;+24.750;+24.850;0 199706020128;01;AIGH;+24.840;+24.860;0 199706020129;01;ANZM;+24.750;+24.850;0 199706020130;01;AIGH;+24.840;+24.850;0 199706020131;01;GBNP;+24.800;+24.900;0 199706020132;01;AIGH;+24.800;+24.850;0 199706020138;01;AIGH;+24.840;+24.890;0 199706020143;01;AIGH;+24.830;+24.880;0 199706020144;01;AIGH;+24.820;+24.870;0 199706020144;01;AIGH;+24.850;+24.870;0 199706020145;01;AIGH;+24.850;+24.860;0 199706020147;01;AIGH;+24.800;+24.850;0 199706020150;01;BOAS;+24.800;+24.850;0 199706020152;01;AIGH;+24.750;+24.850;0 199706020154;01;AIGH;+24.840;+24.850;0 199706020159;01;AIGH;+24.800;+24.850;0 199706020208;02;BOAT;+25.000;+25.840;0 199706020209;01;AIGH;+24.850;+24.900;0 199706020209;01;BOAT;+25.100;+25.840;0 199706020209;01;BOAT;+25.150;+25.840;0 199706020209;02;AIGH;+24.870;+24.890;0 199706020210;01;ABNP;+25.200;+25.850;0 199706020210;01;BOAT;+25.250;+25.840;0 199706020210;01;BOAT;+25.300;+25.840;0 199706020210;01;BOAT;+25.350;+25.840;0 199706020210;01;BOAT;+25.400;+25.840;0 199706020211;01;BOAT;+25.450;+25.840;0 199706020213;01;ANZM;+25.250;+25.450;0 199706020214;01;AIGH;+24.810;+24.860;0 199706020214;02;ANZM;+24.810;+24.860;0 199706020217;01;AIGH;+24.800;+24.850;0 199706020225;01;AIGH;+24.840;+24.890;0 199706020236;01;BOAS;+24.840;+24.890;0 199706020247;01;AIGH;+24.810;+24.860;0 199706020248;01;AIGH;+24.800;+24.850;0 199706020312;01;AIGH;+24.780;+24.830;0 199706020315;01;CTBT;+25.835;+25.855;0 199706020338;01;TMBB;+25.835;+25.855;0 199706020340;01;ABNP;+25.840;+25.850;0 199706020358;01;SCBK;+25.830;+25.850;0 199706020409;01;HKBK;+25.600;+25.800;0 199706020411;01;HKBK;+25.550;+25.770;0 199706020412;01;HKBK;+25.500;+25.700;0 199706020412;01;HKBK;+25.480;+25.680;0 199706020414;01;HKBK;+25.460;+25.660;0 199706020421;01;BOAT;+25.840;+25.850;0 199706020422;01;HKBK;+25.750;+25.950;0 199706020422;01;HKBK;+25.700;+25.900;0 199706020422;01;HKBK;+25.500;+25.600;0 199706020422;02;HKBK;+25.460;+25.560;0 199706020423;01;BOAT;+25.835;+25.850;0 199706020423;01;HKBK;+25.460;+25.560;0 199706020424;01;BOAT;+25.840;+25.850;0 199706020451;01;AIGH;+24.750;+24.850;0 199706020451;01;AIGH;+24.700;+24.800;0 199706020454;01;BOAS;+24.800;+24.850;0 199706020457;02;HKBK;+24.820;+24.870;0 199706020503;01;HKBK;+24.840;+24.890;0 199706020506;01;AIGH;+24.850;+24.860;0 199706020509;01;UBRC;+24.830;+24.880;0 199706020510;01;AIGH;+24.840;+24.870;0 199706020514;01;MBRC;+24.810;+24.860;0 199706020519;01;MBRC;+24.830;+24.880;0 199706020528;01;BBLT;+24.880;+25.880;0 199706020529;01;BBLT;+25.000;+25.900;0 199706020530;01;BBLT;+25.100;+25.950;0 199706020531;01;MBRC;+24.800;+24.850;0 199706020531;01;BBLT;+25.100;+25.850;0 199706020531;02;UOBX;+24.950;+25.950;0 199706020532;01;BBLT;+25.100;+25.850;0 199706020532;01;AIGH;+24.840;+24.860;0 199706020532;01;BBLT;+25.100;+25.850;0 199706020532;01;AIGH;+24.840;+24.850;0 199706020533;01;BBLT;+25.050;+25.850;0 199706020537;01;HKBK;+24.835;+24.885;0 199706020537;01;AIGH;+24.850;+24.870;0 199706020548;01;HKBK;+24.820;+24.920;0 199706020549;01;AIGH;+24.840;+24.860;0 199706020553;01;BGFX;+24.800;+24.900;0 199706020554;01;EMFY;+24.800;+24.900;0 199706020557;01;AIGH;+24.800;+24.850;0 199706020604;01;NWBO;+24.790;+24.798;0 199706020607;01;CHIC;+24.800;+24.900;0 199706020621;01;AIGH;+24.820;+24.850;0 199706020635;01;BGFX;+24.770;+24.870;0 199706020637;01;BBLT;+24.870;+25.870;0 199706020638;01;BBLT;+25.000;+25.845;0 199706020639;01;BBLT;+25.100;+25.850;0 199706020641;02;MBRC;+24.810;+24.860;0 199706020644;01;WBCM;+24.800;+24.870;0 199706020650;01;AIGH;+24.830;+24.860;0 199706020652;01;HKBK;+24.830;+24.930;0 199706020702;01;SCFE;+24.750;+24.850;0 199706020705;02;BGFX;+24.750;+24.850;0 199706020707;01;BBLT;+24.800;+25.800;0 199706020707;01;BBLT;+25.000;+25.800;0 199706020708;01;BOAT;+25.305;+25.845;0 199706020708;01;BOAT;+25.505;+25.845;0 199706020709;01;BBLT;+25.700;+25.850;0 199706020709;01;BOAT;+25.805;+25.845;0 199706020709;01;BBLT;+25.800;+25.850;0 199706020709;01;BBLT;+25.820;+25.850;0 199706020709;01;ABNP;+25.810;+25.840;0 199706020710;01;ABNP;+25.820;+25.850;0 199706020710;01;BBLT;+25.825;+25.845;0 199706020710;01;BOAT;+25.825;+25.845;0 199706020711;01;ABNP;+25.832;+25.842;0 199706020713;01;BGFX;+24.785;+24.885;0 199706020714;01;AIGH;+24.870;+24.880;0 199706020715;01;BOAT;+25.825;+25.840;0 199706020726;01;SCFE;+25.800;+25.900;0 199706020732;01;MBRC;+25.800;+25.870;0 199706020733;01;SCFE;+24.800;+24.900;0 199706020734;01;AIGH;+24.850;+24.860;0 199706020744;01;AIGH;+24.860;+24.910;0 199706020745;01;BGFX;+24.835;+24.935;0 199706020747;01;HKBK;+24.860;+24.960;0 199706020749;01;HKBK;+24.870;+24.940;0 199706020749;01;AIGH;+24.810;+24.860;0 199706020750;01;AIGH;+24.800;+24.850;0 199706020752;01;AIGH;+24.790;+24.840;0 199706020753;01;HKBK;+24.800;+24.900;0 199706020753;01;AIGH;+24.750;+24.850;0 199706020757;01;AIGH;+24.730;+24.830;0 199706020801;01;EMFY;+24.750;+24.850;0 199706020801;01;HKBK;+24.820;+24.870;0 199706020802;01;AIGH;+24.820;+24.850;0 199706020803;02;AIGH;+24.770;+24.820;0 199706020809;01;AIGH;+24.850;+24.900;0 199706020813;01;BGFX;+24.825;+24.925;0 199706020813;01;MBRC;+24.830;+24.880;0 199706020816;01;UOBX;+24.780;+25.780;0 199706020826;01;HKBK;+24.800;+24.900;0 199706020828;01;CHIC;+24.810;+24.910;0 199706020829;01;CBAX;+24.800;+24.900;0 199706020841;01;BNSV;+24.800;+24.900;0 199706020901;01;AIGH;+24.850;+24.950;0 199706020906;01;BBLT;+25.000;+25.900;0 199706020906;01;BBLT;+25.000;+25.800;0 199706020907;01;BBLT;+25.150;+25.850;0 199706020910;01;HKBK;+24.830;+24.880;0 199706020919;01;AIGH;+24.770;+24.870;0 199706020923;01;BGFX;+24.770;+24.870;0 199706020931;01;AIGH;+24.750;+24.850;0 199706020958;02;DBBK;+24.830;+24.840;0 199706021008;00;SCFE;+24.770;+24.870;0 199706021011;00;DBBK;+24.830;+25.840;0 199706021013;00;DBBK;+24.831;+25.841;0 199706021041;00;SCFE;+24.780;+24.880;0 199706021043;00;CBAX;+24.750;+24.850;0 199706021051;00;BNST;+24.780;+24.880;0 199706021056;00;AIGH;+24.800;+24.850;0 199706021056;00;DBBK;+24.830;+25.840;0 199706021056;00;DBBK;+24.830;+24.840;0 199706021104;00;AIGH;+24.800;+24.900;0 199706021124;00;AIGH;+24.750;+24.850;0 199706021139;00;CHIC;+24.800;+24.900;0 199706021142;00;AIGH;+24.820;+24.870;0 199706021147;00;AIGH;+24.750;+24.850;0 199706021153;00;AIGH;+24.730;+24.830;0 199706021159;00;AIGH;+24.830;+24.930;0 199706021200;00;AIGH;+24.840;+24.890;0 199706021200;00;AIGH;+24.850;+24.950;0 199706021203;00;AIGH;+24.800;+24.900;0 199706021208;00;AIGH;+24.780;+24.880;0 199706021209;00;AIGH;+24.850;+24.900;0 199706021212;00;AIGH;+24.850;+24.870;0 199706021216;00;SCEX;+24.850;+24.900;0 199706021225;00;BGFX;+24.825;+24.925;0 199706021314;00;CBAX;+24.800;+24.900;0 199706021341;00;BGFX;+24.800;+24.900;0 199706022155;00;CBAP;+24.800;+24.850;0 199706022156;00;ANZM;+24.790;+24.890;0 199706022157;00;CBAP;+24.800;+24.900;0 199706022157;00;CBAP;+24.800;+24.950;0 199706022157;00;CBAP;+24.800;+24.850;0 199706022221;00;CBAP;+24.800;+25.000;0 199706022250;00;ANZM;+24.800;+24.850;0 199706022358;00;HKBK;+24.800;+24.880;0 199706022358;00;HKBK;+24.800;+24.900;0 199706030006;00;MBRC;+24.800;+24.900;0 199706030035;00;ANZS;+24.800;+24.900;0 199706030046;00;UOBX;+24.790;+25.290;0 199706030129;00;ABNP;+24.850;+25.000;0 199706030130;00;ABNP;+24.950;+25.100;0 199706030130;00;ABNP;+25.000;+25.400;0 199706030144;00;SUMS;+24.800;+24.900;0 199706030159;00;ANZM;+24.850;+24.950;0 199706030202;06;ABNP;+25.000;+25.200;0 199706030202;06;ABNP;+25.840;+25.870;0 199706030211;00;ABNP;+25.860;+25.870;0 199706030212;00;ABNP;+25.855;+25.875;0 199706030245;00;DBBK;+25.865;+25.875;0 199706030255;00;ANZM;+24.700;+24.800;0 199706030256;00;AIGH;+24.670;+24.700;0 199706030256;00;AIGH;+24.670;+24.770;0 199706030256;00;HKBK;+24.730;+24.780;0 199706030319;00;MBRC;+24.730;+24.780;0 199706030321;00;BBLT;+24.860;+24.870;0 199706030321;00;BBLT;+24.960;+24.970;0 199706030322;00;BBLT;+25.000;+25.100;0 199706030322;00;ANZM;+24.730;+24.780;0 199706030323;00;TDBB;+25.855;+25.875;0 199706030325;00;ABNP;+25.865;+25.870;0 199706030326;00;HKBK;+24.740;+24.790;0 199706030340;00;CTBT;+25.860;+25.870;0 199706030344;00;TDBB;+25.860;+25.870;0 199706030349;00;ABNP;+25.858;+25.872;0 199706030353;00;SCBK;+25.850;+25.870;0 199706030355;00;BOAT;+25.860;+25.870;0 199706030355;00;BOAT;+25.860;+25.875;0 199706030408;00;HKBK;+24.730;+24.780;0 199706030411;00;BOAS;+24.700;+24.800;0 199706030446;00;AIGH;+24.650;+24.750;0 199706030450;00;ANZM;+24.630;+24.730;0 199706030459;00;MBRC;+24.650;+24.750;0 199706030501;00;AIGH;+24.590;+24.690;0 199706030511;00;HKBK;+24.600;+24.700;0 199706030515;00;ANZM;+24.550;+24.650;0 199706030516;00;SUMS;+24.600;+24.700;0 199706030520;00;AIGH;+24.520;+24.620;0 199706030520;00;HKBK;+24.510;+24.610;0 199706030525;00;HKBK;+24.550;+24.650;0 199706030526;00;AIGH;+24.500;+24.600;0 199706030526;00;BBLS;+24.600;+24.700;0 199706030528;00;ANZM;+24.530;+24.630;0 199706030529;00;SUMS;+24.550;+24.650;0 199706030535;01;ANZM;+24.480;+24.580;0 199706030536;00;HKBK;+24.520;+24.620;0 199706030539;00;HKBK;+24.490;+24.590;0 199706030542;00;HKBK;+24.460;+24.560;0 199706030543;00;ANZM;+24.450;+24.550;0 199706030545;00;HKBK;+24.490;+24.590;0 199706030555;00;NWBO;+24.490;+24.495;0 199706030557;00;HKBK;+24.420;+24.520;0 199706030558;00;MBRC;+24.450;+24.550;0 199706030558;00;NWBO;+24.450;+24.455;0 199706030600;00;BGFX;+24.400;+24.500;0 199706030603;00;CHIC;+24.450;+24.550;0 199706030623;00;SHDR;+24.450;+24.550;0 199706030625;00;BBLS;+24.550;+24.650;0 199706030628;00;BGFX;+24.500;+24.600;0 199706030630;00;CBAX;+24.500;+24.600;0 199706030630;00;EMFY;+24.500;+24.600;0 199706030635;00;BBLS;+24.550;+24.600;0 199706030637;00;BGFX;+24.525;+24.625;0 199706030637;00;CTRD;+24.500;+24.600;0 199706030637;00;CTRD;+24.490;+24.590;0 199706030645;00;NWBO;+24.570;+24.576;0 199706030646;00;ANZS;+24.600;+24.650;0 199706030654;00;SCFE;+24.600;+24.700;0 199706030654;00;WBCM;+24.580;+24.650;0 199706030701;00;HKBK;+24.650;+24.750;0 199706030705;00;MBRC;+24.600;+24.700;0 199706030728;00;CBAX;+24.650;+24.750;0 199706030731;00;CHIC;+24.670;+24.770;0 199706030747;00;SUMS;+24.700;+24.750;0 199706030753;00;NWBO;+24.650;+24.657;0 199706030759;00;BBLH;+24.680;+24.780;0 199706030806;00;MBRC;+24.650;+24.750;0 199706030808;00;AIGH;+24.700;+24.800;0 199706030814;00;EMFY;+24.650;+24.750;0 199706030825;01;BNSV;+24.650;+24.750;0 199706030836;00;HKBK;+24.660;+24.760;0 199706030847;00;HKBK;+24.700;+24.800;0 199706030856;00;MBRC;+24.670;+24.770;0 199706030904;00;BOAS;+24.700;+24.750;0 199706030929;00;CHIC;+24.660;+24.760;0 199706030957;00;HKBK;+24.670;+24.770;0 199706031010;00;DBBK;+24.660;+24.760;0 199706031012;00;DBBK;+24.660;+24.730;0 199706031013;00;BBLT;+24.750;+25.850;0 199706031015;00;BBLT;+24.900;+25.500;0 199706031015;00;DBBK;+24.650;+24.658;0 199706031016;00;EMFY;+24.660;+24.760;0 199706031016;00;DBBK;+24.655;+24.658;0 199706031016;00;BBLT;+24.900;+25.800;0 199706031017;00;DBBK;+24.670;+24.740;0 199706031017;00;BBLT;+24.950;+25.500;0 199706031019;00;BBLT;+24.950;+25.900;0 199706031020;00;BBLT;+24.990;+25.890;0 199706031020;00;BBLT;+25.000;+25.850;0 199706031021;00;BOAT;+25.000;+25.875;0 199706031021;00;BOAT;+25.100;+25.875;0 199706031021;00;BBLT;+25.100;+25.850;0 199706031021;00;BOAT;+25.300;+25.875;0 199706031021;00;BBLT;+25.300;+25.850;0 199706031022;00;BBLT;+25.700;+25.850;0 199706031022;00;BBLT;+25.800;+25.850;0 199706031022;00;BOAT;+25.800;+25.875;0 199706031022;00;BOAT;+25.820;+25.875;0 199706031022;00;BOAT;+25.820;+25.850;0 199706031023;00;CTBT;+25.840;+25.860;0 199706031023;00;CTBT;+25.845;+25.865;0 199706031023;00;CTBT;+25.845;+25.855;0 199706031045;00;CHIC;+24.700;+24.800;0 199706031056;00;CHIC;+24.690;+24.790;0 199706031116;00;DBBK;+24.500;+24.600;0 199706031122;00;BGFX;+24.500;+24.600;0 199706031126;00;CHIC;+24.720;+24.820;0 199706031200;00;CHIC;+24.800;+24.900;0 199706031202;00;CHIC;+24.840;+24.940;0 199706031204;00;SCEX;+24.900;+25.000;0 199706031214;00;CHIC;+24.870;+24.970;0 199706031216;00;EMFY;+24.880;+24.980;0 199706031235;00;SCFE;+24.850;+24.950;0 199706031250;00;BGFX;+24.850;+24.950;0 199706031334;00;CBAX;+24.820;+24.920;0 199706031342;00;EMFY;+24.850;+24.950;0 199706031412;00;BNSV;+24.850;+24.950;0 199706031524;00;SCEX;+24.820;+24.920;0 199706031836;00;SBCN;+24.850;+24.920;0 199706031836;00;SBCN;+24.850;+24.950;0 199706032125;00;ANZM;+24.800;+24.900;0 199706032341;00;MBRC;+24.800;+24.900;0 199706040027;00;HKBK;+24.820;+24.890;0 199706040033;00;BOAS;+24.800;+24.900;0 199706040044;00;HKBK;+24.800;+24.900;0 199706040046;00;SUMS;+24.750;+24.850;0 199706040046;00;MBRC;+24.720;+24.820;0 199706040052;00;MBRC;+24.250;+24.350;0 199706040052;00;HKBK;+24.250;+24.350;0 199706040052;00;AIGH;+24.250;+24.300;0 199706040053;00;MBRC;+24.270;+24.370;0 199706040055;00;UOBX;+24.280;+24.480;0 199706040056;00;SUMS;+24.300;+24.500;0 199706040056;00;MBRC;+24.380;+24.480;0 199706040057;00;MBRC;+24.330;+24.430;0 199706040100;00;BBLH;+24.400;+24.500;0 199706040101;00;BOAS;+24.400;+24.500;0 199706040111;00;ABNP;+24.200;+24.600;0 199706040114;00;ABNP;+24.400;+24.600;0 199706040115;00;SUMS;+24.450;+24.650;0 199706040117;00;MBRC;+24.450;+24.550;0 199706040119;00;MBRC;+24.500;+24.600;0 199706040124;00;AIGH;+24.430;+24.530;0 199706040145;00;ABNP;+25.845;+25.955;0 199706040146;00;ABNP;+25.846;+25.856;0 199706040215;00;TDBB;+25.850;+25.860;0 199706040216;00;CTRD;+24.550;+24.650;0 199706040218;00;HKBK;+24.550;+24.650;0 199706040221;00;SUMS;+24.450;+24.550;0 199706040223;00;CTRD;+24.500;+24.600;0 199706040226;00;AIGH;+24.450;+24.550;0 199706040226;00;BBLH;+24.500;+24.600;0 199706040229;00;BOAS;+24.500;+24.550;0 199706040234;00;AIGH;+24.400;+24.500;0 199706040239;00;DBBK;+24.550;+24.650;0 199706040239;00;CTRD;+24.490;+24.590;0 199706040239;00;CTRD;+24.500;+24.600;0 199706040256;00;BBLS;+24.480;+24.580;0 199706040313;00;AIGH;+24.470;+24.490;0 199706040318;00;TMBB;+25.850;+25.855;0 199706040330;00;ABNP;+25.845;+25.855;0 199706040338;00;CTBT;+25.847;+25.857;0 199706040341;00;ANZM;+25.700;+25.900;0 199706040341;00;ANZM;+25.600;+25.800;0 199706040342;00;ANZM;+25.500;+25.700;0 199706040344;00;SCBK;+25.850;+25.855;0 199706040424;00;MBRC;+24.450;+24.550;0 199706040426;00;HKBK;+24.430;+24.530;0 199706040440;00;MBRC;+24.400;+24.500;0 199706040445;00;BBLS;+24.350;+24.450;0 199706040457;00;BBLH;+24.400;+24.500;0 199706040457;00;BBLS;+24.330;+24.430;0 199706040506;00;MBRC;+24.300;+24.400;0 199706040510;00;AIGH;+24.250;+24.350;0 199706040511;00;AIGH;+24.200;+24.300;0 199706040511;00;AIGH;+24.300;+24.350;0 199706040513;00;AIGH;+24.250;+24.350;0 199706040519;00;AIGH;+24.220;+24.320;0 199706040520;00;AIGH;+24.200;+24.300;0 199706040521;00;AIGH;+24.180;+24.280;0 199706040521;00;HKBK;+24.220;+24.320;0 199706040522;00;BBLH;+24.300;+24.400;0 199706040522;00;AIGH;+24.300;+24.350;0 199706040523;00;HKBK;+24.250;+24.350;0 199706040531;00;CTBT;+25.848;+25.858;0 199706040535;00;MBRC;+24.250;+24.350;0 199706040544;00;NWBO;+24.250;+24.253;0 199706040553;00;BBLH;+24.350;+24.450;0 199706040553;00;NWBO;+24.330;+24.334;0 199706040554;00;AIGH;+24.230;+24.330;0 199706040555;00;NWBO;+24.300;+24.304;0 199706040555;00;BOAT;+25.845;+25.855;0 199706040557;00;BGFX;+24.300;+24.400;0 199706040612;00;CHAB;+25.850;+25.860;0 199706040613;00;BOAS;+24.300;+24.400;0 199706040618;00;CHIC;+24.300;+24.400;0 199706040622;00;BGFX;+24.250;+24.350;0 199706040627;00;SUMS;+24.200;+24.500;0 199706040631;00;MBRC;+24.300;+24.400;0 199706040635;00;CTBT;+25.845;+25.855;0 199706040635;00;CHIC;+24.350;+24.450;0 199706040636;00;UOBX;+24.300;+25.300;0 199706040639;00;CHIC;+24.340;+24.440;0 199706040640;00;HKBK;+24.320;+24.420;0 199706040641;00;BBLH;+24.360;+24.460;0 199706040641;00;CBAX;+24.300;+24.400;0 199706040648;00;CHIC;+24.400;+24.500;0 199706040649;00;MBRC;+24.350;+24.450;0 199706040650;00;NWBO;+24.370;+24.374;0 199706040656;00;EMFY;+24.350;+24.450;0 199706040701;01;UOBX;+24.300;+24.600;0 199706040702;00;INDS;+24.400;+24.500;0 199706040704;00;BBLS;+24.350;+24.450;0 199706040707;00;WBCM;+24.350;+24.420;0 199706040713;00;BGFX;+24.335;+24.435;0 199706040716;00;INBT;+25.850;+25.870;0 199706040717;00;INDS;+24.300;+24.400;0 199706040717;00;INDS;+24.350;+24.450;0 199706040733;00;HKBK;+24.360;+24.420;0 199706040739;00;ABNP;+25.850;+25.860;0 199706040746;00;HKBK;+24.350;+24.450;0 199706040754;00;BATH;+25.853;+25.858;0 199706040755;00;BNSV;+24.380;+24.480;0 199706040801;00;AIGH;+24.350;+24.450;0 199706040811;00;AIGH;+24.320;+24.420;0 199706040812;00;AIGH;+24.300;+24.400;0 199706040817;00;AIGH;+24.250;+24.350;0 199706040822;00;NWBO;+24.250;+24.253;0 199706040826;00;MBRC;+24.300;+24.400;0 199706040830;00;HKBK;+24.330;+24.430;0 199706040833;00;SBIC;+24.30;+24.40;0 199706040835;00;NWBO;+24.350;+24.354;0 199706040837;00;SCFE;+24.350;+24.450;0 199706040837;00;SCBK;+25.850;+25.860;0 199706040845;00;HKBK;+24.350;+24.450;0 199706040845;00;HKBK;+24.340;+24.440;0 199706040903;00;ABNP;+25.843;+25.848;0 199706040905;00;CHIC;+24.410;+24.510;0 199706040911;00;BOAS;+24.400;+24.500;0 199706040929;00;AIGH;+24.350;+24.450;0 199706040931;00;AIGH;+24.360;+24.410;0 199706041000;00;BBLH;+24.400;+24.500;0 199706041007;00;AIGH;+24.370;+24.420;0 199706041021;00;AIGH;+24.320;+24.370;0 199706041025;00;CTBT;+25.840;+25.850;0 199706041034;00;SCFE;+24.320;+24.420;0 199706041044;00;AIGH;+24.260;+24.360;0 199706041057;00;NWBO;+24.300;+24.304;0 199706041114;00;CHIC;+24.340;+24.440;0 199706041155;00;AIGH;+24.280;+24.380;0 199706041159;00;AIGH;+24.250;+24.350;0 199706041213;00;AIGH;+24.200;+24.300;0 199706041217;00;BGFX;+24.200;+24.300;0 199706041233;00;SCEX;+24.380;+24.480;0 199706041236;00;AIGH;+24.290;+24.390;0 199706041303;00;SCEX;+24.350;+24.450;0 199706041319;00;AIGH;+24.300;+24.400;0 199706041328;00;EMFY;+24.380;+24.480;0 199706041329;00;CHIC;+24.320;+24.420;0 199706041438;00;AIGH;+24.500;+24.550;0 199706041448;00;AIGH;+24.600;+24.700;0 199706041509;00;CHIC;+24.500;+24.600;0 199706041511;00;SCFE;+24.500;+24.600;0 199706041523;00;AIGH;+24.550;+24.650;0 199706041524;00;CHIC;+24.470;+24.570;0 199706041533;00;AIGH;+24.500;+24.600;0 199706041540;00;AIGH;+24.600;+24.700;0 199706041555;00;AIGH;+24.500;+24.600;0 199706041732;00;SCEX;+24.500;+24.600;0 199706041818;00;SCEX;+24.430;+24.530;0 199706042036;00;BNST;+24.440;+24.450;0 199706042036;00;BNST;+24.430;+24.440;0 199706042039;00;ANZM;+24.380;+24.480;0 199706042041;00;BNST;+28.050;+28.060;0 199706042041;00;BNST;+24.400;+24.410;0 199706042220;00;ANZM;+24.450;+24.550;0 199706042327;00;MBRC;+24.450;+24.500;0 199706042332;00;SIME;+24.400;+24.500;0 199706042353;00;MBRC;+24.420;+24.520;0 199706050005;00;HKBK;+24.400;+24.500;0 199706050008;00;HKBK;+24.500;+24.600;0 199706050011;00;CTBT;+25.850;+25.860;0 199706050017;00;MBRC;+24.450;+24.550;0 199706050020;00;MBRC;+24.380;+24.480;0 199706050025;00;BBLS;+24.470;+24.570;0 199706050026;00;BBLH;+24.450;+24.550;0 199706050027;00;BBLS;+24.480;+24.580;0 199706050028;00;BBLS;+24.500;+24.600;0 199706050030;00;BBLS;+24.530;+24.630;0 199706050040;00;ANZM;+24.500;+24.600;0 199706050046;00;AIGH;+24.550;+24.650;0 199706050051;00;HKBK;+24.520;+24.620;0 199706050055;00;UOBX;+24.500;+24.700;0 199706050105;00;MBRC;+24.500;+24.600;0 199706050109;00;SUMS;+24.200;+24.400;0 199706050109;00;CHAB;+25.855;+25.865;0 199706050113;00;AIGH;+24.150;+24.250;0 199706050114;00;MBRC;+24.200;+24.300;0 199706050115;00;MBRC;+24.150;+24.250;0 199706050115;00;AIGH;+24.100;+24.200;0 199706050116;00;AIGH;+24.050;+24.150;0 199706050118;00;MBRC;+24.020;+24.120;0 199706050119;00;AIGH;+24.000;+24.100;0 199706050123;00;AIGH;+23.950;+24.050;0 199706050123;00;HKBK;+24.050;+24.150;0 199706050132;00;ABNP;+25.850;+25.870;0 199706050133;00;BBLS;+24.050;+24.150;0 199706050135;00;MBRC;+24.100;+24.200;0 199706050139;00;ABNP;+25.850;+25.860;0 199706050141;00;HKBK;+24.080;+24.180;0 199706050141;00;ABNP;+25.852;+25.862;0 199706050142;00;HKBK;+24.120;+24.220;0 199706050144;00;AIGH;+24.090;+24.190;0 199706050152;00;MTKB;+25.830;+25.860;0 199706050153;00;HKBK;+24.140;+24.240;0 199706050155;00;ANZM;+24.170;+24.200;0 199706050156;00;BBLT;+25.835;+25.865;0 199706050158;00;AIGH;+24.100;+24.200;0 199706050200;00;BBLT;+25.845;+25.855;0 199706050201;00;INBT;+25.840;+25.860;0 199706050201;00;TDBB;+25.840;+25.860;0 199706050205;04;BATH;+25.840;+25.858;0 199706050206;03;SUMS;+24.000;+24.500;0 199706050206;03;BATH;+25.840;+25.860;0 199706050207;02;MBRC;+24.050;+24.150;0 199706050208;01;DBSS;+24.150;+24.200;0 199706050215;00;GBNP;+24.100;+24.200;0 199706050241;00;DBSS;+24.140;+24.210;0 199706050252;00;BBLT;+25.850;+25.860;0 199706050258;00;AIGH;+24.000;+24.100;0 199706050322;00;SCBK;+25.835;+25.845;0 199706050326;00;ABNP;+25.838;+25.845;0 199706050327;00;TMBB;+25.835;+25.845;0 199706050329;00;AIGH;+23.750;+23.950;0 199706050331;00;HKBK;+23.900;+24.000;0 199706050333;00;TDBB;+25.835;+25.840;0 199706050338;00;AIGH;+23.850;+23.950;0 199706050341;00;CTBT;+25.838;+25.848;0 199706050341;00;BBLS;+24.830;+24.930;0 199706050342;00;BBLS;+23.830;+23.930;0 199706050342;00;BBLT;+25.830;+25.845;0 199706050342;00;DBBK;+23.800;+23.850;0 199706050342;00;DBBK;+25.800;+25.850;0 199706050343;00;DBBK;+24.800;+24.850;0 199706050343;00;DBBK;+25.830;+25.840;0 199706050350;00;AIGH;+23.800;+23.900;0 199706050356;00;HKBK;+23.880;+23.980;0 199706050404;00;HKBK;+23.900;+24.000;0 199706050407;00;ABNP;+25.832;+25.842;0 199706050409;00;ABNP;+25.831;+25.838;0 199706050411;00;HKBK;+23.910;+24.010;0 199706050411;00;MBRC;+23.800;+24.000;0 199706050420;00;DBBK;+25.835;+25.845;0 199706050431;00;ANZM;+23.800;+23.900;0 199706050434;00;HKBK;+23.900;+24.000;0 199706050442;01;AIGH;+23.860;+23.960;0 199706050503;00;AIGH;+23.850;+23.950;0 199706050504;00;AIGH;+23.800;+23.900;0 199706050504;00;HKBK;+23.880;+23.980;0 199706050507;00;AIGH;+23.900;+23.950;0 199706050507;00;UOBX;+23.800;+24.100;0 199706050519;00;CTRD;+23.900;+24.000;0 199706050519;00;CTRD;+23.850;+23.950;0 199706050520;00;HKBK;+23.920;+24.020;0 199706050521;00;MBRC;+23.900;+24.000;0 199706050532;00;SUMS;+23.940;+24.040;0 199706050540;00;UBRC;+24.000;+24.100;0 199706050547;00;AIGH;+23.950;+24.000;0 199706050548;00;HKBK;+24.000;+24.100;0 199706050549;00;HKBK;+24.030;+24.130;0 199706050549;00;GBNP;+24.000;+24.100;0 199706050550;00;BGFX;+24.000;+24.100;0 199706050559;00;ABNP;+25.825;+25.835;0 199706050607;00;TDBB;+25.825;+25.835;0 199706050608;00;EMFY;+23.900;+24.000;0 199706050609;00;NWBO;+23.900;+23.910;0 199706050611;00;SUMS;+24.000;+24.200;0 199706050612;00;HKBK;+24.000;+24.100;0 199706050613;00;MBRC;+24.000;+25.000;0 199706050615;00;CTRD;+24.000;+24.200;0 199706050616;00;BNST;+24.430;+24.440;0 199706050616;00;BNST;+28.050;+28.060;0 199706050616;00;BNST;+24.400;+24.410;0 199706050617;00;CHIC;+23.950;+24.150;0 199706050618;00;BGFX;+23.900;+24.000;0 199706050619;00;MBRC;+24.000;+24.100;0 199706050619;00;ANZS;+24.000;+24.100;0 199706050620;00;ABNP;+25.826;+25.836;0 199706050621;00;BBLT;+25.830;+25.840;0 199706050625;00;EMFY;+24.020;+24.120;0 199706050626;00;CHIC;+24.000;+24.150;0 199706050631;00;SCRS;+24.000;+24.707;0 199706050631;00;SCRS;+24.000;+24.100;0 199706050631;00;SCRS;+23.900;+24.100;0 199706050632;00;UBRC;+24.100;+24.200;0 199706050632;00;WBCM;+24.000;+24.010;0 199706050632;00;WBCM;+24.000;+24.100;0 199706050632;00;SUMS;+24.020;+24.220;0 199706050632;00;ABNP;+25.825;+25.835;0 199706050633;00;ABNP;+25.827;+25.835;0 199706050633;00;ABNP;+25.825;+25.833;0 199706050634;00;SCRS;+24.200;+24.300;0 199706050634;00;MBRC;+24.100;+24.200;0 199706050638;00;ABNP;+25.800;+25.840;0 199706050638;00;HKBK;+24.150;+24.250;0 199706050638;00;SCRS;+24.250;+24.500;0 199706050639;00;HKBK;+24.160;+24.260;0 199706050640;00;HKBK;+24.120;+24.220;0 199706050645;00;SUMS;+24.020;+24.120;0 199706050648;00;CBAX;+24.050;+24.150;0 199706050650;00;SCRS;+24.000;+24.100;0 199706050654;00;BGFX;+24.000;+24.100;0 199706050655;00;AIGH;+23.950;+24.050;0 199706050703;00;SCFE;+23.950;+24.050;0 199706050711;00;ABNP;+25.825;+25.835;0 199706050716;00;EMFY;+23.950;+24.050;0 199706050718;00;BGFX;+23.950;+24.050;0 199706050742;00;BNSV;+24.000;+24.100;0 199706050746;00;NWBO;+23.950;+23.950;0 199706050747;00;BGFX;+23.900;+24.000;0 199706050800;00;ABNP;+25.824;+25.831;0 199706050805;00;NWBO;+23.900;+23.910;0 199706050805;00;BBLH;+23.850;+23.950;0 199706050806;00;NWBO;+23.850;+23.859;0 199706050806;00;CHIC;+23.900;+24.000;0 199706050808;00;INBT;+25.830;+25.840;0 199706050809;00;SUMS;+24.920;+24.970;0 199706050810;00;SCFE;+23.900;+24.000;0 199706050810;00;SUMS;+23.920;+23.970;0 199706050811;00;SUMS;+23.950;+24.000;0 199706050814;00;SUMS;+23.940;+23.990;0 199706050816;00;HKBK;+23.920;+24.020;0 199706050816;00;SUMS;+23.900;+23.950;0 199706050816;00;HKBK;+23.940;+24.040;0 199706050821;00;AIGH;+23.850;+23.950;0 199706050825;00;MBRC;+23.900;+24.000;0 199706050834;00;AIGH;+23.830;+23.930;0 199706050838;00;CHIC;+23.910;+24.010;0 199706050845;00;CHAB;+25.825;+25.835;0 199706050847;00;SCFE;+23.880;+23.980;0 199706050852;00;MBRC;+23.950;+24.050;0 199706050853;00;HSBK;+25.820;+25.840;0 199706050854;00;CHIC;+23.970;+24.070;0 199706050857;00;NWBO;+23.950;+23.950;0 199706050926;00;SCFE;+24.040;+24.140;0 199706050936;00;WBCM;+24.010;+24.080;0 199706050943;00;NWBO;+24.030;+24.031;0 199706050943;00;NWBO;+24.000;+24.001;0 199706051016;00;BOAS;+24.000;+24.050;0 199706051108;00;CTBT;+25.815;+25.825;0 199706051111;00;WBCM;+24.020;+24.090;0 199706051111;00;SCFE;+24.030;+24.130;0 199706051134;00;SCEX;+24.100;+24.200;0 199706051136;00;WBCM;+24.000;+24.100;0 199706051240;00;NWBO;+23.900;+23.910;0 199706051241;00;SCFE;+23.850;+23.950;0 199706051245;00;BGFX;+23.850;+23.950;0 199706051303;00;NWBO;+23.850;+23.859;0 199706051312;00;SCFE;+23.860;+23.960;0 199706051346;00;CBAX;+23.900;+24.000;0 199706051346;00;CHIC;+23.900;+24.000;0 199706051357;00;EMFY;+23.900;+24.000;0 199706051443;00;BGFX;+23.900;+24.000;0 199706052126;00;ANZM;+23.950;+24.050;0 199706052338;00;MBRC;+23.950;+24.000;0 199706052338;00;MBRC;+24.000;+24.100;0 199706052354;00;MBRC;+23.900;+24.000;0 199706060012;00;HKBK;+23.950;+24.050;0 199706060028;00;BBLH;+23.900;+24.000;0 199706060028;00;ANZS;+23.900;+24.000;0 199706060030;00;BBLH;+23.800;+23.900;0 199706060032;00;HKBK;+23.800;+23.900;0 199706060044;00;GBNP;+23.750;+23.850;0 199706060045;00;UOBX;+23.750;+24.000;0 199706060049;00;INDS;+23.750;+23.850;0 199706060052;00;BBLH;+23.780;+23.880;0 199706060055;00;MBRC;+23.700;+23.800;0 199706060101;02;BBLH;+23.800;+23.900;0 199706060114;00;MBRC;+23.780;+23.880;0 199706060131;00;GBNP;+23.800;+23.900;0 199706060146;00;ABNP;+25.820;+25.840;0 199706060149;00;CTBT;+25.817;+25.827;0 199706060150;00;MBRC;+23.800;+23.900;0 199706060155;00;ANZM;+23.780;+23.880;0 199706060159;00;CTBT;+25.820;+25.830;0 199706060203;06;HKBK;+23.810;+23.910;0 199706060203;06;BBLS;+23.850;+23.900;0 199706060210;00;ABNP;+25.823;+25.833;0 199706060227;00;MBRC;+23.800;+23.850;0 199706060233;00;BLBS;+25.800;+25.850;0 199706060236;00;MBRC;+23.770;+23.870;0 199706060239;00;HKBK;+23.780;+23.880;0 199706060249;00;ABNP;+25.825;+25.835;0 199706060251;00;AIGH;+23.750;+23.850;0 199706060251;00;AIGH;+23.700;+23.800;0 199706060253;00;AIGH;+23.650;+23.750;0 199706060254;00;BBLH;+23.820;+23.920;0 199706060255;00;AIGH;+23.600;+23.700;0 199706060255;00;HKBK;+23.750;+23.850;0 199706060256;00;MBRC;+23.700;+23.850;0 199706060256;00;MBRC;+23.750;+23.850;0 199706060256;00;BBLS;+23.830;+23.880;0 199706060258;00;INBT;+25.825;+25.835;0 199706060317;00;BBLT;+25.825;+25.835;0 199706060322;00;ANZM;+23.750;+23.850;0 199706060334;00;CTBT;+25.825;+25.835;0 199706060337;00;AIGH;+23.680;+23.780;0 199706060350;00;TDBB;+25.820;+25.840;0 199706060355;00;ANZM;+23.770;+23.820;0 199706060357;00;SCBK;+25.825;+25.835;0 199706060404;00;ANZM;+23.750;+23.850;0 199706060423;00;ABNP;+25.824;+25.831;0 199706060435;00;ANZS;+23.800;+23.900;0 199706060437;00;ABNP;+25.819;+25.829;0 199706060449;00;BBLH;+23.800;+23.900;0 199706060506;00;BBLH;+23.850;+23.950;0 199706060522;00;MBRC;+23.830;+23.930;0 199706060524;00;BBLS;+23.850;+23.950;0 199706060553;00;HKBK;+23.850;+23.950;0 199706060610;00;HKSX;+25.850;+25.950;0 199706060610;00;EMFY;+23.850;+23.950;0 199706060611;00;BGFX;+23.850;+23.950;0 199706060612;00;BBLH;+23.900;+24.000;0 199706060617;00;ABNP;+25.815;+25.825;0 199706060619;00;MBRC;+23.950;+24.050;0 199706060627;00;BGFX;+23.950;+24.050;0 199706060628;-1;CHIC;+23.940;+24.040;0 199706060629;00;BGFX;+23.940;+24.040;0 199706060631;00;BBLH;+24.000;+24.100;0 199706060644;00;HKBK;+24.100;+24.200;0 199706060648;00;UBRC;+24.000;+24.100;0 199706060649;00;SCFE;+24.000;+24.100;0 199706060654;00;WBCM;+24.000;+24.070;0 199706060654;00;CBAX;+23.950;+24.050;0 199706060726;00;BBLS;+23.900;+24.000;0 199706060736;00;SBIC;+23.900;+24.000;0 199706060737;00;NWBO;+23.950;+23.950;0 199706060741;00;BBLH;+24.000;+24.050;0 199706060748;00;EMFY;+23.950;+24.050;0 199706060750;00;HKBK;+23.970;+24.070;0 199706060752;00;HKBK;+24.020;+24.120;0 199706060811;00;HKBK;+24.000;+24.100;0 199706060815;00;EMFY;+23.980;+24.080;0 199706060854;00;HKBK;+23.950;+24.100;0 199706060854;00;HKBK;+23.950;+24.050;0 199706060922;00;BOAT;+25.810;+25.830;0 199706060927;00;CTBT;+25.815;+25.825;0 199706060937;00;WBCM;+24.000;+24.100;0 199706060937;00;WBCM;+23.950;+24.050;0 199706060951;00;BGFX;+23.950;+24.050;0 199706061024;00;EMFY;+23.920;+24.020;0 199706061032;00;AIGH;+23.900;+24.000;0 199706061034;00;EMFY;+23.900;+24.000;0 199706061116;00;SCFE;+23.980;+24.080;0 199706061116;00;SCFE;+24.000;+24.100;0 199706061119;00;NWBO;+24.050;+24.051;0 199706061127;00;AIGH;+23.940;+24.040;0 199706061129;00;AIGH;+23.920;+24.020;0 199706061222;00;BGFX;+23.920;+24.020;0 199706061229;00;CHIC;+24.000;+24.100;0 199706061250;00;SCEX;+23.950;+24.050;0 199706061308;00;CHIC;+23.970;+24.070;0 199706061323;00;AIGH;+23.900;+24.000;0 199706061411;00;CHIC;+24.000;+24.100;0 199706061416;00;SCEX;+23.970;+24.070;0 199706061418;00;SCEX;+23.950;+24.050;0 199706061433;00;SCEX;+23.960;+24.060;0 199706061433;00;SCEX;+23.970;+24.070;0 199706061516;00;SCEX;+23.950;+24.050;0 199706061558;00;SCEX;+23.900;+24.005;0 199706061558;00;SCEX;+23.900;+24.000;0 199706061615;00;SCEX;+23.880;+23.980;0 199706061851;00;SCEX;+23.950;+24.050;0 199706061851;179;SCEX;+23.950;+24.050;0 199706071851;179;SCEX;+23.950;+24.050;0 199706082141;00;ANZM;+24.000;+24.100;0 199706090017;00;AIGH;+23.950;+24.050;0 199706090018;00;AIGH;+23.900;+24.000;0 199706090018;00;AIGH;+23.850;+23.950;0 199706090019;00;AIGH;+23.800;+23.900;0 199706090023;00;AIGH;+23.750;+23.850;0 199706090026;00;AIGH;+23.700;+23.800;0 199706090029;00;MBRC;+23.800;+24.000;0 199706090032;00;AIGH;+23.650;+23.750;0 199706090040;00;AIGH;+23.750;+23.850;0 199706090042;00;AIGH;+23.800;+23.900;0 199706090046;00;AIGH;+23.850;+23.950;0 199706090052;00;AIGH;+23.800;+23.900;0 199706090102;01;AIGH;+23.950;+24.000;0 199706090107;00;MBRC;+23.900;+24.000;0 199706090114;00;CTRD;+23.900;+24.000;0 199706090127;00;ANZS;+23.900;+24.000;0 199706090129;00;BOAS;+23.900;+24.000;0 199706090138;00;STTA;+25.760;+25.780;0 199706090144;00;ABNP;+25.750;+25.760;0 199706090145;00;MBRC;+23.850;+23.950;0 199706090153;00;ABNP;+25.750;+25.770;0 199706090156;00;MBRC;+23.900;+24.000;0 199706090211;00;ABNP;+25.745;+25.755;0 199706090217;00;ABNP;+25.746;+25.752;0 199706090218;00;ABNP;+25.740;+25.760;0 199706090219;00;SUMS;+23.900;+24.000;0 199706090229;00;ABNP;+25.741;+25.748;0 199706090230;00;MBRC;+23.910;+24.001;0 199706090314;00;TDBB;+25.730;+25.740;0 199706090318;00;INDS;+23.930;+24.030;0 199706090326;00;ABNP;+25.738;+25.745;0 199706090329;00;MBRC;+23.950;+24.050;0 199706090343;00;CTBT;+25.740;+25.748;0 199706090346;00;CTBT;+25.737;+25.747;0 199706090351;00;ABNP;+25.745;+25.755;0 199706090351;00;ABNP;+25.740;+25.750;0 199706090359;00;GBNP;+24.000;+24.241;0 199706090411;00;GBNP;+24.000;+24.100;0 199706090412;00;TDBB;+25.740;+25.743;0 199706090412;00;TDBB;+25.740;+25.750;0 199706090431;00;ABNP;+25.743;+25.753;0 199706090443;00;DBSS;+24.020;+24.120;0 199706090559;00;NWBO;+24.070;+24.071;0 199706090606;00;BOAS;+24.000;+24.100;0 199706090608;00;BGFX;+24.000;+24.100;0 199706090615;00;CHIC;+24.020;+24.120;0 199706090616;01;MBRC;+24.050;+24.150;0 199706090626;00;EMFY;+24.050;+24.150;0 199706090626;00;BTCO;+24.050;+24.150;0 199706090628;00;ABNP;+25.740;+25.750;0 199706090634;00;CHIC;+24.030;+24.130;0 199706090639;00;BGFX;+24.030;+24.130;0 199706090640;00;SCFE;+24.040;+24.140;0 199706090640;01;BGFX;+24.040;+24.140;0 199706090644;00;CBAX;+24.050;+24.150;0 199706090716;00;ABNP;+25.738;+25.748;0 199706090717;00;SCFE;+24.050;+24.150;0 199706090717;00;SCFE;+24.040;+24.140;0 199706090727;00;SUMS;+24.070;+24.170;0 199706090737;00;ABNP;+25.740;+25.745;0 199706090746;00;SCFE;+24.030;+24.130;0 199706090746;00;SCFE;+24.040;+24.140;0 199706090747;00;SCFE;+24.050;+24.150;0 199706090814;00;SCFE;+24.070;+24.170;0 199706090820;00;HSBK;+25.735;+25.745;0 199706090824;00;SCFE;+24.060;+24.160;0 199706090824;00;SCFE;+24.070;+24.170;0 199706090824;00;BGFX;+24.060;+24.160;0 199706090833;00;SCFE;+24.050;+24.150;0 199706090858;00;SCFE;+24.080;+24.180;0 199706090918;00;CHIC;+24.100;+24.200;0 199706090931;00;SCFE;+24.100;+24.200;0 199706090935;00;BGFX;+24.100;+24.200;0 199706090941;00;BNSV;+24.100;+24.200;0 199706090956;00;BOAS;+24.150;+24.250;0 199706091006;00;BGFX;+24.150;+24.250;0 199706091022;00;EMFY;+24.100;+24.200;0 199706091032;00;CHIC;+24.200;+24.300;0 199706091045;00;CHIC;+24.250;+24.350;0 199706091045;00;BGFX;+24.250;+24.350;0 199706091127;00;SCFE;+24.330;+24.430;0 199706091129;00;NWBO;+24.350;+24.354;0 199706091135;00;CHIC;+24.350;+24.450;0 199706091148;00;BGFX;+24.350;+24.450;0 199706091215;00;BNSV;+24.350;+24.450;0 199706091225;00;NWBO;+24.400;+24.405;0 199706091246;01;EMFY;+24.350;+24.450;0 199706091247;00;CHIC;+24.360;+24.460;0 199706091250;00;CHIC;+24.300;+24.400;0 199706091323;00;SCFE;+24.320;+24.420;0 199706091335;00;BBNF;+24.380;+24.480;0 199706091342;00;EMFY;+24.400;+24.500;0 199706091359;00;EMFY;+24.410;+24.500;0 199706091359;00;EMFY;+24.400;+24.500;0 199706091417;00;CBAX;+24.350;+24.450;0 199706091418;00;EMFY;+24.410;+24.500;0 199706091419;00;EMFY;+24.400;+24.500;0 199706091526;00;SCEX;+24.300;+24.400;0 199706091534;00;BBNF;+24.350;+24.450;0 199706091613;00;SBCN;+24.100;+24.300;0 199706091615;00;SCEX;+24.200;+24.300;0 199706091615;00;SCEX;+24.220;+24.320;0 199706091619;00;BBNF;+24.300;+24.400;0 199706092302;00;ANZM;+24.180;+24.280;0 199706092336;00;MBRC;+24.300;+24.400;0 199706092348;00;MBRC;+24.250;+24.350;0 199706100020;00;AIGH;+24.100;+24.200;0 199706100023;00;AIGH;+24.150;+24.250;0 199706100035;00;BBLH;+24.250;+24.350;0 199706100108;00;ABNP;+25.730;+25.750;0 199706100111;00;CTRD;+24.250;+24.350;0 199706100123;00;CHAB;+25.720;+25.750;0 199706100124;00;GBNP;+24.300;+24.400;0 199706100125;00;HKBK;+24.330;+24.430;0 199706100133;00;HKBK;+24.250;+24.350;0 199706100136;00;STTA;+25.720;+25.740;0 199706100141;00;ABNP;+25.725;+25.735;0 199706100142;00;SUMS;+24.250;+24.350;0 199706100143;00;GBNP;+24.250;+24.350;0 199706100231;00;HKBK;+24.240;+24.340;0 199706100241;00;ANZS;+24.240;+24.340;0 199706100249;00;BTCO;+24.240;+24.340;0 199706100256;00;OUBV;+24.240;+24.340;0 199706100312;00;SCRS;+24.200;+24.300;0 199706100319;00;BBLT;+25.728;+25.738;0 199706100320;00;GBNP;+24.220;+24.320;0 199706100323;00;CTBT;+25.728;+25.738;0 199706100346;00;TDBB;+25.730;+25.735;0 199706100416;01;SBES;+24.200;+24.300;0 199706100435;00;ANZM;+24.180;+24.380;0 199706100444;00;MBRC;+24.100;+24.200;0 199706100445;00;SCRS;+24.120;+24.220;0 199706100446;00;BBLH;+24.150;+24.250;0 199706100449;00;AIGH;+24.050;+24.150;0 199706100451;00;AIGH;+24.000;+24.100;0 199706100452;00;GBNP;+24.050;+24.150;0 199706100454;00;AIGH;+23.980;+24.080;0 199706100456;00;AIGH;+23.950;+24.050;0 199706100458;00;BBLH;+24.100;+24.200;0 199706100526;00;UBRC;+24.150;+24.250;0 199706100536;00;BGFX;+24.200;+24.300;0 199706100536;00;MBRC;+24.160;+24.260;0 199706100557;00;HKBK;+24.150;+24.250;0 199706100558;00;BBLH;+24.200;+24.300;0 199706100608;00;TDBB;+25.730;+25.750;0 199706100613;00;TDBB;+25.735;+25.750;0 199706100616;00;HKBK;+24.180;+24.280;0 199706100618;01;EMFY;+24.180;+24.280;0 199706100619;00;CHIC;+24.170;+24.270;0 199706100620;00;BGFX;+24.170;+24.270;0 199706100626;00;BLBS;+23.800;+23.900;0 199706100628;00;SCFE;+24.200;+24.300;0 199706100646;00;HKBK;+24.170;+24.270;0 199706100652;00;HKBK;+24.150;+24.250;0 199706100653;00;NWBO;+24.150;+24.152;0 199706100653;00;GBNP;+24.200;+24.300;0 199706100654;00;ABNP;+25.740;+25.750;0 199706100659;00;DBSS;+24.150;+24.250;0 199706100702;00;ABNP;+25.744;+25.752;0 199706100704;00;MBRC;+24.170;+24.270;0 199706100704;00;SCFE;+24.160;+24.260;0 199706100710;00;TDBB;+25.743;+25.753;0 199706100713;00;MBRC;+24.200;+24.250;0 199706100715;00;ABNP;+25.745;+25.755;0 199706100720;00;SCFE;+24.170;+24.270;0 199706100720;00;HKBK;+25.160;+25.260;0 199706100723;00;AIGH;+24.130;+24.230;0 199706100724;00;BBLH;+24.180;+24.280;0 199706100724;00;CHAB;+25.740;+25.750;0 199706100724;00;AIGH;+24.100;+24.200;0 199706100725;00;BBLH;+24.150;+24.250;0 199706100728;00;CBAX;+24.200;+24.300;0 199706100730;00;HKBK;+25.150;+25.250;0 199706100734;00;SCFE;+24.150;+24.250;0 199706100745;00;SCFE;+24.170;+24.270;0 199706100752;00;BBLH;+24.200;+24.300;0 199706100816;01;SCFE;+24.190;+24.290;0 199706100820;00;SCFE;+24.220;+24.320;0 199706100823;00;INBT;+25.742;+25.752;0 199706100824;00;SUMS;+24.200;+24.300;0 199706100830;00;SCFE;+24.240;+24.340;0 199706100841;00;BBLH;+24.300;+24.400;0 199706100854;00;MBRC;+24.300;+24.400;0 199706100901;00;CBAX;+24.250;+24.350;0 199706100933;00;HKBK;+25.250;+25.350;0 199706100934;00;SCFE;+24.200;+24.300;0 199706100940;00;BGFX;+24.200;+24.300;0 199706100945;01;BNSV;+24.200;+24.300;0 199706100948;00;EMFY;+24.240;+24.340;0 199706100949;00;AIGH;+24.150;+24.250;0 199706100949;00;AIGH;+24.100;+24.200;0 199706100951;00;AIGH;+24.050;+24.150;0 199706100954;00;NWBO;+24.050;+24.051;0 199706100955;00;EMFY;+24.100;+24.200;0 199706101005;00;SCFE;+24.180;+24.280;0 199706101013;00;AIGH;+24.100;+24.200;0 199706101014;00;SCFE;+24.150;+24.250;0 199706101014;00;AIGH;+24.050;+24.150;0 199706101024;00;AIGH;+24.000;+24.100;0 199706101025;00;SCFE;+24.100;+24.300;0 199706101026;00;AIGH;+24.000;+24.200;0 199706101036;00;AIGH;+23.950;+24.150;0 199706101037;00;SCFE;+24.050;+24.250;0 199706101056;00;AIGH;+23.900;+24.100;0 199706101111;00;CBAX;+24.050;+24.200;0 199706101112;00;AIGH;+24.050;+24.120;0 199706101117;00;AIGH;+24.000;+24.100;0 199706101127;00;EMFY;+24.000;+24.100;0 199706101131;00;AIGH;+23.970;+24.070;0 199706101146;00;AIGH;+24.050;+24.100;0 199706101149;00;AIGH;+24.000;+24.100;0 199706101150;00;AIGH;+24.000;+24.070;0 199706101153;00;AIGH;+23.950;+24.050;0 199706101153;00;NWBO;+23.950;+23.950;0 199706101154;00;CHIC;+24.020;+24.120;0 199706101154;00;SCFE;+24.000;+24.100;0 199706101154;00;NWBO;+23.980;+23.980;0 199706101154;00;SCFE;+24.010;+24.110;0 199706101155;00;SCFE;+24.000;+24.100;0 199706101218;00;SCEX;+24.050;+24.150;0 199706101224;01;AIGH;+24.000;+24.100;0 199706101343;00;BGFX;+24.000;+24.100;0 199706101412;00;AIGH;+23.950;+24.050;0 199706101418;00;CTBT;+25.735;+25.745;0 199706101419;00;SCEX;+24.000;+24.100;0 199706101423;00;CTBT;+25.730;+25.745;0 199706101425;00;AIGH;+23.930;+24.030;0 199706101426;00;SCFE;+23.980;+24.080;0 199706101429;00;SCEX;+24.020;+24.120;0 199706101431;00;SCEX;+23.930;+24.030;0 199706101509;00;SCFE;+24.000;+24.100;0 199706101843;00;SCEX;+23.950;+24.050;0 199706102139;00;CBAP;+24.050;+25.015;0 199706102147;00;ANZM;+24.050;+24.100;0 199706102333;00;ANZM;+24.000;+24.100;0 199706102344;00;MBRC;+24.200;+24.300;0 199706102356;00;MBRC;+24.050;+24.150;0 199706110001;00;CTRD;+24.000;+24.100;0 199706110014;00;BOAS;+23.950;+24.050;0 199706110016;00;HKBK;+23.950;+24.050;0 199706110045;00;GBNP;+24.000;+24.100;0 199706110045;01;MBRC;+23.970;+24.070;0 199706110050;00;ANZS;+23.970;+24.070;0 199706110106;00;CHAB;+25.730;+25.740;0 199706110113;00;HKBK;+23.960;+24.060;0 199706110133;00;HKBK;+23.970;+24.070;0 199706110133;00;SUMS;+23.950;+24.050;0 199706110136;00;INBT;+25.720;+25.730;0 199706110145;00;ANZM;+23.850;+24.050;0 199706110157;00;HKBK;+23.920;+24.020;0 199706110206;02;BOAS;+23.950;+24.000;0 199706110227;00;HSBK;+25.710;+25.730;0 199706110228;00;HKBK;+23.980;+24.080;0 199706110245;00;BBLH;+24.000;+24.100;0 199706110248;00;BBLH;+24.100;+24.200;0 199706110257;00;AIGH;+24.000;+24.100;0 199706110257;00;OUBV;+24.100;+24.200;0 199706110312;00;AIGH;+23.980;+24.080;0 199706110318;00;AIGH;+23.950;+24.050;0 199706110341;00;AIGH;+23.930;+24.030;0 199706110342;00;SCBK;+25.720;+25.730;0 199706110342;00;AIGH;+23.900;+24.000;0 199706110350;00;AIGH;+23.880;+23.980;0 199706110350;00;TDBB;+25.720;+25.730;0 199706110355;00;ANZM;+23.900;+24.000;0 199706110400;00;BBLS;+24.000;+24.100;0 199706110417;00;AIGH;+23.870;+23.970;0 199706110420;00;BBLS;+23.950;+24.050;0 199706110426;00;AIGH;+23.850;+23.950;0 199706110426;00;ANZM;+23.910;+24.010;0 199706110431;00;AIGH;+23.800;+23.900;0 199706110433;00;SUMS;+23.900;+24.000;0 199706110433;00;MBRC;+23.850;+23.950;0 199706110433;00;BOAS;+23.850;+23.950;0 199706110438;00;ANZM;+23.850;+23.900;0 199706110439;00;HKBK;+23.900;+24.000;0 199706110449;00;BBLS;+23.920;+24.020;0 199706110454;00;AIGH;+23.850;+23.950;0 199706110456;00;HKBK;+23.850;+23.950;0 199706110500;00;AIGH;+23.820;+23.920;0 199706110501;00;HKBK;+23.820;+23.920;0 199706110502;00;AIGH;+23.800;+23.900;0 199706110510;00;AIGH;+23.780;+23.880;0 199706110519;00;GBNP;+23.800;+23.900;0 199706110519;00;HKBK;+23.780;+23.880;0 199706110530;00;ANZM;+23.800;+23.900;0 199706110534;00;ANZS;+23.820;+23.920;0 199706110544;00;SUMS;+23.870;+23.970;0 199706110553;00;AIGH;+23.760;+23.860;0 199706110603;00;BBLH;+23.850;+23.950;0 199706110613;00;NWBO;+23.850;+23.859;0 199706110613;00;AIGH;+23.800;+23.900;0 199706110615;00;AIGH;+23.760;+23.860;0 199706110623;00;HKBK;+23.750;+23.850;0 199706110623;00;CHIC;+23.770;+23.870;0 199706110625;00;BGFX;+23.770;+23.870;0 199706110625;00;SUMS;+23.820;+23.870;0 199706110626;00;CBAX;+23.700;+23.900;0 199706110627;00;EMFY;+23.760;+23.860;0 199706110627;01;BGFX;+23.760;+23.860;0 199706110631;00;BBLS;+23.850;+23.950;0 199706110638;01;MBRC;+23.800;+23.900;0 199706110646;00;NWBO;+23.800;+23.809;0 199706110648;00;SCFE;+23.800;+23.900;0 199706110656;00;ABNP;+25.705;+25.720;0 199706110659;00;SCFE;+23.930;+24.030;0 199706110701;00;ABNP;+25.690;+25.710;0 199706110703;00;ABNP;+25.680;+25.700;0 199706110708;00;HKBK;+23.900;+24.000;0 199706110709;00;WBCM;+23.900;+24.000;0 199706110710;00;HKBK;+23.880;+23.980;0 199706110714;00;GBNP;+23.850;+23.950;0 199706110715;00;HKBK;+23.850;+23.950;0 199706110717;00;AIGH;+23.770;+23.870;0 199706110717;00;GBNP;+23.830;+23.930;0 199706110718;00;SCFE;+23.790;+23.890;0 199706110723;00;HKBK;+23.780;+23.880;0 199706110740;01;AIGH;+23.760;+23.860;0 199706110748;00;BNSV;+23.800;+23.900;0 199706110749;00;NWBO;+23.750;+23.758;0 199706110751;00;ABNP;+25.675;+25.695;0 199706110801;00;ABNP;+25.670;+25.690;0 199706110805;00;SCFE;+23.760;+23.860;0 199706110805;00;HKBK;+23.720;+23.820;0 199706110808;00;TMBB;+25.675;+25.695;0 199706110810;00;CHIC;+23.760;+23.860;0 199706110813;00;ABNP;+25.665;+25.685;0 199706110813;00;SCFE;+23.790;+23.890;0 199706110841;00;AIGH;+23.730;+23.830;0 199706110901;00;HSBK;+25.670;+25.690;0 199706110903;00;SCFE;+23.780;+23.880;0 199706110905;01;CHIC;+23.850;+23.950;0 199706110906;00;CTRD;+23.800;+23.900;0 199706110908;00;CHIC;+23.840;+23.940;0 199706110909;00;SCFE;+23.800;+23.900;0 199706110915;00;NWBO;+23.850;+23.859;0 199706110921;00;HKBK;+23.820;+23.920;0 199706110928;00;AIGH;+23.900;+24.000;0 199706110932;00;CHIC;+23.820;+23.920;0 199706110940;00;AIGH;+23.880;+23.980;0 199706110942;00;AIGH;+23.900;+24.000;0 199706110945;00;SCFE;+23.840;+23.940;0 199706111004;00;AIGH;+23.880;+23.980;0 199706111009;00;SCFE;+23.830;+23.930;0 199706111009;00;SCFE;+23.840;+23.940;0 199706111039;00;SCFE;+23.800;+23.900;0 199706111113;00;SCFE;+23.740;+23.840;0 199706111119;00;SCFE;+23.720;+23.820;0 199706111136;00;SCFE;+23.750;+23.850;0 199706111137;00;AIGH;+23.800;+23.900;0 199706111208;00;SCFE;+23.740;+23.840;0 199706111218;00;SCFE;+23.750;+23.758;0 199706111218;00;SCFE;+23.750;+23.850;0 199706111218;00;SCFE;+23.740;+23.840;0 199706111219;00;BGFX;+23.740;+23.840;0 199706111224;00;SCFE;+23.730;+23.830;0 199706111231;00;SCFE;+23.750;+23.850;0 199706111245;00;EMFY;+23.750;+23.850;0 199706111249;00;AIGH;+23.850;+23.950;0 199706111256;00;CHIC;+23.840;+23.940;0 199706111303;00;AIGH;+23.900;+24.000;0 199706111306;00;SCFE;+23.830;+23.930;0 199706111307;00;AIGH;+23.900;+23.950;0 199706111310;00;EMFY;+23.870;+23.920;0 199706111331;00;SCFE;+23.840;+23.940;0 199706111331;00;SCFE;+23.830;+23.930;0 199706111343;00;AIGH;+23.870;+23.970;0 199706111344;00;AIGH;+23.900;+24.000;0 199706111359;00;SCFE;+23.850;+23.950;0 199706111406;00;AIGH;+23.930;+24.000;0 199706111406;00;CBAX;+23.800;+24.000;0 199706111414;00;EMFY;+23.850;+23.950;0 199706111636;00;SCEX;+23.750;+23.850;0 199706111739;00;BBNF;+23.800;+23.900;0 199706111835;00;SCEX;+23.770;+23.870;0 199706112053;00;SCEX;+23.720;+23.820;0 199706112117;00;ANZM;+23.700;+23.800;0 199706112215;01;ANZM;+23.750;+23.850;0 199706112258;00;CBAP;+23.850;+23.950;0 199706112307;00;ANZM;+23.760;+23.860;0 199706112337;00;MBRC;+23.800;+23.900;0 199706120020;00;ANZM;+23.700;+23.800;0 199706120037;00;ANZS;+23.700;+23.800;0 199706120045;00;GBNP;+23.700;+23.800;0 199706120046;00;GBNP;+23.650;+23.750;0 199706120048;00;MBRC;+23.650;+23.750;0 199706120103;00;CHAB;+25.720;+25.740;0 199706120114;00;HKBK;+25.700;+25.800;0 199706120117;00;HKBK;+23.700;+23.800;0 199706120145;00;CTBT;+25.727;+25.737;0 199706120154;00;HKBK;+23.710;+23.810;0 199706120205;04;AIGH;+23.800;+23.900;0 199706120207;02;AIGH;+23.850;+23.950;0 199706120212;00;AIGH;+23.950;+24.050;0 199706120213;00;ABNP;+25.740;+25.760;0 199706120231;00;BBLT;+25.740;+25.750;0 199706120244;00;AIGH;+24.000;+24.100;0 199706120255;00;TDBB;+25.735;+25.755;0 199706120256;00;INBT;+25.740;+25.750;0 199706120316;00;AIGH;+24.050;+24.150;0 199706120322;00;MBRC;+24.000;+24.100;0 199706120336;00;MLMA;+24.000;+24.100;0 199706120339;00;ABNP;+25.755;+25.775;0 199706120342;00;BOAT;+25.780;+25.805;0 199706120347;00;HSBK;+25.740;+25.760;0 199706120348;00;CTBT;+25.750;+25.770;0 199706120349;00;CTBT;+25.750;+25.765;0 199706120350;00;CTBT;+25.755;+25.770;0 199706120351;00;TDBB;+25.750;+25.780;0 199706120352;00;SCBK;+25.770;+25.790;0 199706120355;00;MBRC;+23.970;+24.070;0 199706120357;00;BBLT;+25.755;+25.775;0 199706120405;00;ANZM;+24.000;+24.100;0 199706120419;00;AIGH;+24.020;+24.120;0 199706120435;00;AIGH;+24.040;+24.140;0 199706120437;00;MBRC;+24.000;+24.100;0 199706120440;00;AIGH;+24.050;+24.150;0 199706120500;00;HKBK;+24.050;+24.150;0 199706120509;00;MBRC;+24.010;+24.110;0 199706120523;00;AIGH;+24.050;+24.140;0 199706120523;00;AIGH;+24.050;+24.150;0 199706120528;00;ANZM;+24.010;+24.060;0 199706120538;00;ANZS;+24.010;+24.060;0 199706120600;00;EMFY;+24.010;+24.060;0 199706120614;00;CHIC;+24.020;+24.120;0 199706120625;00;ANZM;+23.980;+24.080;0 199706120627;00;EMFY;+24.020;+24.120;0 199706120627;00;BGFX;+23.980;+24.080;0 199706120628;00;GBNP;+23.900;+24.000;0 199706120629;00;SCFE;+23.970;+24.070;0 199706120630;00;NWBO;+23.970;+23.970;0 199706120630;00;BGFX;+23.920;+24.020;0 199706120635;00;CTBT;+25.750;+25.765;0 199706120640;00;SCFE;+23.980;+24.080;0 199706120654;00;INBT;+25.750;+25.780;0 199706120657;01;INDS;+23.907;+24.007;0 199706120658;00;INDS;+24.007;+24.107;0 199706120658;00;INDS;+24.000;+24.100;0 199706120703;00;HKBK;+24.080;+24.180;0 199706120704;00;HKBK;+24.100;+24.200;0 199706120712;00;TDBB;+25.760;+25.790;0 199706120716;00;HKBK;+24.040;+24.140;0 199706120720;00;HKBK;+24.100;+24.200;0 199706120723;01;EMFY;+24.120;+24.220;0 199706120724;00;EMFY;+24.150;+24.250;0 199706120725;00;EMFY;+24.120;+24.250;0 199706120725;00;EMFY;+24.160;+24.260;0 199706120725;00;EMFY;+24.140;+24.240;0 199706120726;00;EMFY;+24.130;+24.240;0 199706120728;00;EMFY;+24.130;+24.230;0 199706120732;01;BOAS;+24.100;+24.200;0 199706120733;00;EMFY;+24.100;+24.200;0 199706120736;01;CHAB;+25.720;+25.750;0 199706120737;00;CHAB;+25.720;+25.740;0 199706120737;00;EMFY;+24.110;+24.210;0 199706120738;00;GBNP;+24.050;+24.150;0 199706120739;00;SCFE;+24.050;+24.150;0 199706120744;00;EMFY;+24.100;+24.200;0 199706120748;00;EMFY;+24.101;+24.201;0 199706120749;00;EMFY;+24.020;+24.120;0 199706120757;00;EMFY;+24.080;+24.180;0 199706120818;01;BGFX;+24.080;+24.180;0 199706120819;00;GBNP;+24.100;+24.200;0 199706120829;00;ABNP;+25.780;+25.800;0 199706120830;00;SBIC;+24.10;+24.20;0 199706120831;00;NWBO;+24.100;+24.102;0 199706120832;00;AIGH;+24.150;+24.250;0 199706120835;00;MBRC;+24.100;+24.200;0 199706120839;00;MBRC;+24.200;+24.300;0 199706120840;00;MBRC;+24.150;+24.250;0 199706120844;00;HKBK;+24.150;+24.250;0 199706120847;00;NWBO;+24.200;+24.203;0 199706120849;00;EMFY;+24.150;+24.250;0 199706120854;00;NWBO;+24.150;+24.152;0 199706120854;00;SHDR;+24.250;+24.350;0 199706120854;00;EMFY;+24.160;+24.260;0 199706120856;00;SHDR;+24.120;+24.220;0 199706120901;00;EMFY;+24.150;+24.250;0 199706120901;00;HSBK;+25.770;+25.790;0 199706120907;00;SCFE;+24.140;+24.240;0 199706120908;00;HKBK;+24.170;+24.270;0 199706120918;00;CBAX;+24.100;+24.300;0 199706120919;00;SCFE;+24.130;+24.230;0 199706120919;00;SCFE;+24.140;+24.240;0 199706120924;01;SCFE;+24.100;+24.200;0 199706120933;00;BBLS;+24.150;+24.250;0 199706120945;00;EMFY;+24.100;+24.200;0 199706121020;00;BATH;+25.775;+25.790;0 199706121022;00;EMFY;+24.110;+24.210;0 199706121049;00;BGFX;+24.110;+24.210;0 199706121106;00;CHIC;+24.150;+24.250;0 199706121202;00;EMFY;+24.150;+24.250;0 199706121209;00;SCEX;+24.100;+24.200;0 199706121219;00;EMFY;+24.180;+24.280;0 199706121219;00;EMFY;+24.170;+24.270;0 199706121220;00;EMFY;+24.180;+24.280;0 199706121220;00;EMFY;+24.190;+24.280;0 199706121220;00;EMFY;+24.180;+24.280;0 199706121220;00;EMFY;+24.190;+24.280;0 199706121220;00;EMFY;+24.180;+24.280;0 199706121224;00;EMFY;+24.190;+24.290;0 199706121248;00;CHIC;+24.250;+24.350;0 199706121300;00;BGFX;+24.250;+24.350;0 199706121306;00;MBNY;+24.250;+24.350;0 199706121330;00;SCFE;+24.150;+24.250;0 199706121330;00;SCFE;+24.100;+24.200;0 199706121330;00;SCFE;+24.100;+24.300;0 199706121331;00;BGFX;+24.150;+24.250;0 199706121332;00;EMFY;+24.180;+24.280;0 199706121341;00;BGFX;+24.180;+24.280;0 199706121342;00;SCFE;+24.070;+24.170;0 199706121416;01;BNSV;+24.070;+24.170;0 199706121423;00;SCEX;+24.050;+24.150;0 199706121424;00;SCFE;+23.950;+24.050;0 199706121441;00;NWBO;+23.950;+23.950;0 199706121443;00;EMFY;+24.000;+24.100;0 199706121539;00;SCEX;+23.950;+24.050;0 199706121640;00;SCEX;+23.880;+23.980;0 199706121806;00;SCEX;+23.800;+23.900;0 199706121831;00;SCEX;+23.750;+23.850;0 199706122156;00;ANZM;+23.700;+23.800;0 199706122226;00;CBAP;+23.750;+23.850;0 199706122250;00;ANZM;+23.710;+23.810;0 199706122301;00;CBAP;+23.760;+23.860;0 199706122341;00;SIME;+23.700;+23.900;0 199706122356;00;ANZM;+23.750;+23.850;0 199706130006;00;MBRC;+23.750;+23.850;0 199706130021;00;ANZS;+23.750;+23.850;0 199706130025;00;HKBK;+23.750;+23.850;0 199706130025;00;HKBK;+23.850;+23.950;0 199706130037;00;GBNP;+23.900;+24.000;0 199706130040;01;GBNP;+23.970;+24.070;0 199706130041;00;CTBT;+25.780;+25.790;0 199706130049;01;MBRC;+23.900;+24.000;0 199706130104;00;MBRC;+24.000;+24.100;0 199706130104;00;BOAS;+24.000;+24.100;0 199706130106;00;HKBK;+24.020;+24.120;0 199706130107;00;GBNP;+24.050;+24.150;0 199706130110;00;INDS;+24.002;+24.102;0 199706130110;00;INDS;+24.020;+24.120;0 199706130111;00;HKBK;+24.040;+24.140;0 199706130112;00;HKBK;+24.050;+24.150;0 199706130113;01;GBNP;+24.100;+24.200;0 199706130114;00;MBRC;+24.100;+24.200;0 199706130114;00;ABNP;+25.782;+25.792;0 199706130114;00;HKBK;+24.150;+24.250;0 199706130114;00;ABNP;+25.780;+25.796;0 199706130116;00;HKBK;+24.180;+24.280;0 199706130118;00;GBNP;+24.200;+24.300;0 199706130125;00;HKBK;+24.250;+24.350;0 199706130128;00;MBRC;+24.300;+24.400;0 199706130129;00;GBNP;+24.300;+24.400;0 199706130131;00;GBNP;+24.350;+24.450;0 199706130132;00;STTA;+25.790;+25.810;0 199706130132;00;HKBK;+24.300;+24.400;0 199706130136;00;GBNP;+24.300;+24.400;0 199706130140;00;CHAB;+25.790;+25.810;0 199706130146;00;SHDR;+24.170;+24.270;0 199706130146;00;HKBK;+24.220;+24.320;0 199706130146;00;SHDR;+24.150;+24.250;0 199706130147;00;BBLS;+24.250;+24.350;0 199706130147;00;SHDR;+24.160;+24.260;0 199706130148;00;SHDR;+24.120;+24.220;0 199706130152;00;CTRD;+24.150;+24.250;0 199706130156;00;GBNP;+24.140;+24.240;0 199706130157;00;AIGH;+24.100;+24.200;0 199706130158;00;SHDR;+24.070;+24.170;0 199706130159;00;GBNP;+24.080;+24.180;0 199706130159;00;SHDR;+24.050;+24.150;0 199706130202;07;AIGH;+24.150;+24.250;0 199706130204;05;ANZS;+24.180;+24.280;0 199706130210;00;ABNP;+25.785;+25.792;0 199706130211;00;ABNP;+25.786;+25.802;0 199706130216;00;MBRC;+24.230;+24.330;0 199706130231;00;MBRC;+24.300;+24.400;0 199706130234;00;AIGH;+24.350;+24.450;0 199706130238;00;AIGH;+24.450;+24.550;0 199706130239;00;TDBB;+25.790;+25.810;0 199706130239;00;AIGH;+24.500;+24.600;0 199706130250;00;HKBK;+24.550;+24.650;0 199706130257;00;BBLT;+25.795;+25.805;0 199706130313;00;INBT;+25.800;+25.810;0 199706130314;00;TMBB;+25.795;+25.805;0 199706130316;00;TDBB;+25.795;+25.805;0 199706130325;01;CTBT;+25.797;+25.807;0 199706130333;00;AIGH;+24.500;+24.700;0 199706130334;00;SCBK;+25.800;+25.805;0 199706130335;00;BBLT;+25.800;+25.810;0 199706130337;00;INDS;+24.500;+24.600;0 199706130343;00;ANZM;+24.500;+24.600;0 199706130412;00;AIGH;+24.600;+24.700;0 199706130415;00;AIGH;+24.650;+24.850;0 199706130416;00;AIGH;+24.500;+24.700;0 199706130436;00;UBRC;+24.400;+24.600;0 199706130457;00;AIGH;+24.300;+24.500;0 199706130512;00;AIGH;+24.000;+24.200;0 199706130513;00;GBNP;+24.100;+24.400;0 199706130513;00;AIGH;+23.900;+24.100;0 199706130514;00;HKBK;+24.180;+24.280;0 199706130521;00;ABNP;+25.780;+25.810;0 199706130521;00;ANZM;+24.150;+24.350;0 199706130527;01;ANZS;+24.190;+24.290;0 199706130531;00;BLBS;+24.200;+24.300;0 199706130541;00;MBRC;+24.200;+24.300;0 199706130559;00;EMFY;+24.200;+24.300;0 199706130610;00;BGFX;+24.250;+24.350;0 199706130611;00;NWBO;+24.200;+24.203;0 199706130619;00;CHIC;+24.300;+24.400;0 199706130624;00;HKBK;+24.350;+24.450;0 199706130626;00;BGFX;+24.350;+24.450;0 199706130710;00;EMFY;+24.350;+24.450;0 199706130711;00;TDBB;+25.790;+25.800;0 199706130711;00;BATH;+25.790;+25.805;0 199706130712;00;TDBB;+25.790;+25.805;0 199706130712;00;TDBB;+25.790;+25.800;0 199706130716;00;SCFE;+24.310;+24.410;0 199706130724;00;ANZS;+24.280;+24.380;0 199706130727;00;BNSV;+24.380;+25.380;0 199706130727;00;SCFE;+24.270;+24.370;0 199706130732;00;HKBK;+24.300;+24.400;0 199706130740;00;BGFX;+24.300;+24.400;0 199706130744;00;NWBO;+24.300;+24.304;0 199706130752;00;CHIC;+24.400;+24.500;0 199706130755;00;HKBK;+24.400;+24.500;0 199706130759;00;BBLS;+24.500;+24.600;0 199706130800;00;BBLS;+24.450;+24.550;0 199706130801;00;NWBO;+24.480;+24.485;0 199706130819;00;SUMS;+24.250;+24.350;0 199706130820;00;SCFE;+24.420;+24.520;0 199706130827;00;UBRC;+24.300;+24.500;0 199706130828;00;AIGH;+24.500;+24.600;0 199706130828;00;UBRC;+24.400;+24.600;0 199706130830;00;AIGH;+24.550;+24.650;0 199706130835;00;HKBK;+24.600;+24.700;0 199706130841;00;HKBK;+24.650;+24.750;0 199706130842;00;HKBK;+24.700;+24.800;0 199706130842;00;NWBO;+24.650;+24.657;0 199706130842;00;NWBO;+24.700;+24.708;0 199706130842;00;HKBK;+24.690;+24.790;0 199706130844;00;BOAS;+24.700;+24.800;0 199706130859;00;BGFX;+24.700;+24.800;0 199706130903;00;BBLS;+24.750;+24.850;0 199706130919;00;CHIC;+24.650;+24.750;0 199706130935;00;AIGH;+24.750;+24.850;0 199706130942;00;SCFE;+24.700;+24.800;0 199706131016;00;EMFY;+24.500;+24.800;0 199706131018;01;SCFE;+24.500;+24.700;0 199706131025;00;SCFE;+24.580;+24.680;0 199706131051;00;SCFE;+24.400;+24.600;0 199706131107;00;SCFE;+24.500;+24.700;0 199706131116;00;BBLT;+25.805;+25.815;0 199706131117;00;SCFE;+24.550;+24.750;0 199706131204;00;SCFE;+24.550;+24.650;0 199706131221;00;BGFX;+24.550;+24.650;0 199706131224;00;SCFE;+24.600;+24.700;0 199706131406;00;NWBO;+24.550;+24.556;0 199706131444;00;SCEX;+23.550;+23.650;0 199706131448;00;SCEX;+23.620;+23.720;0 199706131448;00;SCEX;+24.620;+24.720;0 199706131521;00;SCFE;+24.580;+24.680;0 199706131521;00;SCFE;+24.600;+24.700;0 199706131529;00;SCEX;+24.700;+24.800;0 199706131531;00;SCEX;+24.620;+24.720;0 199706131545;00;SBCN;+24.580;+24.680;0 199706131556;00;SCEX;+23.600;+23.700;0 199706131602;00;SCFE;+24.610;+24.710;0 199706131602;00;SCFE;+24.600;+24.700;0 199706131733;00;MBNY;+24.600;+24.700;0 199706132005;00;SCEX;+24.700;+24.800;0 199706142005;99;SCEX;+24.700;+24.800;0 199706152005;99;SCEX;+24.700;+24.800;0 199706160012;00;MBRC;+24.650;+24.750;0 199706160026;00;BOAS;+24.650;+24.750;0 199706160034;00;HKBK;+24.650;+24.750;0 199706160039;00;ANZS;+24.650;+24.750;0 199706160051;00;BBLS;+24.650;+24.750;0 199706160120;00;HKBK;+24.600;+24.700;0 199706160134;00;AIGH;+24.450;+24.550;0 199706160141;00;HKBK;+24.470;+24.570;0 199706160142;00;ABNP;+25.820;+25.840;0 199706160142;00;AIGH;+24.400;+24.500;0 199706160143;00;HKBK;+24.460;+24.560;0 199706160146;00;CHAB;+25.825;+25.884;0 199706160147;00;HKBK;+24.450;+24.550;0 199706160152;00;AIGH;+24.350;+24.450;0 199706160152;00;HKBK;+24.370;+24.470;0 199706160155;00;AIGH;+24.300;+24.400;0 199706160157;00;HKBK;+24.380;+24.480;0 199706160200;00;HKBK;+24.400;+24.550;0 199706160218;00;ANZS;+24.400;+24.500;0 199706160231;00;INBT;+25.830;+25.840;0 199706160237;00;BOAS;+24.350;+24.400;0 199706160238;00;MBRC;+24.350;+24.450;0 199706160238;00;AIGH;+24.200;+24.300;0 199706160241;00;MBRC;+24.300;+24.400;0 199706160241;00;AIGH;+24.150;+24.250;0 199706160243;00;MBRC;+24.200;+24.300;0 199706160244;00;MBRC;+24.220;+24.320;0 199706160248;00;OUBV;+24.220;+24.230;0 199706160249;00;ANZS;+24.300;+24.400;0 199706160311;00;BBLT;+25.825;+25.835;0 199706160326;00;CTBT;+25.826;+25.834;0 199706160329;00;TDBB;+25.825;+25.835;0 199706160354;00;TMBB;+25.825;+25.832;0 199706160400;00;HSBK;+25.825;+25.835;0 199706160451;00;HKBK;+24.250;+24.350;0 199706160521;00;MBRC;+24.250;+24.350;0 199706160524;00;AIGH;+24.200;+24.300;0 199706160537;00;AIGH;+24.150;+24.250;0 199706160538;00;AIGH;+24.100;+24.200;0 199706160539;00;HKBK;+24.150;+24.250;0 199706160542;00;AIGH;+24.080;+24.180;0 199706160545;00;AIGH;+24.050;+24.150;0 199706160547;00;BGFX;+24.055;+24.155;0 199706160548;00;AIGH;+24.000;+24.100;0 199706160551;00;HKBK;+24.050;+24.150;0 199706160600;00;EMFY;+24.500;+25.150;0 199706160600;01;NWBO;+24.050;+24.051;0 199706160615;00;CHIC;+24.080;+24.180;0 199706160616;00;MBRC;+24.070;+24.170;0 199706160617;01;AIGH;+24.200;+24.300;0 199706160622;00;BGFX;+24.200;+24.300;0 199706160623;00;BOAS;+24.200;+24.300;0 199706160630;00;MBRC;+24.200;+24.300;0 199706160656;00;EMFY;+24.200;+24.300;0 199706160659;00;BGFX;+24.200;+24.300;0 199706160702;00;SCFE;+24.200;+24.300;0 199706160745;00;BNST;+24.200;+24.300;0 199706160811;00;BNSV;+24.200;+24.300;0 199706160811;20;XXXX;+24.200;+24.400;0 199706160832;00;SCFE;+24.230;+24.330;0 199706160846;00;SCFE;+24.200;+24.300;0 199706160859;00;HSBK;+25.830;+25.840;0 199706160902;00;SCFE;+24.220;+24.320;0 199706160905;00;HSBK;+25.835;+25.845;0 199706160909;00;SCFE;+24.230;+24.330;0 199706160909;00;SCFE;+24.220;+24.320;0 199706160910;00;HKBK;+24.220;+24.320;0 199706160946;00;CBAX;+24.200;+24.400;0 199706160947;00;AIGH;+24.250;+24.300;0 199706161032;00;AIGH;+24.180;+24.280;0 199706161047;00;SHDR;+24.250;+24.300;0 199706161051;00;SHDR;+24.200;+24.300;0 199706161110;00;SCFE;+24.210;+24.310;0 199706161110;00;SCFE;+24.220;+24.320;0 199706161218;00;EMFY;+24.100;+24.200;0 199706161219;00;SHDR;+24.150;+24.250;0 199706161219;00;SCFE;+24.190;+24.290;0 199706161256;00;SCFE;+24.150;+24.250;0 199706161337;00;CHIC;+24.000;+24.100;0 199706161338;00;SCFE;+24.030;+24.130;0 199706161401;00;BGFX;+24.030;+24.130;0 199706161446;00;SCFE;+23.980;+24.080;0 199706161512;00;BBNF;+23.950;+24.150;0 199706161845;00;SCEX;+23.900;+24.000;0 199706162108;00;ANZM;+23.900;+24.000;0 199706162152;00;ANZM;+24.000;+24.100;0 199706162355;00;ANZM;+23.950;+24.050;0 199706162357;00;MBRC;+23.950;+24.050;0 199706170020;00;MBRC;+23.900;+24.000;0 199706170020;00;MBRC;+23.930;+24.030;0 199706170026;00;AIGH;+23.880;+23.980;0 199706170028;00;AIGH;+23.850;+23.950;0 199706170029;00;AIGH;+23.830;+23.930;0 199706170030;00;AIGH;+23.800;+23.900;0 199706170035;00;MBRC;+23.850;+23.950;0 199706170037;00;HKBK;+23.850;+23.950;0 199706170039;00;SUMS;+23.920;+24.020;0 199706170041;00;ANZS;+23.920;+24.020;0 199706170046;00;BOAS;+23.830;+23.930;0 199706170054;00;AIGH;+23.750;+23.850;0 199706170055;00;HKBK;+23.730;+23.830;0 199706170108;00;CTBT;+25.820;+25.835;0 199706170108;00;BOAS;+23.750;+23.850;0 199706170110;00;ANZS;+23.750;+23.850;0 199706170111;00;CTBT;+25.815;+25.825;0 199706170113;00;SUMS;+23.720;+23.820;0 199706170114;00;SUMS;+23.690;+23.790;0 199706170117;00;BOAS;+23.700;+23.800;0 199706170117;00;BOAS;+23.650;+23.750;0 199706170125;00;SUMS;+23.750;+23.850;0 199706170130;00;AIGH;+23.630;+23.730;0 199706170131;00;CTBT;+25.790;+25.800;0 199706170132;00;CTBT;+25.787;+25.797;0 199706170133;00;ABNP;+25.790;+25.800;0 199706170149;00;CHAB;+25.790;+25.810;0 199706170155;00;BOAS;+23.700;+23.800;0 199706170205;03;AIGH;+23.600;+23.700;0 199706170207;01;AIGH;+23.580;+23.680;0 199706170208;00;HKBK;+23.580;+23.680;0 199706170210;00;SUMS;+23.660;+23.710;0 199706170210;00;HKBK;+23.600;+23.700;0 199706170212;00;CTRD;+23.600;+23.700;0 199706170213;00;AIGH;+23.550;+23.650;0 199706170214;00;SUMS;+23.550;+23.650;0 199706170217;00;AIGH;+23.500;+23.600;0 199706170221;00;INBT;+25.800;+25.810;0 199706170223;00;BOAS;+23.550;+23.650;0 199706170223;00;AIGH;+23.480;+23.580;0 199706170227;00;AIGH;+23.460;+23.560;0 199706170228;00;SUMS;+23.540;+23.640;0 199706170230;00;GBNP;+23.500;+23.600;0 199706170234;00;BOAS;+23.500;+23.600;0 199706170238;00;BOAT;+25.800;+25.820;0 199706170239;00;BTCO;+23.500;+23.600;0 199706170243;00;ABNP;+25.800;+25.810;0 199706170254;00;HKBK;+23.580;+23.680;0 199706170256;00;NTBB;+25.805;+25.810;0 199706170319;00;NTBB;+25.800;+25.815;0 199706170320;00;NTBB;+25.803;+25.813;0 199706170330;00;TDBB;+25.800;+25.815;0 199706170333;00;MLMA;+23.600;+23.700;0 199706170334;00;ABNP;+25.802;+25.812;0 199706170335;00;BBLT;+25.800;+25.810;0 199706170335;00;CTBT;+25.787;+25.812;0 199706170340;00;BBLT;+25.805;+25.810;0 199706170352;00;TMBB;+25.800;+25.810;0 199706170406;00;ANZM;+23.550;+23.650;0 199706170419;00;AIGH;+23.450;+23.550;0 199706170423;00;AIGH;+23.400;+23.500;0 199706170426;00;AIGH;+23.380;+23.480;0 199706170427;00;AIGH;+23.360;+23.460;0 199706170432;00;ANZM;+23.350;+23.450;0 199706170434;00;HKBK;+23.420;+23.520;0 199706170435;00;BOAS;+23.450;+23.550;0 199706170435;00;ANZS;+23.420;+23.520;0 199706170440;00;SUMS;+23.380;+23.480;0 199706170447;00;UOBX;+23.450;+23.550;0 199706170449;00;ANZM;+23.400;+23.500;0 199706170456;00;ANZM;+23.450;+23.550;0 199706170518;00;AIGH;+23.350;+23.450;0 199706170528;00;BOAS;+23.400;+23.500;0 199706170538;00;SUMS;+23.350;+23.450;0 199706170539;00;SUMS;+23.400;+23.500;0 199706170556;00;MBRC;+23.400;+23.500;0 199706170559;00;ANZM;+23.400;+23.500;0 199706170604;00;HKBK;+23.400;+23.500;0 199706170605;00;CHIC;+23.400;+23.500;0 199706170605;00;AIGH;+23.320;+23.420;0 199706170608;00;CBAX;+23.300;+23.500;0 199706170609;00;AIGH;+23.300;+23.400;0 199706170609;00;ANZM;+23.380;+23.480;0 199706170610;00;AIGH;+23.280;+23.380;0 199706170611;00;AIGH;+23.250;+23.350;0 199706170611;00;SUMS;+23.254;+23.255;0 199706170611;00;SUMS;+23.250;+23.450;0 199706170612;00;AIGH;+23.230;+23.330;0 199706170612;00;EMFY;+23.250;+23.350;0 199706170614;00;AIGH;+23.200;+23.300;0 199706170617;00;HKBK;+23.300;+23.400;0 199706170626;00;ANZS;+23.300;+23.400;0 199706170635;00;SCFE;+23.300;+23.400;0 199706170636;00;MBRC;+23.280;+23.380;0 199706170640;00;SUMS;+23.200;+23.300;0 199706170641;00;HKBK;+23.240;+23.340;0 199706170705;00;AIGH;+23.190;+23.290;0 199706170707;00;HKBK;+23.210;+23.310;0 199706170709;00;BGFX;+23.240;+23.340;0 199706170720;00;SUMS;+23.180;+23.280;0 199706170753;00;SHDR;+23.200;+23.300;0 199706170753;00;ANZS;+23.200;+23.300;0 199706170754;00;AIGH;+23.120;+23.220;0 199706170758;00;HKBK;+23.150;+23.250;0 199706170759;00;EMFY;+23.150;+23.250;0 199706170807;00;BNST;+23.200;+23.300;0 199706170810;00;BGFX;+23.200;+23.300;0 199706170810;00;SCFE;+23.160;+23.260;0 199706170811;00;SCFE;+23.130;+23.230;0 199706170812;00;AIGH;+23.100;+23.200;0 199706170816;00;AIGH;+23.080;+23.180;0 199706170817;00;AIGH;+23.050;+23.150;0 199706170820;00;CTBT;+25.815;+25.825;0 199706170820;00;BOAS;+23.150;+23.200;0 199706170824;00;SCFE;+23.120;+23.220;0 199706170824;00;SCFE;+23.140;+23.240;0 199706170825;00;SHDR;+23.100;+23.200;0 199706170835;00;BNSV;+23.100;+23.300;0 199706170837;00;AIGH;+23.000;+23.100;0 199706170838;00;AIGH;+22.900;+23.000;0 199706170838;00;CHIC;+23.150;+23.250;0 199706170842;00;DBSS;+23.000;+23.200;0 199706170845;00;DBSS;+23.150;+23.250;0 199706170859;00;SCFE;+23.090;+23.190;0 199706170900;00;HKBK;+23.100;+23.200;0 199706170901;01;HKBK;+23.050;+23.150;0 199706170912;00;SCFE;+23.000;+23.100;0 199706170913;00;HKBK;+23.000;+23.100;0 199706170914;00;AIGH;+22.850;+22.950;0 199706170915;00;AIGH;+22.800;+22.900;0 199706170915;00;BATH;+25.817;+25.827;0 199706170916;00;HKBK;+22.750;+22.950;0 199706170919;00;HKBK;+22.880;+23.080;0 199706170919;00;AIGH;+22.750;+22.850;0 199706170920;00;AIGH;+22.700;+22.800;0 199706170920;00;BOAS;+22.850;+23.050;0 199706170920;00;AIGH;+22.650;+22.750;0 199706170920;00;BOAS;+22.800;+22.900;0 199706170920;00;AIGH;+22.600;+22.750;0 199706170921;00;AIGH;+22.500;+22.700;0 199706170923;00;AIGH;+22.500;+22.600;0 199706170924;00;AIGH;+22.700;+22.800;0 199706170931;00;BOAS;+22.700;+22.800;0 199706170934;00;HSBK;+25.820;+25.840;0 199706170935;00;SCFE;+22.700;+22.900;0 199706170941;00;AIGH;+22.800;+23.000;0 199706170944;00;AIGH;+22.750;+22.950;0 199706170946;00;AIGH;+22.700;+22.900;0 199706170947;00;AIGH;+22.650;+22.850;0 199706170952;00;SCFE;+22.750;+22.950;0 199706170956;00;BGFX;+22.800;+22.900;0 199706171004;00;SCFE;+22.700;+23.000;0 199706171004;00;SCFE;+22.800;+22.900;0 199706171004;00;SCFE;+22.800;+23.000;0 199706171013;00;EMFY;+22.800;+23.000;0 199706171116;01;BGFX;+22.850;+22.950;0 199706171152;00;CHIC;+22.700;+22.900;0 199706171155;00;SCFE;+22.700;+22.900;0 199706171210;00;EMFY;+22.700;+22.900;0 199706171217;00;AIGH;+22.700;+22.800;0 199706171220;00;AIGH;+22.650;+22.750;0 199706171222;00;AIGH;+22.600;+22.700;0 199706171224;00;CBAX;+22.600;+22.800;0 199706171224;00;AIGH;+22.570;+22.670;0 199706171228;00;AIGH;+22.550;+22.650;0 199706171229;00;SCFE;+22.550;+22.750;0 199706171242;00;AIGH;+22.700;+22.750;0 199706171242;00;SCFE;+22.600;+22.800;0 199706171243;00;AIGH;+22.700;+22.800;0 199706171251;00;AIGH;+22.650;+22.750;0 199706171256;00;BGFX;+22.650;+22.750;0 199706171256;00;AIGH;+22.600;+22.700;0 199706171306;00;AIGH;+22.580;+22.680;0 199706171313;00;BGFX;+22.580;+22.680;0 199706171315;00;AIGH;+22.550;+22.650;0 199706171323;00;AIGH;+22.530;+22.630;0 199706171326;00;AIGH;+22.520;+22.620;0 199706171327;00;AIGH;+22.500;+22.600;0 199706171330;00;AIGH;+22.600;+22.700;0 199706171337;00;CHIC;+22.600;+22.800;0 199706171339;00;SCEX;+22.600;+22.700;0 199706171350;00;AIGH;+22.450;+22.550;0 199706171351;00;SCFE;+22.500;+22.700;0 199706171355;00;AIGH;+22.500;+22.600;0 199706171403;00;AIGH;+22.460;+22.560;0 199706171404;00;CBAX;+22.500;+22.700;0 199706171405;00;AIGH;+22.430;+22.530;0 199706171405;00;BGFX;+22.550;+22.650;0 199706171405;00;AIGH;+22.400;+22.500;0 199706171407;00;BGFX;+22.400;+22.500;0 199706171409;00;SCFE;+22.500;+22.600;0 199706171409;00;SCFE;+22.500;+22.650;0 199706171411;00;AIGH;+22.500;+22.600;0 199706171433;00;EMFY;+22.500;+22.700;0 199706171455;00;BBNF;+22.600;+22.750;0 199706171457;00;SCEX;+22.550;+22.650;0 199706171501;00;BGFX;+22.550;+22.650;0 199706171503;00;CHIC;+22.600;+22.750;0 199706171522;00;SCFE;+22.550;+22.700;0 199706171525;00;SCEX;+22.650;+22.750;0 199706171526;00;SCEX;+22.590;+22.690;0 199706171607;00;BBNF;+22.650;+22.800;0 199706171705;00;SCEX;+22.650;+22.750;0 199706171711;00;BBNF;+22.700;+22.800;0 199706171731;00;BBNF;+22.600;+22.800;0 199706171741;00;BBNF;+22.720;+22.820;0 199706171941;00;BBNF;+22.750;+22.850;0 199706172111;00;SCEX;+22.630;+22.730;0 199706172111;00;SCEX;+22.650;+22.750;0 199706172117;00;ANZM;+23.000;+23.300;0 199706172134;00;CBAP;+22.800;+23.100;0 199706172220;00;ANZM;+22.900;+23.200;0 199706172226;00;CBAP;+22.850;+23.150;0 199706172229;00;ANZM;+22.880;+23.180;0 199706172327;00;MBRC;+22.600;+22.650;0 199706172339;00;MBRC;+23.000;+23.200;0 199706180010;00;ANZS;+23.000;+23.200;0 199706180022;00;BOAS;+22.900;+23.100;0 199706180026;00;HKBK;+22.800;+23.000;0 199706180029;00;SUMS;+22.701;+22.702;0 199706180029;00;SUMS;+22.700;+22.900;0 199706180031;00;MBRC;+22.800;+23.000;0 199706180035;00;HKBK;+22.750;+22.950;0 199706180042;00;HKBK;+22.700;+22.900;0 199706180042;00;MBRC;+22.650;+22.850;0 199706180043;00;MBRC;+22.700;+22.900;0 199706180047;00;CHAB;+25.800;+25.820;0 199706180047;00;MBRC;+22.600;+22.800;0 199706180049;00;ABNP;+25.800;+25.820;0 199706180055;01;GBNP;+22.450;+22.950;0 199706180114;00;ANZS;+22.500;+22.700;0 199706180115;00;HKBK;+22.470;+22.670;0 199706180118;00;AIGH;+22.350;+22.550;0 199706180119;00;HKBK;+22.400;+22.600;0 199706180125;00;AIGH;+22.300;+22.500;0 199706180125;00;MBRC;+22.400;+22.600;0 199706180126;00;BOAS;+22.400;+22.600;0 199706180127;00;HKBK;+22.350;+22.550;0 199706180133;00;STTA;+25.800;+25.820;0 199706180134;00;ANZM;+22.400;+22.600;0 199706180144;00;AIGH;+22.250;+22.450;0 199706180146;00;BOAS;+22.400;+22.500;0 199706180156;00;SUMS;+22.300;+22.500;0 199706180159;00;AIGH;+22.200;+22.400;0 199706180202;06;HKBK;+22.300;+22.500;0 199706180209;00;SUMS;+22.400;+22.450;0 199706180211;00;SUMS;+22.500;+22.600;0 199706180216;00;BOAS;+22.550;+22.650;0 199706180221;00;AIGH;+22.400;+22.500;0 199706180223;00;AIGH;+22.350;+22.450;0 199706180224;00;INBT;+25.815;+25.825;0 199706180230;00;CTRD;+22.470;+22.570;0 199706180230;00;ANZM;+22.450;+22.550;0 199706180230;00;AIGH;+22.400;+22.500;0 199706180234;00;BOAS;+22.400;+22.500;0 199706180237;00;AIGH;+22.350;+22.450;0 199706180238;01;HKBK;+22.310;+22.510;0 199706180239;00;AIGH;+22.330;+22.430;0 199706180252;00;GBNP;+22.470;+22.570;0 199706180258;00;OUBV;+22.450;+22.550;0 199706180314;00;ANZM;+22.350;+22.550;0 199706180329;00;MLMA;+22.350;+22.550;0 199706180339;00;CTRD;+22.450;+22.550;0 199706180349;00;SCBK;+25.810;+25.820;0 199706180352;00;HKBK;+22.400;+22.600;0 199706180402;00;TDBB;+25.815;+25.835;0 199706180407;00;ANZM;+22.400;+22.500;0 199706180409;00;ABNP;+25.810;+25.830;0 199706180411;00;MBRC;+22.350;+22.450;0 199706180441;00;HKBK;+22.300;+22.500;0 199706180447;00;AIGH;+22.300;+22.400;0 199706180455;00;ANZS;+22.350;+22.450;0 199706180459;00;AIGH;+22.280;+22.380;0 199706180511;00;AIGH;+22.250;+22.350;0 199706180514;00;HKBK;+22.200;+22.400;0 199706180514;00;AIGH;+22.230;+22.330;0 199706180516;00;AIGH;+22.200;+22.300;0 199706180521;00;MBRC;+22.150;+22.250;0 199706180521;00;SUMS;+22.100;+22.400;0 199706180528;00;MBRC;+22.350;+22.450;0 199706180533;00;AIGH;+22.600;+22.700;0 199706180538;00;AIGH;+22.500;+22.600;0 199706180540;00;BOAS;+22.700;+22.800;0 199706180541;00;BOAS;+22.700;+22.900;0 199706180541;01;BOAS;+22.800;+23.000;0 199706180543;00;BGFX;+22.850;+22.950;0 199706180543;00;BOAS;+22.900;+23.100;0 199706180544;00;MBRC;+22.900;+23.000;0 199706180544;00;MBRC;+22.980;+23.080;0 199706180544;00;BOAS;+23.000;+23.200;0 199706180545;00;MBRC;+22.900;+23.000;0 199706180546;00;BOAS;+22.750;+22.950;0 199706180547;00;MBRC;+22.800;+22.900;0 199706180550;00;ANZS;+22.800;+22.900;0 199706180555;00;AIGH;+22.870;+22.970;0 199706180558;00;AIGH;+22.850;+22.950;0 199706180603;00;AIGH;+22.800;+22.900;0 199706180606;00;ABNP;+25.820;+25.840;0 199706180610;00;CTRD;+22.850;+22.950;0 199706180611;00;EMFY;+22.800;+23.000;0 199706180614;00;CHIC;+22.850;+23.050;0 199706180618;00;BOAS;+22.850;+22.950;0 199706180618;00;BOAS;+22.700;+22.900;0 199706180625;00;BGFX;+22.750;+22.850;0 199706180631;00;SCFE;+22.750;+22.850;0 199706180631;00;AIGH;+22.850;+22.950;0 199706180639;00;ABNP;+25.830;+25.850;0 199706180644;00;CTRD;+22.950;+23.050;0 199706180651;00;BGFX;+22.950;+23.050;0 199706180653;00;AIGH;+22.900;+23.000;0 199706180657;00;AIGH;+23.000;+23.100;0 199706180702;00;MBRC;+23.050;+23.150;0 199706180702;00;MBRC;+22.950;+23.050;0 199706180704;00;BOAS;+22.930;+23.030;0 199706180707;00;AIGH;+22.900;+23.000;0 199706180708;00;ABNP;+25.835;+25.855;0 199706180711;00;CTRD;+22.880;+22.980;0 199706180711;00;BATH;+25.835;+25.855;0 199706180718;00;BOAS;+23.000;+23.100;0 199706180718;00;AIGH;+23.000;+23.100;0 199706180721;00;ABNP;+25.845;+25.875;0 199706180721;00;HKBK;+23.000;+23.200;0 199706180724;00;NTBB;+25.840;+25.860;0 199706180725;00;HKBK;+23.050;+23.250;0 199706180727;00;HKBK;+23.030;+23.230;0 199706180730;00;AIGH;+22.950;+23.050;0 199706180731;00;HKBK;+22.970;+23.170;0 199706180735;00;SCFE;+23.000;+23.100;0 199706180739;00;AIGH;+23.200;+23.300;0 199706180743;00;AIGH;+23.100;+23.200;0 199706180746;00;HKBK;+23.070;+23.270;0 199706180751;00;AIGH;+23.200;+23.300;0 199706180751;00;HKBK;+23.100;+23.300;0 199706180752;00;HKBK;+23.200;+23.400;0 199706180753;00;SCFE;+23.150;+23.350;0 199706180754;00;HKBK;+23.150;+23.350;0 199706180756;00;AIGH;+23.120;+23.220;0 199706180758;00;SCFE;+23.150;+23.250;0 199706180758;00;SCFE;+23.130;+23.230;0 199706180758;00;SCFE;+23.130;+23.330;0 199706180804;00;EMFY;+23.250;+23.450;0 199706180805;00;SCFE;+23.150;+23.350;0 199706180811;00;EMFY;+23.200;+23.400;0 199706180817;00;CTRD;+23.200;+23.300;0 199706180818;00;CBAX;+23.100;+23.300;0 199706180818;00;SCFE;+23.100;+23.300;0 199706180818;00;SCFE;+23.150;+23.350;0 199706180833;00;AIGH;+23.100;+23.200;0 199706180834;00;AIGH;+23.000;+23.200;0 199706180834;00;AIGH;+23.000;+23.100;0 199706180835;00;HKBK;+22.980;+23.180;0 199706180837;00;AIGH;+23.250;+23.350;0 199706180839;00;AIGH;+23.350;+23.450;0 199706180841;00;BNST;+23.350;+23.450;0 199706180853;00;MBRC;+23.350;+23.450;0 199706180855;00;CHIC;+23.300;+23.450;0 199706180858;00;AIGH;+23.450;+23.550;0 199706180858;00;HSBK;+25.840;+25.860;0 199706180859;00;BGFX;+23.200;+23.300;0 199706180901;00;BGFX;+23.200;+23.305;0 199706180901;00;BGFX;+23.200;+23.335;0 199706180901;00;BGFX;+23.200;+23.405;0 199706180901;00;BGFX;+23.200;+23.460;0 199706180901;00;BGFX;+23.200;+23.500;0 199706180901;00;BGFX;+23.200;+23.540;0 199706180901;00;BGFX;+23.200;+23.550;0 199706180901;00;CTRD;+23.500;+23.600;0 199706180901;00;BGFX;+23.200;+23.600;0 199706180901;00;BGFX;+23.205;+23.600;0 199706180901;00;BGFX;+23.275;+23.600;0 199706180901;00;BGFX;+23.330;+23.600;0 199706180902;00;BGFX;+23.385;+23.600;0 199706180902;00;BGFX;+23.400;+23.600;0 199706180907;00;AIGH;+23.470;+23.570;0 199706180919;00;HKBK;+23.450;+23.650;0 199706180919;00;AIGH;+23.550;+23.650;0 199706180920;00;CHIC;+23.400;+23.650;0 199706180933;00;AIGH;+23.470;+23.570;0 199706180938;00;AIGH;+23.550;+23.650;0 199706180940;00;AIGH;+23.700;+23.800;0 199706180947;00;AIGH;+23.600;+23.700;0 199706180950;00;BGFX;+23.550;+23.750;0 199706180955;00;AIGH;+23.650;+23.750;0 199706180959;00;BBLT;+25.850;+25.880;0 199706181002;00;SCFE;+23.580;+23.680;0 199706181004;00;AIGH;+23.550;+23.650;0 199706181010;00;AIGH;+23.500;+23.600;0 199706181011;00;SCFE;+23.530;+23.630;0 199706181027;00;AIGH;+23.600;+23.700;0 199706181030;00;EMFY;+23.500;+23.700;0 199706181041;00;AIGH;+23.550;+23.650;0 199706181056;00;AIGH;+23.600;+23.700;0 199706181059;00;AIGH;+23.550;+23.650;0 199706181108;00;AIGH;+23.500;+23.600;0 199706181111;00;AIGH;+23.470;+23.570;0 199706181112;00;AIGH;+23.450;+23.550;0 199706181140;00;SCFE;+23.400;+23.600;0 199706181143;00;SCFE;+23.450;+23.600;0 199706181152;00;EMFY;+23.400;+23.600;0 199706181215;00;AIGH;+23.550;+23.650;0 199706181219;00;EMFY;+23.480;+23.680;0 199706181224;00;AIGH;+23.600;+23.700;0 199706181228;00;AIGH;+23.650;+23.750;0 199706181229;00;SCFE;+23.550;+23.700;0 199706181229;00;SCFE;+23.550;+23.750;0 199706181230;00;AIGH;+23.700;+23.800;0 199706181236;00;CBAX;+23.600;+23.800;0 199706181240;00;BGFX;+23.600;+23.800;0 199706181247;00;AIGH;+23.650;+23.750;0 199706181248;00;AIGH;+23.600;+23.700;0 199706181256;00;AIGH;+23.700;+23.800;0 199706181259;00;SCFE;+23.580;+23.780;0 199706181259;00;AIGH;+23.680;+23.780;0 199706181300;00;AIGH;+23.700;+23.800;0 199706181301;00;AIGH;+23.750;+23.850;0 199706181303;00;AIGH;+23.800;+23.900;0 199706181310;00;AIGH;+23.850;+23.950;0 199706181312;00;AIGH;+23.800;+23.900;0 199706181312;00;SHDR;+23.800;+23.900;0 199706181314;00;AIGH;+23.750;+23.850;0 199706181315;00;AIGH;+23.700;+23.800;0 199706181316;00;AIGH;+23.650;+23.750;0 199706181317;00;AIGH;+23.600;+23.700;0 199706181317;00;EMFY;+23.500;+23.700;0 199706181318;00;SCFE;+23.600;+23.700;0 199706181318;00;AIGH;+23.550;+23.650;0 199706181322;00;AIGH;+23.600;+23.700;0 199706181326;00;AIGH;+23.580;+23.680;0 199706181327;00;AIGH;+23.550;+23.650;0 199706181329;00;AIGH;+23.500;+23.600;0 199706181329;00;SCFE;+23.550;+23.650;0 199706181334;00;AIGH;+23.650;+23.850;0 199706181334;00;BGFX;+23.500;+23.700;0 199706181339;00;SCFE;+23.650;+23.850;0 199706181340;00;AIGH;+23.600;+23.800;0 199706181345;00;AIGH;+23.700;+23.800;0 199706181347;00;SCEX;+23.550;+23.755;0 199706181347;00;SCEX;+23.550;+23.750;0 199706181353;00;AIGH;+23.600;+23.700;0 199706181356;00;AIGH;+23.550;+23.650;0 199706181359;00;AIGH;+23.500;+23.600;0 199706181359;00;AIGH;+23.450;+23.550;0 199706181359;00;AIGH;+23.400;+23.500;0 199706181400;00;AIGH;+23.250;+23.450;0 199706181400;00;BGFX;+23.350;+23.550;0 199706181404;00;SCFE;+23.550;+23.750;0 199706181404;00;AIGH;+23.600;+23.700;0 199706181404;00;SCFE;+23.600;+23.700;0 199706181417;00;AIGH;+23.650;+23.850;0 199706181421;00;SCFE;+23.620;+23.720;0 199706181438;00;AIGH;+23.700;+23.800;0 199706181443;00;BGFX;+23.650;+23.850;0 199706181524;00;AIGH;+23.800;+23.900;0 199706181527;00;AIGH;+23.750;+23.850;0 199706181530;00;AIGH;+23.700;+23.800;0 199706181535;00;AIGH;+23.800;+23.900;0 199706181537;00;AIGH;+23.700;+23.800;0 199706181537;00;AIGH;+23.650;+23.750;0 199706181537;00;AIGH;+23.600;+23.700;0 199706181545;00;AIGH;+23.700;+23.800;0 199706181552;00;SCFE;+23.600;+23.800;0 199706181552;00;AIGH;+23.650;+23.750;0 199706181555;00;SCFE;+23.700;+23.800;0 199706181656;00;AIGH;+23.600;+23.700;0 199706181707;00;AIGH;+23.550;+23.650;0 199706181814;00;AIGH;+23.450;+23.650;0 199706181908;00;SCEX;+23.600;+23.700;0 199706182012;00;ANZM;+23.600;+23.700;0 199706182116;00;SCEX;+24.200;+24.800;0 199706182117;00;ANZM;+24.000;+25.000;0 199706182130;00;SCEX;+24.350;+24.550;0 199706182130;20;SCEX;+24.350;+24.550;0 199706182150;00;ANZM;+24.400;+24.700;0 199706182252;00;SCEX;+25.000;+25.300;0 199706182252;00;ANZM;+25.000;+25.300;0 199706182322;00;ANZM;+25.000;+26.000;0 199706182359;00;MBRC;+25.000;+26.000;0 199706190000;00;MBRC;+25.000;+25.900;0 199706190007;00;SUMS;+25.200;+25.700;0 199706190028;00;SUMS;+24.900;+25.400;0 199706190034;00;ANZS;+24.900;+25.400;0 199706190047;00;BBLT;+25.840;+25.890;0 199706190047;00;HKBK;+25.050;+25.250;0 199706190058;00;HKBK;+24.900;+25.100;0 199706190109;00;MBRC;+24.900;+25.100;0 199706190110;00;ABNS;+23.900;+24.900;0 199706190116;00;ABNS;+24.100;+25.100;0 199706190119;00;MBRC;+24.800;+25.000;0 199706190131;00;BOAS;+24.900;+25.000;0 199706190143;00;ABNP;+25.850;+25.930;0 199706190148;00;GBNP;+25.000;+25.200;0 199706190154;00;BOAS;+25.200;+25.300;0 199706190157;00;ABNP;+25.860;+25.990;0 199706190158;00;BOAS;+25.200;+25.500;0 199706190200;00;SUMS;+24.950;+25.450;0 199706190202;07;MBRC;+25.000;+25.300;0 199706190210;00;SUMS;+24.000;+24.500;0 199706190211;00;SUMS;+25.000;+25.500;0 199706190226;00;CTRD;+25.300;+25.600;0 199706190235;00;CBAP;+25.200;+25.700;0 199706190239;00;ABNP;+25.920;+26.050;0 199706190243;00;GBNP;+25.600;+25.800;0 199706190255;00;SUMS;+26.000;+26.200;0 199706190256;01;UBRC;+25.800;+26.000;0 199706190258;00;OUBV;+26.000;+26.300;0 199706190312;00;BBLT;+26.000;+27.000;0 199706190313;00;BBLT;+25.900;+26.000;0 199706190315;00;BBLT;+26.500;+26.900;0 199706190320;00;BBLT;+26.000;+27.000;0 199706190329;00;AIGH;+26.800;+27.300;0 199706190330;00;AIGH;+25.800;+26.800;0 199706190331;00;GBNP;+26.500;+27.500;0 199706190333;00;MBRC;+26.500;+27.500;0 199706190345;00;AIGH;+26.000;+26.500;0 199706190346;00;AIGH;+25.900;+26.400;0 199706190346;00;AIGH;+25.800;+26.300;0 199706190347;00;AIGH;+25.500;+26.000;0 199706190347;00;AIGH;+25.300;+25.800;0 199706190348;00;AIGH;+25.200;+25.700;0 199706190351;00;AIGH;+25.000;+25.500;0 199706190354;00;AIGH;+25.500;+26.000;0 199706190355;00;AIGH;+25.750;+26.250;0 199706190358;00;AIGH;+25.500;+26.000;0 199706190358;00;AIGH;+25.400;+25.900;0 199706190359;00;AIGH;+25.300;+25.800;0 199706190400;00;BATH;+25.800;+25.950;0 199706190401;01;BBLT;+25.500;+26.500;0 199706190403;00;CBAP;+25.000;+27.000;0 199706190403;00;BATH;+25.850;+25.950;0 199706190404;00;CBAP;+25.500;+26.500;0 199706190405;00;AIGH;+25.700;+26.200;0 199706190407;00;HKBK;+25.600;+26.100;0 199706190410;00;BATH;+25.800;+25.900;0 199706190415;00;EMFY;+26.100;+26.600;0 199706190416;00;AIGH;+25.500;+26.000;0 199706190417;00;EMFY;+26.000;+26.500;0 199706190421;00;EMFY;+26.100;+26.600;0 199706190421;00;EMFY;+26.000;+26.500;0 199706190421;00;EMFY;+25.900;+26.400;0 199706190421;00;HKBK;+25.800;+26.000;0 199706190421;00;AIGH;+25.400;+26.000;0 199706190421;00;EMFY;+25.800;+26.300;0 199706190421;00;AIGH;+25.500;+26.000;0 199706190422;00;EMFY;+25.850;+26.350;0 199706190422;00;ANZM;+25.900;+26.200;0 199706190422;00;EMFY;+26.100;+26.300;0 199706190425;00;GBNP;+25.800;+26.100;0 199706190425;00;AIGH;+25.450;+25.950;0 199706190425;00;EMFY;+26.000;+26.300;0 199706190426;00;ANZM;+25.800;+26.100;0 199706190427;00;AIGH;+25.400;+25.900;0 199706190427;00;ANZM;+25.600;+26.100;0 199706190428;00;AIGH;+25.300;+25.800;0 199706190428;00;CTBT;+25.820;+25.920;0 199706190428;00;EMFY;+25.750;+26.250;0 199706190429;00;CTBT;+25.800;+25.900;0 199706190431;00;CTBT;+25.810;+25.910;0 199706190434;00;AIGH;+25.650;+25.950;0 199706190435;00;AIGH;+25.600;+25.900;0 199706190435;00;ANZM;+25.300;+25.800;0 199706190436;00;EMFY;+25.300;+25.800;0 199706190436;00;EMFY;+25.500;+26.000;0 199706190437;00;EMFY;+25.600;+26.100;0 199706190438;00;ANZM;+25.400;+25.900;0 199706190439;00;ANZM;+25.450;+25.950;0 199706190440;00;AIGH;+25.500;+25.800;0 199706190440;00;AIGH;+25.400;+25.700;0 199706190441;00;BATH;+25.850;+25.890;0 199706190442;00;HKBK;+25.700;+26.100;0 199706190442;00;AIGH;+25.350;+25.650;0 199706190443;00;BOAS;+25.650;+25.750;0 199706190443;00;BOAS;+25.550;+25.650;0 199706190446;00;EMFY;+25.100;+25.600;0 199706190446;00;BATH;+25.850;+25.880;0 199706190446;00;EMFY;+25.200;+25.700;0 199706190446;00;ANZM;+25.200;+25.700;0 199706190447;00;EMFY;+25.150;+25.650;0 199706190449;00;CTBT;+25.800;+25.900;0 199706190450;00;ANZM;+25.150;+25.650;0 199706190452;00;AIGH;+25.600;+25.700;0 199706190457;00;BATH;+25.800;+25.850;0 199706190457;00;ANZM;+25.420;+25.920;0 199706190458;00;AIGH;+25.500;+25.600;0 199706190459;00;AIGH;+25.450;+25.550;0 199706190459;00;AIGH;+25.400;+25.500;0 199706190500;00;ANZM;+25.000;+25.500;0 199706190502;00;AIGH;+25.450;+25.550;0 199706190502;00;HKBK;+25.450;+25.650;0 199706190505;00;AIGH;+25.300;+25.500;0 199706190505;00;AIGH;+25.250;+25.450;0 199706190507;00;AIGH;+25.200;+25.400;0 199706190507;00;AIGH;+25.150;+25.350;0 199706190508;00;AIGH;+25.100;+25.300;0 199706190509;00;AIGH;+25.050;+25.250;0 199706190510;00;AIGH;+25.000;+25.200;0 199706190515;00;ANZM;+25.100;+25.600;0 199706190518;00;BOAS;+25.400;+25.500;0 199706190519;00;ANZM;+25.050;+25.450;0 199706190523;00;ANZM;+24.700;+25.200;0 199706190526;00;ABNS;+25.200;+25.300;0 199706190530;00;ANZM;+24.800;+25.300;0 199706190532;00;AIGH;+24.900;+25.100;0 199706190534;00;INDS;+25.000;+25.200;0 199706190535;00;MBRC;+24.800;+25.300;0 199706190535;00;AIGH;+24.850;+25.050;0 199706190535;00;ANZM;+24.500;+25.000;0 199706190536;00;BGFX;+24.650;+24.850;0 199706190537;00;HSBK;+25.830;+25.880;0 199706190537;00;AIGH;+24.800;+25.000;0 199706190538;00;CTRD;+24.900;+25.100;0 199706190538;00;CTRD;+24.900;+25.250;0 199706190538;00;CTRD;+24.900;+25.000;0 199706190538;00;ANZM;+24.400;+24.900;0 199706190539;00;AIGH;+24.750;+24.950;0 199706190539;00;AIGH;+24.700;+24.900;0 199706190542;00;AIGH;+24.800;+25.000;0 199706190549;00;BOAS;+24.900;+25.100;0 199706190605;00;ANZM;+24.700;+25.200;0 199706190611;00;ANZM;+24.650;+25.150;0 199706190615;00;EMFY;+24.900;+25.100;0 199706190616;00;ANZM;+24.700;+25.100;0 199706190625;00;CHIC;+24.800;+25.200;0 199706190629;00;ANZM;+24.650;+25.150;0 199706190631;00;ANZM;+24.700;+25.100;0 199706190632;00;BOAS;+25.000;+25.200;0 199706190632;00;ANZM;+24.650;+25.015;0 199706190635;00;BGFX;+24.730;+24.930;0 199706190637;00;BGFX;+24.580;+25.080;0 199706190637;00;ANZM;+24.700;+25.200;0 199706190642;00;AIGH;+24.950;+25.050;0 199706190643;00;ANZM;+24.800;+25.100;0 199706190648;00;CTBT;+25.830;+25.880;0 199706190648;01;ANZM;+24.750;+25.150;0 199706190655;01;BGFX;+24.700;+25.200;0 199706190656;00;MBRC;+25.000;+25.100;0 199706190658;00;ANZM;+24.800;+25.100;0 199706190706;00;WBCM;+24.900;+25.000;0 199706190706;00;SCFE;+24.800;+25.100;0 199706190706;00;SCFE;+24.900;+25.100;0 199706190717;00;SCFE;+24.950;+25.150;0 199706190724;00;SBIC;+24.900;+25.200;0 199706190725;00;AIGH;+24.800;+25.050;0 199706190725;00;EMFY;+24.000;+24.200;0 199706190725;00;EMFY;+23.950;+24.150;0 199706190726;00;AIGH;+24.900;+25.000;0 199706190727;00;EMFY;+23.850;+24.050;0 199706190729;00;HKBK;+24.950;+25.050;0 199706190731;00;EMFY;+24.950;+25.150;0 199706190731;00;EMFY;+24.900;+25.100;0 199706190732;00;EMFY;+24.850;+25.050;0 199706190732;00;EMFY;+24.900;+25.100;0 199706190735;00;SCFE;+24.900;+25.100;0 199706190747;00;MBRC;+24.950;+25.050;0 199706190804;00;EMFY;+24.920;+25.120;0 199706190805;00;EMFY;+24.900;+25.100;0 199706190814;00;BBLT;+25.870;+25.920;0 199706190817;00;BOAT;+25.840;+25.940;0 199706190817;00;SCFE;+24.920;+25.120;0 199706190817;00;SCFE;+24.900;+25.100;0 199706190818;00;EMFY;+24.950;+25.100;0 199706190818;00;BOAT;+25.845;+25.945;0 199706190819;00;EMFY;+24.950;+25.150;0 199706190819;00;BOAS;+24.950;+25.050;0 199706190822;00;EMFY;+24.900;+25.100;0 199706190827;00;EMFY;+24.800;+25.300;0 199706190827;00;EMFY;+24.800;+25.100;0 199706190828;00;EMFY;+24.900;+25.100;0 199706190828;00;SCFE;+24.950;+25.150;0 199706190830;00;SCFE;+24.900;+25.100;0 199706190831;00;SCFE;+24.950;+25.150;0 199706190838;00;EMFY;+25.000;+25.200;0 199706190840;00;EMFY;+25.020;+25.120;0 199706190843;00;EMFY;+25.030;+25.130;0 199706190843;00;EMFY;+25.000;+25.100;0 199706190843;00;CBAX;+24.800;+25.300;0 199706190920;01;EMFY;+25.100;+25.300;0 199706190950;00;BGFX;+24.950;+25.450;0 199706190953;00;EMFY;+25.000;+25.200;0 199706191002;00;EMFY;+25.050;+25.350;0 199706191002;00;EMFY;+25.000;+25.400;0 199706191030;00;EMFY;+25.200;+25.700;0 199706191032;00;SCFE;+25.250;+25.450;0 199706191055;00;BGFX;+25.100;+25.600;0 199706191100;00;EMFY;+25.100;+25.600;0 199706191122;00;EMFY;+25.150;+25.650;0 199706191151;00;CHIC;+25.100;+25.400;0 199706191209;00;EMFY;+25.100;+25.600;0 199706191212;00;SCEX;+25.100;+25.300;0 199706191330;00;SCFE;+25.000;+25.200;0 199706191342;00;SCFE;+24.950;+25.150;0 199706191356;00;SCFE;+25.000;+25.200;0 199706191409;00;BGFX;+24.850;+25.350;0 199706191412;00;EMFY;+24.900;+25.500;0 199706191422;00;CHIC;+25.000;+25.250;0 199706191451;00;BGFX;+24.500;+25.000;0 199706191456;00;SCFE;+24.950;+25.150;0 199706191457;00;SCFE;+25.000;+25.100;0 199706191457;00;SCFE;+25.000;+26.000;0 199706191457;00;SCFE;+25.000;+25.200;0 199706191520;01;EMFY;+25.100;+25.600;0 199706191526;00;SCFE;+25.020;+25.220;0 199706191526;00;SCFE;+25.000;+25.200;0 199706191644;00;RBCI;+24.800;+24.900;0 199706191645;00;RBCI;+24.820;+24.920;0 199706191645;01;RBCI;+24.830;+24.930;0 199706191657;00;RBCI;+25.000;+25.100;0 199706192147;00;ANZM;+25.100;+25.600;0 199706200000;00;MBRC;+25.100;+25.200;0 199706200016;00;GBNP;+25.200;+25.700;0 199706200022;00;HKBK;+25.200;+25.500;0 199706200026;00;UOBX;+25.050;+25.850;0 199706200036;00;BOAS;+25.200;+25.500;0 199706200037;00;ANZS;+25.200;+25.500;0 199706200047;00;ANZM;+25.150;+25.650;0 199706200050;00;UOBX;+25.060;+25.660;0 199706200053;00;MBRC;+25.100;+25.600;0 199706200053;00;HKBK;+25.250;+25.450;0 199706200054;00;AIGH;+25.100;+25.300;0 199706200054;00;HKBK;+25.000;+25.300;0 199706200055;00;AIGH;+25.000;+25.200;0 199706200056;00;MBRC;+24.900;+25.400;0 199706200056;00;ANZM;+24.600;+25.100;0 199706200100;00;BOAS;+25.000;+25.200;0 199706200104;00;UOBX;+24.850;+25.850;0 199706200105;01;ANZM;+24.700;+25.200;0 199706200107;00;ABNS;+25.050;+25.250;0 199706200108;00;ANZM;+24.500;+25.000;0 199706200109;00;MBRC;+25.050;+25.250;0 199706200112;00;ANZM;+24.700;+25.200;0 199706200116;00;UOBX;+24.650;+25.650;0 199706200116;00;CTRD;+25.150;+25.350;0 199706200130;00;AIGH;+25.200;+25.400;0 199706200132;00;UOBX;+25.000;+25.700;0 199706200140;00;UOBX;+25.100;+25.800;0 199706200149;00;ANZM;+25.000;+26.000;0 199706200153;00;BOAS;+25.500;+26.000;0 199706200153;00;UOBX;+25.200;+26.000;0 199706200155;00;ANZM;+25.100;+25.900;0 199706200158;00;AIGH;+25.400;+25.700;0 199706200159;00;ANZM;+25.000;+25.500;0 199706200200;00;AIGH;+25.200;+25.500;0 199706200201;08;MBRC;+25.100;+25.600;0 199706200201;08;AIGH;+25.150;+25.450;0 199706200203;06;AIGH;+25.100;+25.400;0 199706200205;04;AIGH;+25.050;+25.350;0 199706200208;01;ANZM;+24.900;+25.400;0 199706200210;00;HKBK;+25.400;+26.300;0 199706200210;00;HKBK;+25.400;+25.600;0 199706200210;00;HSBK;+25.900;+26.000;0 199706200211;00;ANZM;+24.800;+25.300;0 199706200211;01;MBRC;+25.400;+25.500;0 199706200214;00;CHAB;+25.900;+26.000;0 199706200218;00;UOBX;+25.250;+25.950;0 199706200222;00;BOAS;+25.300;+25.500;0 199706200223;00;SUMS;+24.950;+25.450;0 199706200230;00;AIGH;+25.100;+25.400;0 199706200230;00;UOBX;+25.050;+25.750;0 199706200231;00;AIGH;+25.050;+25.350;0 199706200232;00;ANZS;+25.000;+25.500;0 199706200233;00;HKBK;+25.250;+25.450;0 199706200234;00;HKBK;+25.300;+25.600;0 199706200235;00;INBT;+25.930;+26.030;0 199706200236;00;MBRC;+25.200;+25.400;0 199706200237;00;UOBX;+25.060;+25.860;0 199706200241;00;UOBX;+25.100;+25.750;0 199706200251;00;AIGH;+25.150;+25.450;0 199706200252;00;AIGH;+25.100;+25.400;0 199706200252;00;UOBX;+25.050;+25.700;0 199706200253;00;AIGH;+25.000;+25.300;0 199706200256;00;OUBV;+25.450;+25.550;0 199706200256;00;BBLS;+25.400;+25.600;0 199706200236;48;WLDB;+24.900;+25.400;0 199706200326;00;BBLT;+25.950;+26.050;0 199706200331;00;BBLT;+25.920;+26.020;0 199706200340;00;MBRC;+25.550;+25.650;0 199706200352;00;BATH;+25.950;+26.010;0 199706200352;00;BATH;+25.900;+26.010;0 199706200356;00;ANZM;+24.200;+24.700;0 199706200358;00;ANZM;+25.200;+25.700;0 199706200424;00;UOBX;+25.050;+25.750;0 199706200433;00;UOBX;+25.080;+25.780;0 199706200454;00;AIGH;+25.250;+25.550;0 199706200500;00;UOBX;+25.100;+25.800;0 199706200501;00;MBRC;+25.400;+25.600;0 199706200503;00;ANZM;+25.100;+25.500;0 199706200505;00;CTRD;+25.400;+25.600;0 199706200514;00;AIGH;+25.150;+25.450;0 199706200533;00;CTBT;+25.890;+25.990;0 199706200537;00;HKBK;+25.350;+25.550;0 199706200538;00;ANZM;+25.250;+25.550;0 199706200554;00;BGFX;+25.150;+25.650;0 199706200559;00;UOBX;+25.050;+25.750;0 199706200611;00;CHIC;+25.250;+25.550;0 199706200628;00;CTBT;+25.960;+26.040;0 199706200629;00;ABNS;+25.400;+25.600;0 199706200642;00;EMFY;+25.450;+25.650;0 199706200655;00;SCFE;+25.500;+25.700;0 199706200705;00;AIGH;+25.400;+25.600;0 199706200708;00;SCFE;+25.500;+25.600;0 199706200708;00;SCFE;+25.500;+25.700;0 199706200708;00;SCFE;+25.480;+25.680;0 199706200712;00;SCFE;+25.550;+25.750;0 199706200723;00;ANZS;+25.400;+25.800;0 199706200731;00;AIGH;+25.400;+25.700;0 199706200736;00;SCFE;+25.680;+25.880;0 199706200738;00;BOAS;+25.700;+25.800;0 199706200742;00;AIGH;+25.800;+26.000;0 199706200747;00;BOAS;+25.800;+26.000;0 199706200753;00;BGFX;+25.650;+26.150;0 199706200804;00;ABNP;+25.950;+26.400;0 199706200806;00;SCFE;+25.750;+25.950;0 199706200813;00;SCRS;+25.800;+25.890;0 199706200818;00;UOBX;+25.200;+25.900;0 199706200825;00;UOBX;+25.250;+26.250;0 199706200831;00;CTRD;+25.800;+26.000;0 199706200900;00;BOAS;+25.900;+26.000;0 199706200901;00;MBRC;+25.800;+26.000;0 199706200907;00;HSBK;+26.000;+26.100;0 199706200914;00;BGFX;+25.800;+26.300;0 199706200925;00;BNSV;+25.900;+26.100;0 199706200933;00;SCFE;+25.900;+26.100;0 199706200937;00;AIGH;+25.900;+26.000;0 199706200938;00;AIGH;+25.870;+25.970;0 199706200938;00;SCFE;+25.920;+26.120;0 199706200939;00;SCFE;+25.890;+26.090;0 199706200943;00;AIGH;+25.850;+25.950;0 199706200955;00;AIGH;+25.800;+25.900;0 199706200959;00;AIGH;+25.750;+25.850;0 199706201000;00;EMFY;+25.700;+25.900;0 199706201000;00;AIGH;+25.700;+25.800;0 199706201001;00;CHIC;+25.650;+25.900;0 199706201002;00;AIGH;+25.650;+25.750;0 199706201005;00;AIGH;+25.600;+25.700;0 199706201009;00;AIGH;+25.550;+25.650;0 199706201011;00;CBAX;+25.500;+25.700;0 199706201014;00;AIGH;+25.450;+25.650;0 199706201015;00;AIGH;+25.400;+25.600;0 199706201017;00;AIGH;+25.350;+25.550;0 199706201018;00;AIGH;+25.300;+25.500;0 199706201018;00;AIGH;+25.250;+25.450;0 199706201019;00;AIGH;+25.200;+25.400;0 199706201019;00;AIGH;+25.150;+25.350;0 199706201019;00;AIGH;+25.100;+25.300;0 199706201020;00;AIGH;+25.050;+25.250;0 199706201020;00;AIGH;+25.000;+25.200;0 199706201022;00;BGFX;+24.850;+25.350;0 199706201023;00;CBAX;+25.000;+25.300;0 199706201023;00;AIGH;+24.900;+25.100;0 199706201029;00;SCFE;+25.000;+25.300;0 199706201036;00;SCFE;+25.200;+25.600;0 199706201041;00;BGFX;+25.150;+25.650;0 199706201058;00;CTBT;+26.050;+26.250;0 199706201100;00;AIGH;+25.400;+25.600;0 199706201100;01;AIGH;+25.350;+25.550;0 199706201101;00;AIGH;+25.300;+25.500;0 199706201102;00;AIGH;+25.250;+25.450;0 199706201102;00;SCFE;+25.300;+25.600;0 199706201102;00;SCFE;+25.350;+25.650;0 199706201102;00;AIGH;+25.200;+25.400;0 199706201104;00;AIGH;+25.150;+25.350;0 199706201109;00;AIGH;+25.100;+25.300;0 199706201117;00;AIGH;+25.050;+25.250;0 199706201119;00;SCFE;+25.100;+25.400;0 199706201119;00;AIGH;+25.000;+25.200;0 199706201119;00;CHIC;+25.000;+25.300;0 199706201120;00;AIGH;+25.100;+25.200;0 199706201142;00;EMFY;+25.100;+25.600;0 199706201205;00;AIGH;+24.900;+25.400;0 199706201211;00;AIGH;+24.800;+25.300;0 199706201213;00;AIGH;+24.750;+25.250;0 199706201216;00;AIGH;+24.700;+25.200;0 199706201223;00;AIGH;+24.650;+25.150;0 199706201224;01;AIGH;+24.600;+25.100;0 199706201227;00;AIGH;+24.550;+25.050;0 199706201230;00;AIGH;+24.500;+25.000;0 199706201231;01;AIGH;+24.450;+24.950;0 199706201233;00;BGFX;+25.120;+25.620;0 199706201233;00;BGFX;+25.060;+25.560;0 199706201233;00;BGFX;+24.990;+25.490;0 199706201233;00;BGFX;+24.925;+25.425;0 199706201233;00;BGFX;+24.870;+25.370;0 199706201233;00;BGFX;+24.865;+25.365;0 199706201233;00;BGFX;+24.800;+25.300;0 199706201234;00;BGFX;+24.775;+25.275;0 199706201234;00;BGFX;+24.780;+25.280;0 199706201235;00;AIGH;+24.400;+24.900;0 199706201242;00;EMFY;+24.800;+25.000;0 199706201243;00;AIGH;+24.350;+24.850;0 199706201244;00;AIGH;+24.300;+24.800;0 199706201244;00;EMFY;+24.750;+24.900;0 199706201245;00;EMFY;+24.750;+24.950;0 199706201245;00;AIGH;+24.250;+24.750;0 199706201245;00;EMFY;+24.750;+24.850;0 199706201245;00;EMFY;+24.700;+24.900;0 199706201246;00;EMFY;+24.750;+24.850;0 199706201246;00;AIGH;+24.200;+24.700;0 199706201247;00;EMFY;+24.700;+24.900;0 199706201247;00;EMFY;+24.680;+24.880;0 199706201247;00;EMFY;+24.700;+24.900;0 199706201247;01;SCEX;+24.650;+24.750;0 199706201248;00;EMFY;+24.700;+24.800;0 199706201248;00;AIGH;+24.150;+24.650;0 199706201250;00;EMFY;+24.680;+24.880;0 199706201250;00;CTBT;+25.930;+26.130;0 199706201252;00;BBNF;+24.600;+24.900;0 199706201255;00;BGFX;+24.500;+25.000;0 199706201259;00;AIGH;+24.100;+24.600;0 199706201307;00;CHIC;+24.600;+25.100;0 199706201320;01;AIGH;+24.650;+24.750;0 199706201330;00;AIGH;+24.000;+24.500;0 199706201338;00;SCFE;+24.500;+24.800;0 199706201342;00;AIGH;+23.900;+24.400;0 199706201347;00;BBNF;+24.500;+24.700;0 199706201353;00;AIGH;+24.000;+24.500;0 199706201354;00;AIGH;+23.950;+24.450;0 199706201355;00;AIGH;+23.900;+24.400;0 199706201356;00;AIGH;+23.800;+24.300;0 199706201357;00;AIGH;+23.700;+24.200;0 199706201357;00;EMFY;+24.200;+24.500;0 199706201358;00;CHIC;+24.000;+24.500;0 199706201402;00;AIGH;+23.650;+24.150;0 199706201405;00;AIGH;+23.600;+24.100;0 199706201407;00;EMFY;+24.000;+24.500;0 199706201409;00;AIGH;+24.000;+24.100;0 199706201409;00;BGFX;+23.800;+24.300;0 199706201411;00;AIGH;+23.600;+24.100;0 199706201416;00;AIGH;+23.500;+24.000;0 199706201420;01;CBAX;+23.800;+24.000;0 199706201454;00;BGFX;+23.650;+24.150;0 199706201512;00;SCFE;+23.950;+24.150;0 199706201518;00;BGFX;+23.800;+24.300;0 199706201542;00;SCFE;+24.000;+24.300;0 199706201902;00;SCEX;+24.000;+24.500;0 199706201906;00;SCEX;+23.750;+24.250;0 199706201915;00;SCEX;+24.000;+24.500;0 199706211915;99;SCEX;+24.000;+24.500;0 199706222019;00;BNST;+24.400;+24.410;0 199706222211;00;ANZM;+24.000;+25.000;0 199706222220;00;CBAP;+24.500;+25.500;0 199706222220;00;ANZM;+24.200;+25.200;0 199706222227;00;CBAP;+24.600;+25.600;0 199706222252;00;ANZM;+24.100;+25.100;0 199706230010;00;MBRC;+24.000;+24.500;0 199706230019;00;AIGH;+24.000;+24.200;0 199706230019;00;HKBK;+24.000;+24.500;0 199706230023;00;AIGH;+23.750;+24.250;0 199706230024;00;AIGH;+23.600;+24.100;0 199706230028;00;AIGH;+23.500;+24.000;0 199706230029;00;ANZS;+23.900;+24.600;0 199706230029;00;AIGH;+24.000;+24.200;0 199706230034;00;BOAS;+24.200;+24.300;0 199706230037;00;HKBK;+24.100;+24.600;0 199706230059;00;BOAS;+24.100;+24.750;0 199706230101;02;AIGH;+24.100;+24.200;0 199706230102;01;UOBX;+24.050;+25.850;0 199706230104;00;UOBX;+24.050;+24.850;0 199706230110;00;HKBK;+24.250;+24.750;0 199706230116;00;BOAS;+24.200;+24.700;0 199706230116;00;UOBX;+24.100;+24.800;0 199706230119;00;AIGH;+24.000;+24.500;0 199706230131;00;STTA;+26.000;+26.100;0 199706230133;00;SUMS;+24.000;+24.500;0 199706230135;00;BTCO;+24.250;+24.500;0 199706230139;00;HKBK;+24.200;+24.700;0 199706230149;00;INDS;+24.200;+24.700;0 199706230151;00;INDS;+24.100;+24.700;0 199706230151;00;INDS;+24.200;+24.700;0 199706230202;06;BOAS;+24.700;+25.200;0 199706230203;05;AIGH;+24.300;+24.800;0 199706230206;02;SUMS;+24.300;+24.800;0 199706230209;00;ANZS;+24.300;+24.800;0 199706230209;00;ANZM;+24.300;+24.800;0 199706230237;00;ABNP;+25.850;+26.100;0 199706230237;00;ABNP;+25.860;+26.150;0 199706230240;00;ABNS;+24.500;+24.700;0 199706230254;00;UOBX;+24.200;+24.900;0 199706230315;00;AIGH;+24.000;+24.500;0 199706230317;00;BBLT;+26.000;+26.150;0 199706230318;00;DBSS;+24.500;+24.800;0 199706230319;00;ANZM;+24.500;+25.000;0 199706230324;00;MLMA;+24.500;+25.500;0 199706230324;01;AIGH;+24.350;+24.850;0 199706230344;00;BBLS;+24.300;+24.500;0 199706230345;00;TDBB;+26.000;+26.100;0 199706230354;00;SCBK;+26.000;+26.100;0 199706230409;00;UOBX;+24.250;+25.050;0 199706230418;00;CTBT;+25.950;+26.050;0 199706230431;00;BOAS;+24.650;+24.850;0 199706230435;00;UOBX;+24.300;+25.100;0 199706230441;00;CTRD;+24.600;+24.900;0 199706230452;00;MBRC;+24.500;+25.000;0 199706230452;00;MBRC;+24.550;+24.850;0 199706230502;00;UOBX;+24.250;+25.050;0 199706230505;00;HKBK;+24.650;+24.950;0 199706230608;00;EMFY;+24.650;+24.750;0 199706230616;00;BGFX;+24.450;+24.950;0 199706230627;00;CHIC;+24.500;+25.000;0 199706230645;00;CTRD;+24.600;+24.800;0 199706230657;00;WBCM;+24.500;+25.000;0 199706230702;00;CTBT;+26.000;+26.100;0 199706230704;00;HKBK;+24.750;+24.950;0 199706230724;00;HKBK;+24.800;+25.000;0 199706230725;00;EMFY;+24.650;+24.850;0 199706230736;00;SCFE;+24.700;+25.000;0 199706230739;00;CTRD;+24.800;+25.000;0 199706230753;00;SUMS;+24.500;+25.000;0 199706230804;00;HKBK;+24.950;+25.150;0 199706230812;00;BGFX;+24.800;+25.300;0 199706230812;00;EMFY;+24.800;+25.000;0 199706230823;00;MBRC;+24.950;+25.150;0 199706230825;00;CBAX;+24.900;+25.200;0 199706230848;00;MBRC;+24.800;+25.000;0 199706230857;00;HSBK;+25.950;+26.050;0 199706230903;00;CHIC;+24.700;+24.720;0 199706230903;00;CHIC;+24.700;+25.200;0 199706230909;00;HKBK;+24.850;+25.050;0 199706230911;00;INDS;+24.700;+25.700;0 199706230912;00;INDS;+24.700;+25.400;0 199706230913;00;INDS;+24.700;+25.100;0 199706230913;00;INDS;+24.500;+25.100;0 199706230914;00;INDS;+24.500;+24.600;0 199706230914;00;INDS;+24.700;+24.800;0 199706230914;01;INDS;+24.700;+24.710;0 199706230915;00;INDS;+24.700;+24.800;0 199706230915;00;INDS;+24.700;+25.400;0 199706230915;00;INDS;+24.700;+25.100;0 199706230944;01;ANZZ;+25.900;+26.100;0 199706230951;00;CHIC;+24.850;+25.150;0 199706230954;00;ANZZ;+24.910;+25.110;0 199706230954;00;ANZZ;+24.900;+25.100;0 199706231236;00;SCEX;+24.900;+25.200;0 199706231543;00;SCEX;+24.750;+25.250;0 199706232128;00;ANZM;+24.900;+25.400;0 199706232356;00;MBRC;+25.000;+25.200;0 199706240013;00;HKBK;+24.900;+25.200;0 199706240038;00;ANZS;+24.900;+25.300;0 199706240040;00;BOAS;+24.900;+25.200;0 199706240045;00;UOBX;+24.750;+25.450;0 199706240045;00;HKBK;+25.100;+25.300;0 199706240048;00;HKBK;+25.150;+25.350;0 199706240052;00;UOBX;+24.850;+25.550;0 199706240052;01;HKBK;+25.250;+25.400;0 199706240053;00;HKBK;+25.250;+25.450;0 199706240102;01;UOBX;+24.950;+25.650;0 199706240109;00;GBNP;+25.250;+25.350;0 199706240114;00;ANZS;+25.200;+25.400;0 199706240117;00;BLBS;+25.250;+25.650;0 199706240139;00;MBRC;+25.300;+25.400;0 199706240147;00;ANZM;+25.300;+25.800;0 199706240152;01;STTA;+25.950;+26.050;0 199706240203;05;HKBK;+25.450;+25.650;0 199706240229;00;ABNP;+25.850;+25.910;0 199706240239;00;UOBX;+25.050;+26.050;0 199706240244;00;HKBK;+25.450;+25.600;0 199706240246;00;SUMS;+25.000;+25.500;0 199706240248;00;AIGH;+24.900;+25.400;0 199706240248;00;AIGH;+24.850;+25.350;0 199706240248;01;AIGH;+24.800;+25.300;0 199706240249;00;SUMS;+24.800;+25.200;0 199706240249;00;AIGH;+24.750;+25.250;0 199706240249;00;SUMS;+24.800;+25.100;0 199706240250;00;SUMS;+24.900;+25.200;0 199706240251;00;HKBK;+25.050;+25.250;0 199706240251;00;UOBX;+24.800;+25.300;0 199706240314;00;STTA;+25.870;+25.970;0 199706240315;00;HKBK;+25.100;+25.300;0 199706240317;00;BBLT;+25.900;+25.950;0 199706240319;00;CTRD;+25.100;+25.300;0 199706240319;00;MLMA;+25.000;+25.200;0 199706240325;00;ABNP;+25.870;+25.940;0 199706240329;00;AIGH;+24.650;+25.150;0 199706240330;00;TDBB;+25.900;+25.950;0 199706240332;00;AIGH;+24.550;+25.050;0 199706240333;00;HSBK;+25.900;+26.000;0 199706240333;00;AIGH;+24.500;+25.000;0 199706240336;00;AIGH;+24.400;+24.900;0 199706240340;00;BBLS;+24.800;+25.100;0 199706240352;00;SCBK;+25.900;+26.000;0 199706240428;00;UOBX;+24.750;+25.250;0 199706240456;00;HKBK;+25.050;+25.250;0 199706240536;00;SUMS;+25.100;+25.400;0 199706240614;00;BGFX;+25.000;+25.500;0 199706240618;01;EMFY;+25.000;+25.200;0 199706240620;00;BBLH;+25.300;+25.500;0 199706240622;00;CHIC;+25.200;+25.600;0 199706240641;00;MBRC;+25.400;+25.600;0 199706240643;01;ABNP;+25.850;+25.920;0 199706240644;00;AIGH;+25.000;+25.500;0 199706240644;01;SCFE;+25.300;+25.600;0 199706240651;00;AIGH;+24.900;+25.400;0 199706240652;00;EMFY;+25.300;+25.500;0 199706240705;00;HKBK;+25.400;+25.600;0 199706240722;00;WBCM;+25.350;+25.650;0 199706240722;00;WBCM;+25.350;+25.365;0 199706240722;01;HKBK;+25.420;+25.620;0 199706240728;00;CTBT;+25.850;+25.950;0 199706240743;00;SCFE;+25.200;+25.500;0 199706240754;00;INDS;+25.400;+25.470;0 199706240755;00;INDS;+25.400;+25.500;0 199706240755;00;INDS;+25.500;+25.600;0 199706240755;01;GBNP;+25.450;+25.650;0 199706240803;00;SCRS;+24.400;+24.600;0 199706240803;00;CTRD;+25.400;+25.600;0 199706240804;00;SCRS;+24.200;+24.700;0 199706240806;00;SCRS;+25.200;+25.700;0 199706240820;00;HKBK;+25.400;+25.600;0 199706240825;00;HKBK;+25.450;+25.600;0 199706240836;00;ANZS;+25.300;+25.600;0 199706240912;00;MBRC;+25.400;+25.700;0 199706240932;00;EMFY;+25.400;+25.600;0 199706240941;00;BGFX;+25.250;+25.750;0 199706240942;00;CBAX;+25.400;+25.600;0 199706240946;00;BNST;+25.400;+25.600;0 199706240951;00;BNSV;+25.400;+25.600;0 199706241125;00;SCFE;+25.400;+25.600;0 199706241126;00;ANZZ;+25.400;+25.600;0 199706241221;00;SCFE;+25.300;+25.500;0 199706241239;00;SCEX;+25.350;+25.550;0 199706241249;00;SCFE;+25.250;+25.450;0 199706241315;00;EMFY;+25.050;+25.250;0 199706241344;00;SCFE;+25.100;+25.400;0 199706241420;00;BGFX;+25.000;+25.500;0 199706241421;00;EMFY;+25.000;+25.200;0 199706241618;01;SCEX;+25.100;+25.300;0 199706241754;00;BBNF;+25.050;+25.350;0 199706241856;00;SCEX;+25.000;+25.200;0 199706241942;00;SCEX;+25.000;+25.300;0 199706242228;00;CBAP;+24.900;+25.400;0 199706242229;00;CBAP;+24.950;+25.400;0 199706242229;00;CBAP;+24.950;+25.450;0 199706242334;00;SCRS;+25.150;+25.550;0 199706242349;00;SCRS;+25.000;+25.400;0 199706250003;00;MBRC;+25.100;+25.350;0 199706250014;00;ANZS;+25.000;+25.500;0 199706250055;00;INDS;+24.200;+24.250;0 199706250055;00;INDS;+25.200;+25.250;0 199706250055;00;INDS;+25.200;+25.300;0 199706250055;00;INDS;+25.200;+26.200;0 199706250055;00;INDS;+25.200;+26.100;0 199706250056;00;SCRS;+25.200;+25.400;0 199706250105;00;UOBX;+25.050;+25.550;0 199706250107;00;AIGH;+24.800;+25.300;0 199706250111;00;ABNS;+25.150;+25.450;0 199706250111;00;GBNP;+25.250;+25.450;0 199706250117;00;MBRC;+25.200;+25.400;0 199706250126;00;CTBT;+25.820;+25.920;0 199706250127;00;BOAS;+25.300;+25.500;0 199706250147;00;SCRS;+25.100;+25.400;0 199706250147;00;STTA;+25.800;+25.900;0 199706250152;00;ABNP;+25.830;+25.900;0 199706250152;00;ANZS;+25.100;+25.400;0 199706250233;00;HKBK;+25.300;+25.600;0 199706250251;00;MBRC;+25.250;+25.350;0 199706250256;00;OUBV;+25.250;+25.400;0 199706250323;00;MLMA;+25.250;+25.350;0 199706250326;00;HKBK;+25.300;+25.500;0 199706250329;00;CTBT;+25.830;+25.890;0 199706250335;01;TDBB;+25.820;+25.870;0 199706250431;00;AYUD;+25.820;+25.870;0 199706250437;00;HSBK;+25.830;+25.880;0 199706250439;00;SCRS;+25.100;+25.400;0 199706250503;00;AIGH;+24.750;+25.250;0 199706250514;00;BOAS;+25.200;+25.300;0 199706250518;00;UOBX;+25.030;+25.530;0 199706250554;00;SCRS;+25.050;+25.450;0 199706250555;00;GBNP;+25.250;+25.350;0 199706250557;00;EMFY;+25.200;+25.300;0 199706250559;00;CHIC;+25.250;+25.550;0 199706250612;00;BGFX;+25.150;+25.650;0 199706250631;01;AIGH;+25.050;+25.350;0 199706250641;00;SUMS;+25.001;+25.004;0 199706250641;00;SUMS;+25.000;+25.250;0 199706250642;00;SUMS;+25.000;+25.500;0 199706250655;00;AIGH;+24.800;+25.300;0 199706250706;00;SCFE;+25.200;+25.400;0 199706250709;00;AIGH;+24.750;+25.250;0 199706250715;01;SCFE;+25.250;+25.350;0 199706250717;00;BOAT;+25.830;+25.850;0 199706250736;00;UBRC;+25.280;+25.380;0 199706250740;00;INBT;+25.820;+25.850;0 199706250754;00;EMFY;+25.400;+25.600;0 199706250756;00;SCFE;+25.250;+25.450;0 199706250756;00;HKBK;+25.250;+25.450;0 199706250758;00;INDS;+25.200;+25.250;0 199706250759;00;INDS;+25.200;+25.300;0 199706250759;00;EMFY;+25.200;+25.400;0 199706250803;00;BNSV;+25.200;+25.400;0 199706250809;00;BNST;+25.200;+25.400;0 199706251146;00;RABS;+25.300;+25.500;0 199706251205;00;SCFE;+25.150;+25.350;0 199706251206;00;SCEX;+25.150;+25.350;0 199706252030;00;ANZM;+25.250;+25.350;0 199706260003;00;MBRC;+25.250;+25.350;0 199706260035;00;UOBX;+25.050;+25.550;0 199706260035;01;BOAS;+25.250;+25.450;0 199706260054;00;UOBX;+25.040;+25.540;0 199706260058;00;GBNP;+25.300; +0.000;0 199706260058;00;GBNP;+25.300;+25.450;0 199706260102;01;BBLS;+25.250;+25.450;0 199706260115;01;HKBK;+25.300;+25.500;0 199706260118;00;UOBX;+25.100;+25.600;0 199706260121;00;CHAB;+25.800;+25.900;0 199706260122;00;CHAB;+25.850;+25.950;0 199706260152;00;SCRS;+25.300;+25.304;0 199706260152;00;SCRS;+25.300;+25.500;0 199706260214;00;BOAT;+25.850;+25.900;0 199706260217;00;AIGH;+25.450;+25.550;0 199706260217;00;SUMS;+25.500;+25.800;0 199706260236;00;AIGH;+25.400;+25.500;0 199706260238;00;AIGH;+25.380;+25.480;0 199706260239;00;UOBX;+25.110;+25.610;0 199706260240;01;AIGH;+25.350;+25.450;0 199706260241;00;AIGH;+25.300;+25.400;0 199706260249;00;ABNP;+25.840;+25.910;0 199706260318;00;AIGH;+25.000;+25.500;0 199706260342;00;CTRD;+25.400;+25.500;0 199706260344;00;BBLT;+25.850;+25.870;0 199706260345;00;TDBB;+25.840;+25.870;0 199706260345;00;ABNP;+25.830;+25.880;0 199706260349;00;CHAB;+25.860;+25.960;0 199706260350;00;SCBK;+25.830;+25.860;0 199706260350;00;CHAB;+25.850;+25.950;0 199706260427;00;HSBK;+25.840;+25.870;0 199706260513;01;AIGH;+25.200;+25.400;0 199706260526;00;HKBK;+25.400;+25.500;0 199706260557;01;MBRC;+25.450;+25.500;0 199706260559;00;CHIC;+25.300;+25.600;0 199706260604;00;SUMS;+25.000;+25.500;0 199706260612;01;BGFX;+24.750;+25.250;0 199706260618;00;ABNS;+25.400;+25.550;0 199706260620;00;EMFY;+25.300;+25.500;0 199706260628;00;SUMS;+25.450;+25.550;0 199706260649;00;EMFY;+25.400;+25.600;0 199706260701;00;BGFX;+25.150;+25.650;0 199706260710;00;BOAS;+25.450;+25.550;0 199706260717;00;INBT;+25.830;+25.880;0 199706260720;00;GBNP;+25.500;+25.600;0 199706260728;00;ABNP;+25.850;+25.900;0 199706260730;00;SCFE;+25.500;+25.700;0 199706260840;00;BNSV;+25.500;+25.700;0 199706260842;00;BTCO;+25.550;+25.650;0 199706260911;00;MBRC;+25.600;+25.700;0 199706260911;00;EMFY;+25.450;+25.650;0 199706261020;00;BNST;+25.450;+25.650;0 199706261155;00;CHIC;+25.050;+25.350;0 199706261225;00;EMFY;+25.200;+25.400;0 199706261306;00;SCFE;+25.250;+25.450;0 199706261311;00;RABS;+25.300;+25.450;0 199706261326;01;SCFE;+25.150;+25.350;0 199706261327;00;SCFE;+25.250;+25.450;0 199706261407;00;BGFX;+25.000;+25.500;0 199706261420;00;SCFE;+25.200;+25.400;0 199706261432;00;RABS;+25.300;+25.500;0 199706261441;00;SCFE;+25.300;+25.500;0 199706261441;01;SCFE;+25.200;+25.400;0 199706262339;01;ANZM;+25.200;+25.500;0 199706270017;00;MBRC;+25.200;+25.300;0 199706270023;00;BOAS;+25.300;+25.500;0 199706270026;00;ANZS;+25.300;+25.500;0 199706270041;00;BBLS;+25.350;+25.450;0 199706270049;00;UOBX;+25.100;+25.600;0 199706270055;00;BBLS;+25.330;+25.430;0 199706270101;02;BBLS;+25.350;+25.450;0 199706270102;01;BBLS;+25.400;+25.500;0 199706270103;00;BBLS;+25.350;+25.450;0 199706270126;00;UOBX;+25.120;+25.620;0 199706270133;00;STTA;+25.840;+25.890;0 199706270135;00;SCRS;+25.350;+25.450;0 199706270231;00;STTA;+25.850;+25.900;0 199706270316;00;BBLS;+25.250;+25.350;0 199706270324;00;MLMA;+22.350;+22.550;0 199706270326;00;SUMS;+25.320;+25.420;0 199706270326;00;MBRC;+25.320;+25.420;0 199706270332;00;MLMA;+25.320;+25.420;0 199706270334;00;TDBB;+25.820;+25.900;0 199706270350;00;CTBT;+25.840;+25.890;0 199706270359;00;SCBK;+25.820;+25.900;0 199706270427;00;ANZM;+25.100;+25.400;0 199706270438;00;UOBX;+25.000;+25.500;0 199706270446;00;ABNP;+25.840;+25.900;0 199706270505;00;SCRS;+25.250;+25.350;0 199706270613;00;SCRS;+25.200;+25.300;0 199706270628;00;BBLT;+25.850;+25.900;0 199706270636;00;AIGH;+25.120;+25.220;0 199706270639;00;BGFX;+25.120;+25.620;0 199706270702;00;CHIC;+25.100;+25.350;0 199706270707;00;AIGH;+25.100;+25.200;0 199706270711;00;SCRS;+25.210;+25.310;0 199706270807;00;HSBK;+25.850;+25.900;0 199706270809;00;SCRS;+25.200;+25.300;0 199706270841;00;SCFE;+25.000;+25.200;0 199706270851;01;MBRC;+25.200;+25.300;0 199706270853;00;CTRD;+25.050;+25.150;0 199706270922;00;CHIC;+24.850;+25.150;0 199706270934;00;CTRD;+24.800;+25.000;0 199706270941;00;BGFX;+24.550;+25.050;0 199706270943;00;CTRD;+24.600;+24.900;0 199706270946;00;CTRD;+24.500;+24.800;0 199706270948;01;SCFE;+24.500;+24.800;0 199706271048;00;AIGH;+24.750;+24.850;0 199706271132;00;BBNF;+24.600;+24.900;0 199706271200;03;AIGN;+24.750;+24.850;0 199706271211;00;AIGN;+24.800;+24.900;0 199706271228;00;AIGN;+24.820;+24.870;0 199706271238;00;BBNF;+24.750;+24.900;0 199706271256;00;SCFE;+24.800;+25.100;0 199706271300;01;AIGN;+25.650;+25.750;0 199706271303;00;AIGN;+24.650;+24.750;0 199706271339;00;BBNF;+24.500;+24.700;0 199706271347;00;AIGN;+24.550;+24.650;0 199706271401;00;AIGN;+24.500;+24.700;0 199706271407;00;SCFE;+24.400;+24.700;0 199706271456;01;BBNF;+24.300;+24.600;0 199706271515;00;AIGH;+24.100;+24.300;0 199706271515;00;BGFX;+24.050;+24.550;0 199706271538;01;AIGH;+24.000;+24.300;0 199706271554;01;AIGH;+24.000;+24.200;0 199706271633;00;AIGN;+25.200;+25.350;0 199706271636;00;AIGN;+24.200;+24.350;0 199706271636;00;SCEX;+24.200;+24.400;0 199706271705;00;AIGH;+24.050;+24.250;0 199706271724;00;AIGH;+24.000;+24.200;0 199706271824;00;AIGN;+25.200;+25.300;0 199706271833;00;SCEX;+24.000;+24.500;0 199706271856;00;AIGN;+24.150;+24.350;0 199706281856;99;AIGN;+24.150;+24.350;0 199706292057;00;ANZM;+24.000;+24.500;0 199706292131;00;ANZM;+24.001;+24.051;0 199706292316;00;SCRS;+24.250;+24.550;0 199706292354;01;AIGH;+24.100;+24.300;0 199706300028;00;BOAS;+24.100;+24.600;0 199706300029;00;AIGH;+23.950;+24.150;0 199706300031;01;CTRD;+24.100;+24.500;0 199706300032;00;MBRC;+24.700;+24.750;0 199706300036;00;MBRC;+24.200;+24.500;0 199706300036;00;BBLS;+24.100;+24.300;0 199706300041;00;BBLS;+24.200;+24.500;0 199706300046;00;UOBX;+24.050;+25.550;0 199706300046;01;ANZS;+24.100;+24.600;0 199706300049;00;UOBX;+24.050;+24.550;0 199706300059;00;ABNS;+24.400;+24.605;0 199706300059;00;GBNP;+24.450;+24.750;0 199706300059;00;ABNS;+24.400;+24.700;0 199706300059;00;ABNS;+24.400;+24.600;0 199706300101;02;UOBX;+24.150;+24.650;0 199706300128;00;ABNS;+24.500;+25.000;0 199706300149;00;AIGH;+24.250;+24.750;0 199706300153;00;SUMS;+24.500;+24.800;0 199706300224;01;SCRS;+24.600;+24.800;0 199706300231;00;UOBX;+24.350;+24.850;0 199706300236;00;ANZM;+24.350;+24.950;0 199706300248;00;SCRS;+24.500;+24.700;0 199706300254;00;UOBX;+24.330;+24.830;0 199706300317;00;BBLT;+25.870;+25.970;0 199706300325;00;CTBT;+25.870;+25.920;0 199706300335;00;TDBB;+25.870;+25.910;0 199706300345;00;BBLS;+24.100;+24.600;0 199706300402;00;BBLS;+24.000;+24.500;0 199706300417;00;BATH;+25.860;+25.910;0 199706300428;00;SCRS;+24.250;+24.550;0 199706300441;00;MBRC;+24.300;+24.500;0 199706300549;00;SBES;+24.450;+24.650;0 199706300559;00;UOBX;+24.250;+24.750;0 199706300615;00;EMFY;+24.250;+24.450;0 199706300621;00;BGFX;+24.350;+24.850;0 199706300623;00;BGFX;+24.100;+24.600;0 199706300627;00;CBAX;+24.300;+24.800;0 199706300634;00;SCFE;+24.500;+24.800;0 199706300651;00;CBAX;+24.500;+24.800;0 199706300653;00;BATH;+25.880;+25.930;0 199706300655;00;MBRC;+24.600;+24.700;0 199706300655;01;SUMS;+24.550;+24.650;0 199706300736;00;BBLS;+24.500;+24.800;0 199706300740;00;TLBS;+24.500;+24.800;0 199706300754;00;BGFX;+24.400;+24.900;0 199706300840;00;SCFE;+24.600;+24.900;0 199706300925;00;UOBX;+24.450;+24.950;0 199706300953;00;SCFE;+24.800;+25.000;0 199706301003;00;CBAX;+24.800;+25.100;0 199706301026;00;BNSV;+24.750;+25.250;0 199706301030;00;CHIC;+24.900;+25.100;0 199706301053;00;AIGN;+24.900;+25.100;0 199706301149;00;EMFY;+24.900;+25.100;0 199706301341;00;AIGN;+24.800;+25.000;0 199706301444;00;BGFX;+24.650;+25.150;0 199706301700;00;SCEX;+24.700;+25.000;0 199706301902;00;SCEX;+24.250;+24.750;0 199706301906;00;SCEX;+24.450;+24.650;0 199706301909;00;SCEX;+24.400;+24.900;0 199706302014;00;ANZM;+24.650;+24.750;0 199706302328;00;CBAP;+24.250;+24.750;0 199706302330;00;SCEX;+24.650;+24.950;0 199706302332;00;SCRS;+24.450;+24.750;0 199706302344;00;MBRC;+24.600;+24.800;0 fBasics/data/cars2.csv0000644000176200001440000000636213202116740014267 0ustar liggesusersrowNames;Price;Country;Reliability;Mileage;Type;Weight;Disp.;HP Eagle Summit 4;8895;USA;4;33;Small;2560;97;113 Ford Escort 4;7402;USA;2;33;Small;2345;114;90 Ford Festiva 4;6319;Korea;4;37;Small;1845;81;63 Honda Civic 4;6635;Japan/USA;5;32;Small;2260;91;92 Mazda Protege 4;6599;Japan;5;32;Small;2440;113;103 Mercury Tracer 4;8672;Mexico;4;26;Small;2285;97;82 Nissan Sentra 4;7399;Japan/USA;5;33;Small;2275;97;90 Pontiac LeMans 4;7254;Korea;1;28;Small;2350;98;74 Subaru Loyale 4;9599;Japan;5;25;Small;2295;109;90 Subaru Justy 3;5866;Japan;NA;34;Small;1900;73;73 Toyota Corolla 4;8748;Japan/USA;5;29;Small;2390;97;102 Toyota Tercel 4;6488;Japan;5;35;Small;2075;89;78 Volkswagen Jetta 4;9995;Germany;3;26;Small;2330;109;100 Chevrolet Camaro V8;11545;USA;1;20;Sporty;3320;305;170 Dodge Daytona;9745;USA;1;27;Sporty;2885;153;100 Ford Mustang V8;12164;USA;1;19;Sporty;3310;302;225 Ford Probe;11470;USA;3;30;Sporty;2695;133;110 Honda Civic CRX Si 4;9410;Japan;5;33;Sporty;2170;97;108 Honda Prelude Si 4WS 4;13945;Japan;5;27;Sporty;2710;125;140 Nissan 240SX 4;13249;Japan;3;24;Sporty;2775;146;140 Plymouth Laser;10855;USA;NA;26;Sporty;2840;107;92 Subaru XT 4;13071;Japan;NA;28;Sporty;2485;109;97 Audi 80 4;18900;Germany;NA;27;Compact;2670;121;108 Buick Skylark 4;10565;USA;2;23;Compact;2640;151;110 Chevrolet Beretta 4;10320;USA;1;26;Compact;2655;133;95 Chrysler Le Baron V6;10945;USA;4;25;Compact;3065;181;141 Ford Tempo 4;9483;USA;2;24;Compact;2750;141;98 Honda Accord 4;12145;Japan/USA;5;26;Compact;2920;132;125 Mazda 626 4;12459;Japan/USA;4;24;Compact;2780;133;110 Mitsubishi Galant 4;10989;Japan;5;25;Compact;2745;122;102 Mitsubishi Sigma V6;17879;Japan;4;21;Compact;3110;181;142 Nissan Stanza 4;11650;Japan;5;21;Compact;2920;146;138 Oldsmobile Calais 4;9995;USA;2;23;Compact;2645;151;110 Peugeot 405 4;15930;France;;24;Compact;2575;116;120 Subaru Legacy 4;11499;Japan/USA;5;23;Compact;2935;135;130 Toyota Camry 4;11588;Japan/USA;5;27;Compact;2920;122;115 Volvo 240 4;18450;Sweden;3;23;Compact;2985;141;114 Acura Legend V6;24760;Japan;5;20;Medium;3265;163;160 Buick Century 4;13150;USA;3;21;Medium;2880;151;110 Chrysler Le Baron Coupe;12495;USA;2;22;Medium;2975;153;150 Chrysler New Yorker V6;16342;USA;3;22;Medium;3450;202;147 Eagle Premier V6;15350;USA;2;22;Medium;3145;180;150 Ford Taurus V6;13195;USA;3;22;Medium;3190;182;140 Ford Thunderbird V6;14980;USA;1;23;Medium;3610;232;140 Hyundai Sonata 4;9999;Korea;NA;23;Medium;2885;143;110 Mazda 929 V6;23300;Japan;5;21;Medium;3480;180;158 Nissan Maxima V6;17899;Japan;5;22;Medium;3200;180;160 Oldsmobile Cutlass Ciera 4;13150;USA;2;21;Medium;2765;151;110 Oldsmobile Cutlass Supreme V6;14495;USA;NA;21;Medium;3220;189;135 Toyota Cressida 6;21498;Japan;3;23;Medium;3480;180;190 Buick Le Sabre V6;16145;USA;3;23;Large;3325;231;165 Chevrolet Caprice V8;14525;USA;1;18;Large;3855;305;170 Ford LTD Crown Victoria V8;17257;USA;3;20;Large;3850;302;150 Chevrolet Lumina APV V6;13995;USA;NA;18;Van;3195;151;110 Dodge Grand Caravan V6;15395;USA;3;18;Van;3735;202;150 Ford Aerostar V6;12267;USA;3;18;Van;3665;182;145 Mazda MPV V6;14944;Japan;5;19;Van;3735;181;150 Mitsubishi Wagon 4;14929;Japan;NA;20;Van;3415;143;107 Nissan Axxess 4;13949;Japan;NA;20;Van;3185;146;138 Nissan Van 4;14799;Japan;NA;19;Van;3690;146;106 fBasics/data/SWXLP.csv0000644000176200001440000030765413202116740014202 0ustar liggesusers%Y-%m-%d;SBI;SPI;SII;LP25;LP40;LP60 2000-01-03;95.88;5022.86;146.264;99.81;99.71;99.55 2000-01-04;95.68;4853.06;146.266;98.62;97.93;96.98 2000-01-05;95.67;4802.81;145.543;98.26;97.36;96.11 2000-01-06;95.54;4861.37;146.099;98.13;97.2;95.88 2000-01-07;95.58;4971.8;146.009;98.89;98.34;97.53 2000-01-10;95.58;4982.29;146.357;99.19;98.79;98.21 2000-01-11;95.48;4968.49;146.314;98.95;98.48;97.8 2000-01-12;95.47;4977.76;146.275;98.91;98.42;97.71 2000-01-13;95.51;4985.22;147.094;99.2;98.81;98.24 2000-01-14;95.65;5042.25;146.94;99.79;99.68;99.52 2000-01-17;95.53;5047.21;147.126;99.91;99.9;99.88 2000-01-18;95.39;4972.39;147.224;99.42;99.23;98.98 2000-01-19;95.32;4948.53;146.636;99.29;99.04;98.7 2000-01-20;95.25;4902.95;146.367;99.14;98.8;98.34 2000-01-21;95.24;4902.42;145.966;99.07;98.73;98.27 2000-01-24;95.18;4841.11;145.992;98.9;98.42;97.79 2000-01-25;95.24;4755.05;146.093;98.69;98.04;97.21 2000-01-26;95.22;4771.43;147.393;98.81;98.24;97.51 2000-01-27;95.12;4853.21;146.911;99.16;98.83;98.4 2000-01-28;94.96;4804.86;146.803;98.86;98.43;97.87 2000-01-31;95.01;4717.22;147.053;98.7;98.17;97.53 2000-02-01;95.15;4791.86;147.149;99.22;98.88;98.48 2000-02-02;95.19;4827.56;147.506;99.45;99.22;98.97 2000-02-03;95.08;4887.15;147.31;99.48;99.36;99.21 2000-02-04;95.09;4869.56;147.029;99.56;99.48;99.43 2000-02-07;95.03;4859.41;146.859;99.42;99.31;99.2 2000-02-08;95.09;4867.8;146.41;99.6;99.54;99.51 2000-02-09;95.1;4807.2;146.714;99.32;99.09;98.84 2000-02-10;95;4781.58;146.556;99.19;98.96;98.72 2000-02-11;94.95;4778.65;146.413;98.99;98.67;98.28 2000-02-14;94.97;4754.87;146.014;99.06;98.72;98.33 2000-02-15;94.82;4686.02;146.766;98.68;98.21;97.66 2000-02-16;94.54;4747.6;145.873;98.54;98.14;97.65 2000-02-17;94.62;4799.34;145.656;98.74;98.4;97.99 2000-02-18;94.54;4824.66;145.615;98.52;98.07;97.47 2000-02-21;94.57;4772.78;144.919;98.32;97.71;96.91 2000-02-22;94.58;4811.57;145.095;98.25;97.55;96.59 2000-02-23;94.51;4848.03;144.613;98.53;98.01;97.29 2000-02-24;94.46;4832.86;143.539;98.61;98.12;97.45 2000-02-25;94.42;4803.76;143.295;98.75;98.35;97.83 2000-02-28;94.25;4758.93;142.314;98.71;98.37;97.96 2000-02-29;94.3;4750.92;141.844;98.91;98.66;98.4 2000-03-01;94.34;4798.53;141.685;99.17;99.06;98.97 2000-03-02;94.26;4860.84;141.665;99.43;99.5;99.66 2000-03-03;94.28;4850.61;141.958;99.71;99.9;100.24 2000-03-06;94.32;4904.67;141.907;99.8;99.99;100.3 2000-03-07;94.38;4883.14;142.286;99.67;99.73;99.86 2000-03-08;94.36;4805.12;141.683;99.47;99.42;99.44 2000-03-09;94.39;4787.45;140.714;99.52;99.5;99.56 2000-03-10;94.31;4793.21;140.879;99.57;99.6;99.73 2000-03-13;94.34;4693.71;140.763;99.19;98.95;98.73 2000-03-14;94.23;4738.34;140.279;99.19;98.97;98.76 2000-03-15;94.1;4725.83;140.571;99.06;98.82;98.57 2000-03-16;94.03;4871.47;140.645;99.74;99.92;100.23 2000-03-17;94.04;4866.28;140.784;99.93;100.2;100.65 2000-03-20;94.03;4922.66;139.608;100.1;100.43;100.95 2000-03-21;94;4959.52;139.67;100.31;100.8;101.53 2000-03-22;93.92;5033.5;140.396;100.57;101.24;102.2 2000-03-23;93.82;5032.77;140.136;100.36;101.01;101.93 2000-03-24;93.59;5083.49;139.887;100.23;100.97;102 2000-03-27;93.4;5047.49;140.162;100.05;100.79;101.84 2000-03-28;93.27;5054.27;140.364;100.07;100.86;101.97 2000-03-29;93.05;5073.5;141.003;100.3;101.27;102.64 2000-03-30;93.01;5049.04;140.92;99.88;100.64;101.7 2000-03-31;92.86;5075.78;142.31;99.99;100.86;102.07 2000-04-03;92.8;5116.34;142.994;99.89;100.74;101.9 2000-04-04;92.99;5141.02;143.188;99.97;100.77;101.85 2000-04-05;93.47;5057.3;143.25;99.75;100.16;100.71 2000-04-06;93.41;5065.52;143.542;99.79;100.32;101.03 2000-04-07;93.48;5064.3;143.207;100.08;100.72;101.62 2000-04-10;93.77;5049.73;142.811;100.22;100.78;101.56 2000-04-11;93.84;5074.53;142.684;100.07;100.51;101.1 2000-04-12;93.65;5115.68;142.175;99.98;100.43;101.01 2000-04-13;93.6;5117.4;142.271;99.81;100.16;100.58 2000-04-14;93.56;5060.67;142.115;99.05;98.94;98.68 2000-04-17;93.53;4970.05;142.23;98.89;98.69;98.35 2000-04-18;93.37;4988.74;141.592;99.27;99.38;99.51 2000-04-19;93.25;5003.16;141.551;99.33;99.53;99.77 2000-04-20;93.22;5013.79;141.408;99.43;99.7;100.04 2000-04-21;93.22;5013.79;141.408;99.43;99.7;100.04 2000-04-24;93.22;5013.79;141.408;99.38;99.63;99.94 2000-04-25;93.03;5052.1;140.864;99.88;100.49;101.32 2000-04-26;92.82;5078.69;139.862;99.84;100.52;101.44 2000-04-27;92.79;5054.14;139.391;99.85;100.56;101.54 2000-04-28;92.58;5062.73;138.8;99.71;100.44;101.45 2000-05-01;92.58;5062.73;138.8;99.76;100.56;101.67 2000-05-02;92.61;5148.17;138.867;99.84;100.67;101.8 2000-05-03;92.62;5139.62;137.644;99.52;100.22;101.15 2000-05-04;92.58;5133.56;138.57;99.46;100.16;101.07 2000-05-05;92.6;5129.34;138.316;99.64;100.42;101.48 2000-05-08;92.68;5145.7;138.005;99.6;100.29;101.2 2000-05-09;92.68;5181.95;138.119;99.49;100.07;100.79 2000-05-10;92.64;5157.6;138.132;99.18;99.54;99.94 2000-05-11;92.54;5241.77;138.018;99.43;100.02;100.73 2000-05-12;92.45;5265.97;137.848;99.51;100.22;101.08 2000-05-15;92.47;5257.22;137.499;99.55;100.25;101.11 2000-05-16;92.43;5287.21;137.721;99.85;100.74;101.91 2000-05-17;92.2;5263.87;137.127;99.61;100.51;101.65 2000-05-18;92.11;5300.78;137.045;99.65;100.55;101.7 2000-05-19;92.03;5253.56;136.902;99.22;99.89;100.7 2000-05-22;92.09;5237.43;136.117;98.84;99.26;99.7 2000-05-23;92.18;5297.42;136.172;99.11;99.54;99.96 2000-05-24;92.19;5297.11;135.968;99.29;99.76;100.26 2000-05-25;92.13;5347.58;137.958;99.31;99.82;100.35 2000-05-26;92.18;5281.56;139.094;99.01;99.29;99.51 2000-05-29;92.22;5297.52;138.94;99.19;99.53;99.81 2000-05-30;92.15;5251.29;138.792;99.4;99.9;100.47 2000-05-31;92.3;5269.66;138.744;99.45;100;100.63 2000-06-01;92.3;5269.66;138.744;99.69;100.37;101.2 2000-06-02;92.48;5346.03;139.612;100.08;100.93;101.98 2000-06-05;92.34;5321.05;138.993;100.14;100.95;101.95 2000-06-06;92.4;5295.42;139.089;99.83;100.45;101.17 2000-06-07;92.58;5330.17;138.781;100.01;100.64;101.37 2000-06-08;92.48;5341.11;139.535;99.9;100.53;101.24 2000-06-09;92.45;5336.14;139.251;99.8;100.42;101.12 2000-06-12;92.45;5336.14;139.251;99.67;100.21;100.8 2000-06-13;92.44;5334.84;139.995;99.73;100.27;100.86 2000-06-14;92.43;5370.99;139.946;99.89;100.51;101.21 2000-06-15;92.43;5333.66;139.738;99.86;100.45;101.12 2000-06-16;92.54;5345.88;140.088;99.78;100.24;100.7 2000-06-19;92.55;5314.28;140.015;99.86;100.37;100.92 2000-06-20;92.48;5320.89;139.965;99.84;100.39;101.02 2000-06-21;92.38;5295.97;139.534;99.72;100.31;101 2000-06-22;92.37;5235.29;138.689;99.51;99.97;100.5 2000-06-23;92.42;5238.37;137.562;99.57;100.03;100.54 2000-06-26;92.37;5241.37;137.41;99.54;99.99;100.49 2000-06-27;92.43;5242.17;137.299;99.45;99.82;100.19 2000-06-28;92.52;5264.54;137.008;99.66;100.09;100.54 2000-06-29;92.56;5253.98;137.14;99.62;99.93;100.22 2000-06-30;92.66;5293.34;137.608;99.76;100.12;100.48 2000-07-03;92.65;5318.93;136.708;100;100.51;101.08 2000-07-04;92.65;5351.49;136.687;100.07;100.61;101.22 2000-07-05;92.81;5382.58;136.782;99.97;100.35;100.7 2000-07-06;92.99;5413.23;136.917;100.07;100.46;100.81 2000-07-07;92.99;5423;136.371;100.37;100.93;101.52 2000-07-10;93.1;5435.26;136.801;100.48;101.03;101.6 2000-07-11;93.25;5446.01;136.294;100.7;101.27;101.88 2000-07-12;93.25;5431.35;135.893;100.89;101.56;102.33 2000-07-13;93.16;5471.54;135.164;101.03;101.81;102.72 2000-07-14;93.14;5464.9;135.108;100.99;101.79;102.74 2000-07-17;93.1;5450.09;134.839;100.99;101.81;102.8 2000-07-18;93.14;5433.73;134.122;100.88;101.58;102.39 2000-07-19;93.06;5454.34;134.341;100.95;101.71;102.61 2000-07-20;93.12;5463.87;134.452;101.11;101.94;102.94 2000-07-21;93.18;5448.21;134.277;100.93;101.58;102.32 2000-07-24;93.21;5505.41;134.527;101.01;101.64;102.32 2000-07-25;93.21;5505.25;134.7;100.86;101.42;101.98 2000-07-26;93.15;5495.93;134.233;100.7;101.17;101.6 2000-07-27;93.07;5490.74;133.941;100.56;100.98;101.34 2000-07-28;92.93;5489.64;134.794;100.4;100.77;101.06 2000-07-31;92.85;5504.14;135.713;100.46;100.91;101.29 2000-08-01;92.85;5504.14;135.713;100.57;101.07;101.53 2000-08-02;92.9;5585.35;134.677;100.94;101.6;102.29 2000-08-03;92.87;5575.78;135.002;101.09;101.83;102.63 2000-08-04;92.86;5580.18;136.157;101.19;101.97;102.83 2000-08-07;92.88;5655.54;136.12;101.47;102.39;103.41 2000-08-08;92.93;5653.38;136.615;101.61;102.6;103.74 2000-08-09;92.98;5658.87;136.164;101.75;102.76;103.93 2000-08-10;93.13;5639.88;136.568;101.63;102.48;103.43 2000-08-11;93.16;5655.71;137.225;101.96;102.94;104.07 2000-08-14;93.13;5690.01;136.773;102.13;103.24;104.53 2000-08-15;93.09;5687.15;136.837;102.05;103.1;104.33 2000-08-16;93.03;5730.99;136.698;102.15;103.29;104.62 2000-08-17;93.02;5689.41;136.572;102.09;103.18;104.45 2000-08-18;93.01;5686.91;137.054;102.17;103.29;104.62 2000-08-21;92.97;5713.61;138.346;102.27;103.46;104.89 2000-08-22;93.04;5739.89;139.153;102.5;103.79;105.34 2000-08-23;93.09;5770.05;140.229;102.51;103.8;105.34 2000-08-24;93.19;5758.82;140.832;102.36;103.53;104.91 2000-08-25;93.3;5736.29;141.796;102.38;103.52;104.87 2000-08-28;93.37;5753.37;142.441;102.55;103.76;105.22 2000-08-29;93.39;5704.34;142.753;102.55;103.73;105.17 2000-08-30;93.37;5676.34;142.88;102.54;103.69;105.1 2000-08-31;93.34;5681.82;142.132;102.71;103.96;105.51 2000-09-01;93.47;5690.66;142.682;102.8;104.03;105.54 2000-09-04;93.52;5673.55;142.349;102.93;104.18;105.73 2000-09-05;93.49;5662.85;142.257;102.98;104.24;105.82 2000-09-06;93.43;5641.44;142.083;102.82;104.03;105.53 2000-09-07;93.39;5644.45;141.994;102.97;104.28;105.94 2000-09-08;93.41;5625.33;142.28;102.91;104.16;105.73 2000-09-11;93.44;5625.34;141.934;102.53;103.6;104.91 2000-09-12;93.46;5586.63;141.739;102.32;103.29;104.43 2000-09-13;93.51;5579.74;141.612;102.27;103.16;104.2 2000-09-14;93.67;5565.31;141.789;102.51;103.43;104.52 2000-09-15;93.68;5573.87;141.211;102.44;103.28;104.25 2000-09-18;93.6;5524.6;140.308;102.17;102.88;103.67 2000-09-19;93.57;5483.78;138.952;102.01;102.68;103.44 2000-09-20;93.55;5459.6;139;101.93;102.58;103.31 2000-09-21;93.56;5466.14;138.599;101.89;102.47;103.08 2000-09-22;93.58;5511.47;139.218;101.6;101.97;102.24 2000-09-25;93.48;5550.31;138.941;101.69;102.16;102.58 2000-09-26;93.39;5518.53;139.757;101.52;101.86;102.08 2000-09-27;93.35;5514.37;139.386;101.48;101.82;102.07 2000-09-28;93.39;5520.03;139.412;101.66;102.11;102.49 2000-09-29;93.45;5423.6;139.516;101.43;101.72;101.91 2000-10-02;93.46;5526.35;139.702;101.64;102.03;102.34 2000-10-03;93.49;5572.97;139.378;101.71;102.12;102.45 2000-10-04;93.56;5566.71;139.994;101.79;102.24;102.62 2000-10-05;93.57;5578.45;139.9;101.99;102.5;102.96 2000-10-06;93.57;5549.83;139.269;101.8;102.17;102.43 2000-10-09;93.64;5441.5;139.004;101.55;101.72;101.72 2000-10-10;93.63;5478.84;138.852;101.54;101.68;101.63 2000-10-11;93.75;5375.42;139.133;100.95;100.68;100.07 2000-10-12;93.78;5393.8;139.388;100.82;100.49;99.78 2000-10-13;93.84;5354;139.197;101.12;100.93;100.46 2000-10-16;93.74;5316.58;138.871;101.27;101.19;100.9 2000-10-17;93.74;5339.68;139.184;101.1;100.88;100.38 2000-10-18;93.81;5335.09;138.577;100.9;100.56;99.87 2000-10-19;93.71;5422.95;138.084;101.49;101.54;101.39 2000-10-20;93.7;5404.64;138.845;101.6;101.74;101.72 2000-10-23;93.65;5433.57;138.667;101.73;101.92;101.99 2000-10-24;93.66;5503.16;138.38;102.02;102.36;102.62 2000-10-25;93.65;5479.88;138.824;101.8;102.01;102.09 2000-10-26;93.6;5492.22;138.188;101.96;102.22;102.36 2000-10-27;93.6;5509.27;138.313;102.11;102.43;102.64 2000-10-30;93.54;5554.52;138.288;102.2;102.6;102.9 2000-10-31;93.55;5572.9;138.732;102.5;103.05;103.58 2000-11-01;93.61;5575.75;138.049;102.43;102.92;103.35 2000-11-02;93.64;5644.84;137.754;102.62;103.19;103.73 2000-11-03;93.63;5631.9;137.439;102.5;103.03;103.5 2000-11-06;93.64;5676.82;137.39;102.66;103.27;103.84 2000-11-07;93.65;5673.29;137.926;102.69;103.3;103.89 2000-11-08;93.7;5658.69;138.369;102.61;103.13;103.58 2000-11-09;93.74;5604.36;137.636;102.37;102.72;102.94 2000-11-10;93.82;5609.89;137.601;102.1;102.21;102.08 2000-11-13;93.91;5565.27;137.295;101.92;101.84;101.44 2000-11-14;93.99;5642.47;137.517;102.5;102.7;102.7 2000-11-15;93.97;5639.04;137.403;102.66;102.95;103.07 2000-11-16;93.98;5656.32;137.657;102.59;102.81;102.81 2000-11-17;93.93;5657.66;137.267;102.55;102.76;102.74 2000-11-20;93.93;5657.99;137.266;102.4;102.47;102.25 2000-11-21;93.86;5669.53;137.508;102.36;102.45;102.27 2000-11-22;93.84;5581.55;137.299;101.96;101.8;101.27 2000-11-23;93.78;5596.16;137.549;102.04;101.94;101.49 2000-11-24;93.75;5614.67;137.492;102.22;102.27;102.03 2000-11-27;93.75;5656.8;138.119;102.17;102.21;101.94 2000-11-28;93.81;5613.82;137.895;101.91;101.74;101.17 2000-11-29;93.94;5597.2;138.685;101.85;101.59;100.89 2000-11-30;94.11;5533.21;138.695;101.49;100.89;99.72 2000-12-01;94.12;5578.25;139.158;101.66;101.14;100.08 2000-12-04;94.18;5550.89;138.475;101.43;100.74;99.44 2000-12-05;94.19;5643.81;138.726;102.12;101.82;101.05 2000-12-06;94.31;5604.16;138.459;102.02;101.58;100.61 2000-12-07;94.38;5550.57;138.568;101.84;101.24;100.08 2000-12-08;94.42;5538.44;138.741;102;101.5;100.49 2000-12-11;94.43;5565.46;139.043;102.35;102.06;101.35 2000-12-12;94.44;5549.24;138.915;102.23;101.88;101.08 2000-12-13;94.6;5563.85;139.234;102.33;101.91;101.01 2000-12-14;94.77;5495.63;139.591;101.99;101.27;99.95 2000-12-15;94.89;5449.22;139.741;101.56;100.5;98.72 2000-12-18;95.04;5511.11;140.108;101.81;100.85;99.18 2000-12-19;95.07;5563.39;139.736;101.99;101.06;99.43 2000-12-20;95.22;5508.82;139.793;101.5;100.13;97.87 2000-12-21;95.28;5468.73;140.336;101.47;100.02;97.65 2000-12-22;95.18;5501.27;140.631;101.48;100.11;97.86 2000-12-25;95.18;5501.27;140.631;101.53;100.19;97.98 2000-12-26;95.18;5501.27;140.631;101.41;100.03;97.76 2000-12-27;95.18;5573.72;140.171;101.8;100.58;98.53 2000-12-28;95.16;5627.97;140.506;101.99;100.9;99.01 2000-12-29;95.26;5621.13;140.3;101.79;100.52;98.37 2001-01-01;95.26;5621.13;140.3;102.08;100.81;98.65 2001-01-02;95.26;5621.13;140.3;101.48;99.99;97.51 2001-01-03;95.81;5601.77;140.686;102.07;100.66;98.32 2001-01-04;95.9;5603.67;142.229;102.19;100.78;98.45 2001-01-05;96.01;5521.97;142.979;101.98;100.35;97.75 2001-01-08;96.06;5515.63;143.352;102.01;100.34;97.68 2001-01-09;95.85;5498.51;144.17;101.89;100.27;97.69 2001-01-10;95.82;5441.81;144.257;101.8;100.17;97.58 2001-01-11;95.97;5449.7;144.308;102;100.38;97.81 2001-01-12;95.82;5441.12;145.192;102;100.44;97.95 2001-01-15;95.76;5449.11;145.312;102.12;100.64;98.27 2001-01-16;95.75;5451.59;146.825;102.13;100.66;98.31 2001-01-17;95.6;5518.18;146.705;102.45;101.23;99.2 2001-01-18;95.63;5497.86;146.941;102.18;100.85;98.67 2001-01-19;95.66;5454.57;146.767;102.3;101;98.89 2001-01-22;95.56;5460.57;146.614;102.36;101.1;99.05 2001-01-23;95.55;5459.08;146.812;102.37;101.14;99.12 2001-01-24;95.46;5494.03;147.179;102.62;101.59;99.83 2001-01-25;95.45;5521.47;147.034;102.61;101.57;99.81 2001-01-26;95.52;5556.39;146.691;102.72;101.69;99.92 2001-01-29;95.52;5552.43;146.718;102.73;101.73;99.99 2001-01-30;95.52;5555.57;146.914;102.75;101.75;100.02 2001-01-31;95.65;5564.09;146.682;102.93;101.91;100.14 2001-02-01;95.77;5514.2;147.454;102.87;101.73;99.83 2001-02-02;95.78;5532.75;147.26;102.91;101.73;99.77 2001-02-05;95.87;5560.94;146.731;102.94;101.72;99.67 2001-02-06;95.88;5573.41;147.624;103.14;102;100.07 2001-02-07;95.92;5550.43;146.987;102.93;101.65;99.54 2001-02-08;95.79;5500.61;147.211;102.83;101.57;99.5 2001-02-09;95.8;5484.39;147.452;102.53;101.1;98.79 2001-02-12;95.85;5469.39;146.664;102.69;101.29;99.03 2001-02-13;95.85;5478.01;146.568;102.79;101.42;99.21 2001-02-14;95.79;5418.7;146.095;102.55;101.09;98.77 2001-02-15;95.67;5451.38;146.366;102.85;101.63;99.65 2001-02-16;95.64;5378.92;145.933;102.4;100.9;98.52 2001-02-19;95.65;5382.7;146.135;102.31;100.74;98.26 2001-02-20;95.56;5348.08;146.03;102.16;100.54;98 2001-02-21;95.53;5303.6;145.933;101.74;99.9;97.07 2001-02-22;95.42;5306.62;145.533;101.71;99.89;97.08 2001-02-23;95.41;5269.82;145.524;101.58;99.66;96.74 2001-02-26;95.44;5307.33;145.113;101.92;100.14;97.41 2001-02-27;95.54;5316.48;144.645;101.91;100.04;97.17 2001-02-28;95.67;5320.82;144.807;101.89;99.92;96.9 2001-03-01;95.76;5219.54;144.367;101.53;99.32;96.01 2001-03-02;95.8;5200.62;143.714;101.27;98.93;95.44 2001-03-05;95.79;5227.55;143.981;101.49;99.27;95.93 2001-03-06;95.76;5254.32;143.981;101.72;99.62;96.46 2001-03-07;95.85;5254.34;142.808;101.91;99.86;96.77 2001-03-08;95.95;5230.57;143.078;101.92;99.82;96.66 2001-03-09;95.93;5205.61;142.853;101.67;99.39;96 2001-03-12;95.93;5116.27;143.005;100.95;98.26;94.32 2001-03-13;95.94;5101.77;143.258;101.16;98.55;94.73 2001-03-14;96.01;4998.09;142.604;100.77;97.91;93.77 2001-03-15;96.03;5024.83;142.824;101.06;98.33;94.38 2001-03-16;96.16;4917.09;143.081;100.78;97.81;93.55 2001-03-19;96.14;4867.8;142.704;100.72;97.75;93.52 2001-03-20;96.05;4889.7;142.606;100.54;97.5;93.16 2001-03-21;96.15;4815.02;142.987;100.4;97.21;92.71 2001-03-22;96.37;4565.45;142.523;99.94;96.4;91.51 2001-03-23;96.46;4666.13;142.826;100.36;97.03;92.38 2001-03-26;96.47;4829.85;142.263;101.04;98.04;93.81 2001-03-27;96.56;4850.35;142.299;101.33;98.49;94.48 2001-03-28;96.43;4829.04;142.23;101.09;98.16;94.02 2001-03-29;96.39;4869.65;142.648;101.05;98.1;93.93 2001-03-30;96.37;4952.28;142.755;101.23;98.39;94.32 2001-04-02;96.51;4867.53;142.582;101.03;98.02;93.74 2001-04-03;96.53;4761.82;142.438;100.37;96.98;92.24 2001-04-04;96.5;4727.87;142.72;100.05;96.53;91.63 2001-04-05;96.35;4829.64;142.514;100.73;97.66;93.32 2001-04-06;96.32;4817.94;142.914;100.57;97.38;92.9 2001-04-09;96.35;4885.97;142.869;100.78;97.67;93.26 2001-04-10;96.31;4950.8;143.247;101.25;98.46;94.46 2001-04-11;96.06;5002.75;143.107;101.21;98.54;94.69 2001-04-12;95.88;5007.11;142.97;101.1;98.5;94.73 2001-04-13;95.88;5007.11;142.97;101.1;98.49;94.71 2001-04-16;95.88;5007.11;142.97;101.2;98.64;94.93 2001-04-17;95.76;5007.6;143.21;101.32;98.83;95.23 2001-04-18;95.51;5071.74;142.542;102.11;100.15;97.24 2001-04-19;95.62;5046.85;142.828;102.02;99.98;96.97 2001-04-20;95.54;5011.22;142.719;101.58;99.34;96.07 2001-04-23;95.62;4966.92;142.509;101.46;99.1;95.68 2001-04-24;95.53;5022.58;142.503;101.51;99.18;95.77 2001-04-25;95.54;4983.58;143.42;101.56;99.25;95.9 2001-04-26;95.54;4981.73;143.67;101.69;99.42;96.13 2001-04-27;95.52;5009.7;143.994;102.04;100;97 2001-04-30;95.37;5064.11;144.25;102.23;100.34;97.54 2001-05-01;95.37;5064.11;144.25;102.44;100.64;97.97 2001-05-02;95.41;5098.16;145.49;102.61;100.86;98.23 2001-05-03;95.6;5056.15;145.816;102.44;100.48;97.57 2001-05-04;95.72;5093.64;145.609;102.8;100.94;98.17 2001-05-07;95.74;5160;145.911;103;101.23;98.54 2001-05-08;95.77;5147.83;145.172;103.01;101.21;98.51 2001-05-09;95.82;5110.6;145.644;102.9;101.01;98.19 2001-05-10;95.88;5181.75;145.409;103.15;101.35;98.63 2001-05-11;95.84;5201.94;146.025;103.07;101.27;98.54 2001-05-14;95.64;5170.86;146.208;102.77;100.91;98.1 2001-05-15;95.62;5215.25;146.016;102.86;101.04;98.27 2001-05-16;95.68;5224.6;145.413;103.02;101.28;98.63 2001-05-17;95.64;5272.37;145.447;103.33;101.76;99.33 2001-05-18;95.63;5283.52;145.623;103.42;101.92;99.57 2001-05-21;95.48;5294.5;145.948;103.54;102.19;100.04 2001-05-22;95.41;5315.83;145.493;103.69;102.43;100.42 2001-05-23;95.34;5317.2;145.545;103.57;102.28;100.2 2001-05-24;95.34;5317.2;145.545;103.61;102.34;100.3 2001-05-25;95.29;5296.73;145.89;103.43;102.07;99.9 2001-05-28;95.32;5289.08;145.684;103.39;102;99.8 2001-05-29;95.36;5258.14;145.81;103.41;101.96;99.69 2001-05-30;95.39;5222.72;146.073;103.06;101.39;98.83 2001-05-31;95.32;5183.45;145.723;103.09;101.49;99.04 2001-06-01;95.46;5206.79;145.648;103.34;101.76;99.34 2001-06-04;95.46;5206.79;145.648;103.36;101.81;99.41 2001-06-05;95.58;5247.32;145.946;103.59;102.09;99.77 2001-06-06;95.6;5246.05;146.039;103.63;102.11;99.75 2001-06-07;95.6;5251.39;145.77;103.66;102.15;99.81 2001-06-08;95.62;5227.55;146.105;103.6;102.03;99.62 2001-06-11;95.7;5196.28;145.95;103.51;101.84;99.29 2001-06-12;95.74;5133.83;146.411;103.21;101.35;98.57 2001-06-13;95.76;5179.67;145.603;103.32;101.48;98.71 2001-06-14;95.67;5114.35;145.496;102.85;100.79;97.72 2001-06-15;95.8;5084.82;145.293;102.7;100.49;97.22 2001-06-18;95.85;5071.58;145.481;102.69;100.41;97.05 2001-06-19;95.84;5039.58;145.369;102.74;100.47;97.14 2001-06-20;95.94;4996.01;144.69;102.78;100.5;97.2 2001-06-21;95.97;4997.49;144.765;102.82;100.58;97.33 2001-06-22;95.99;4957.15;143.278;102.68;100.35;96.99 2001-06-25;96.06;4961.49;143.173;102.62;100.2;96.69 2001-06-26;96.07;4898.93;142.908;102.41;99.89;96.26 2001-06-27;96.06;4852.99;142.79;102.26;99.66;95.96 2001-06-28;96;4950.23;143.61;102.71;100.39;97.03 2001-06-29;95.8;5006.54;144.399;102.8;100.63;97.47 2001-07-02;95.8;5048.65;143.854;103.08;101.04;98.03 2001-07-03;95.78;5003.83;143.6;102.9;100.77;97.66 2001-07-04;95.69;4964.46;143.528;102.7;100.51;97.34 2001-07-05;95.69;4924.6;144.042;102.64;100.38;97.14 2001-07-06;95.72;4837.37;143.315;101.99;99.36;95.64 2001-07-09;95.72;4839.4;142.977;102.01;99.4;95.68 2001-07-10;95.72;4783.56;143.271;101.72;98.92;94.97 2001-07-11;95.83;4726.98;143.795;101.42;98.41;94.19 2001-07-12;95.79;4799.65;143.411;101.85;99.13;95.28 2001-07-13;95.82;4804.87;143.511;101.93;99.25;95.45 2001-07-16;95.82;4800.84;143.381;101.81;99.02;95.08 2001-07-17;95.71;4775.05;143.477;101.8;99.05;95.18 2001-07-18;95.65;4750.25;143.65;101.16;98.12;93.85 2001-07-19;95.68;4833.85;144.325;101.52;98.64;94.55 2001-07-20;95.71;4793.13;143.845;101.34;98.34;94.1 2001-07-23;95.72;4790.88;144.771;101.34;98.28;93.96 2001-07-24;95.76;4691.64;144.956;100.92;97.61;92.97 2001-07-25;95.77;4628.45;145.146;100.79;97.42;92.74 2001-07-26;95.75;4635.32;145.378;101.02;97.77;93.25 2001-07-27;95.87;4681.22;145.639;101.33;98.17;93.77 2001-07-30;95.94;4713.57;146.006;101.49;98.35;93.96 2001-07-31;96.02;4732.71;145.558;101.73;98.68;94.41 2001-08-01;96.02;4775.11;145.302;101.77;98.76;94.53 2001-08-02;96.01;4792.86;145.763;101.86;98.9;94.73 2001-08-03;96.01;4755.23;146.316;101.59;98.5;94.16 2001-08-06;96.09;4765.61;145.848;101.68;98.55;94.17 2001-08-07;96.1;4761.26;145.913;101.75;98.67;94.34 2001-08-08;96.09;4749.08;145.978;101.53;98.31;93.81 2001-08-09;96.28;4654.38;146.069;101.19;97.69;92.83 2001-08-10;96.37;4594.87;146.498;101.19;97.6;92.67 2001-08-13;96.42;4645.73;146.89;101.34;97.79;92.87 2001-08-14;96.37;4712.31;147.063;101.58;98.15;93.39 2001-08-15;96.41;4686.85;146.913;101.31;97.73;92.76 2001-08-16;96.41;4644.94;146.804;101.17;97.5;92.44 2001-08-17;96.43;4610.48;146.815;100.87;97.01;91.69 2001-08-20;96.47;4585.22;146.829;100.92;97.06;91.75 2001-08-21;96.49;4644;147.101;101.01;97.19;91.9 2001-08-22;96.42;4599.42;147.144;100.87;97;91.68 2001-08-23;96.39;4574.22;147.234;100.84;96.98;91.67 2001-08-24;96.31;4633.32;147.406;101.15;97.49;92.44 2001-08-27;96.24;4663.23;147.24;101.25;97.64;92.64 2001-08-28;96.25;4599.5;146.849;100.93;97.13;91.91 2001-08-29;96.27;4545.41;146.429;100.75;96.82;91.45 2001-08-30;96.28;4511.31;146.364;100.47;96.36;90.74 2001-08-31;96.4;4540.71;146.868;100.64;96.55;90.95 2001-09-03;96.46;4458.2;146.179;100.46;96.24;90.5 2001-09-04;96.39;4519.44;146.29;100.81;96.83;91.39 2001-09-05;96.21;4482.96;146.391;100.49;96.44;90.92 2001-09-06;96.24;4410.85;146.585;100.06;95.75;89.9 2001-09-07;96.39;4323.05;146.377;99.6;94.94;88.68 2001-09-10;96.45;4238.06;146.224;99.48;94.74;88.4 2001-09-11;96.41;3955.34;146.271;98.18;92.89;85.95 2001-09-12;96.59;4042.86;146.061;98.47;93.21;86.27 2001-09-13;96.55;4080.07;145.862;98.54;93.33;86.44 2001-09-14;96.68;3903.15;145.788;97.84;92.21;84.85 2001-09-17;96.75;4004.5;145.735;97.56;91.76;84.11 2001-09-18;96.83;3956.96;145.634;97.32;91.38;83.57 2001-09-19;96.76;3908.69;145.604;96.9;90.78;82.76 2001-09-20;96.77;3735.14;145.118;96.08;89.55;81.05 2001-09-21;96.73;3546.6;145.289;94.95;87.99;79 2001-09-24;96.71;3754.35;144.826;96.22;89.82;81.49 2001-09-25;96.75;3858.78;145.009;96.51;90.23;82.02 2001-09-26;96.67;3920.27;145.094;96.91;90.78;82.73 2001-09-27;96.72;3968.87;145.076;97.23;91.23;83.33 2001-09-28;96.76;4085.51;144.895;97.81;92.11;84.58 2001-10-01;96.76;4032.03;145.123;97.76;91.98;84.35 2001-10-02;96.87;4021.86;145.389;97.98;92.26;84.73 2001-10-03;97.05;3985.58;144.838;98.05;92.3;84.76 2001-10-04;97.27;4086.64;144.594;98.69;93.18;85.9 2001-10-05;97.43;4049.18;144.815;98.57;92.97;85.59 2001-10-08;97.56;4047.75;145.232;98.52;92.81;85.29 2001-10-09;97.49;4037.5;144.336;98.41;92.68;85.14 2001-10-10;97.44;4064.84;144.693;98.86;93.38;86.14 2001-10-11;97.35;4151.23;144.531;99.37;94.2;87.32 2001-10-12;97.34;4110.68;145.262;99.2;93.93;86.94 2001-10-15;97.41;4082.97;145.181;98.97;93.56;86.41 2001-10-16;97.47;4082.64;144.768;99.17;93.81;86.72 2001-10-17;97.47;4106.45;145.008;99.24;93.91;86.83 2001-10-18;97.52;4144.81;144.557;99.2;93.79;86.61 2001-10-19;97.64;4129.11;144.806;99.26;93.81;86.59 2001-10-22;97.68;4197.46;144.745;99.84;94.6;87.62 2001-10-23;97.66;4263.71;144.515;100.21;95.13;88.32 2001-10-24;97.73;4267.62;144.54;100.28;95.2;88.37 2001-10-25;97.85;4213.24;144.423;100.14;94.94;88 2001-10-26;97.94;4253.84;145.021;100.42;95.33;88.52 2001-10-29;98.11;4176.38;144.931;99.89;94.41;87.13 2001-10-30;98.3;4089.15;144.417;99.38;93.56;85.9 2001-10-31;98.34;4137.99;144.925;99.73;94.03;86.5 2001-11-01;98.61;4149.82;145.115;100.1;94.47;87.03 2001-11-02;98.59;4163.7;145.097;100.15;94.59;87.23 2001-11-05;98.62;4226.83;145.225;100.74;95.41;88.3 2001-11-06;98.64;4234.34;145.155;100.94;95.69;88.68 2001-11-07;98.76;4244.37;144.95;100.97;95.65;88.57 2001-11-08;98.65;4339.98;144.989;101.32;96.24;89.4 2001-11-09;98.49;4307.15;145.165;101.04;95.93;89.07 2001-11-12;98.26;4236.68;145.352;100.57;95.3;88.27 2001-11-13;98.03;4336.97;145.71;101.28;96.44;89.9 2001-11-14;97.75;4363.2;146.099;100.06;95.63;89.57 2001-11-15;97.37;4447.49;145.05;101.13;96.6;90.4 2001-11-16;97.17;4464.2;145.362;100.91;96.38;90.18 2001-11-19;97.15;4496.3;145.811;101.17;96.81;90.81 2001-11-20;97.33;4417.91;145.815;100.74;96.16;89.9 2001-11-21;97.18;4424.67;146.478;100.76;96.19;89.95 2001-11-22;97.12;4451.8;146.789;100.79;96.28;90.11 2001-11-23;97.2;4399;146.136;100.95;96.48;90.38 2001-11-26;97.23;4406.64;146.971;101.1;96.65;90.59 2001-11-27;96.9;4367.96;147.086;100.63;96.09;89.91 2001-11-28;96.95;4289.9;147.004;100.05;95.25;88.77 2001-11-29;96.94;4296.56;147.109;100.39;95.68;89.31 2001-11-30;97;4260.27;146.992;100.37;95.59;89.18 2001-12-03;97.09;4259.32;147.039;100.41;95.56;89.05 2001-12-04;97.09;4346.82;147.063;100.76;96.1;89.79 2001-12-05;96.77;4409.71;146.96;101.18;96.86;90.96 2001-12-06;96.25;4407.06;146.696;100.85;96.59;90.78 2001-12-07;96.1;4398.69;146.285;100.56;96.28;90.44 2001-12-10;96.04;4340.72;146.126;100.23;95.8;89.76 2001-12-11;96.16;4324.06;145.908;100.16;95.65;89.53 2001-12-12;96.36;4315.98;145.565;100.17;95.57;89.33 2001-12-13;96.51;4273.2;145.472;99.86;95;88.45 2001-12-14;96.46;4228.23;145.334;99.65;94.7;88.05 2001-12-17;96.2;4302.98;144.995;99.83;95.07;88.64 2001-12-18;96.11;4282.94;144.999;99.84;95.13;88.77 2001-12-19;96.1;4231.51;145.546;99.76;95.03;88.68 2001-12-20;95.98;4296.84;145.515;99.65;94.92;88.53 2001-12-21;95.89;4340.79;145.302;99.92;95.36;89.16 2001-12-24;95.89;4340.79;145.302;100.42;96.03;90.05 2001-12-25;95.89;4340.79;145.302;100.42;96.02;90.04 2001-12-26;95.89;4340.79;145.302;100.46;96.08;90.13 2001-12-27;95.73;4374.9;145.675;100.51;96.21;90.35 2001-12-28;95.72;4382.94;145.394;100.53;96.33;90.58 2001-12-31;95.72;4382.94;145.394;100.26;95.92;89.99 2002-01-01;95.72;4382.94;145.394;100.03;95.7;89.79 2002-01-02;95.72;4351.45;145.009;100.08;95.64;89.59 2002-01-03;95.87;4359.12;145.195;100.45;96.13;90.23 2002-01-04;95.95;4372.28;145.884;100.6;96.35;90.55 2002-01-07;96.13;4368.06;146.035;100.66;96.32;90.4 2002-01-08;96.4;4321.85;145.803;100.67;96.19;90.12 2002-01-09;96.37;4354.48;145.281;100.79;96.33;90.26 2002-01-10;96.52;4355.44;145.698;100.86;96.34;90.21 2002-01-11;96.55;4389.29;145.52;100.89;96.36;90.18 2002-01-14;96.66;4311.61;145.916;100.68;95.93;89.51 2002-01-15;96.48;4305.72;146.302;100.7;96.02;89.69 2002-01-16;96.52;4269.13;146.591;100.37;95.55;89.05 2002-01-17;96.4;4319.58;146.932;100.55;95.89;89.57 2002-01-18;96.3;4303.57;146.718;100.37;95.64;89.24 2002-01-21;96.25;4263.81;146.285;100.21;95.42;88.97 2002-01-22;96.03;4284.46;146.482;100.07;95.28;88.8 2002-01-23;95.93;4313.52;146.687;100.19;95.5;89.15 2002-01-24;95.81;4364.93;146.603;100.38;95.85;89.69 2002-01-25;95.65;4351.95;146.616;100.45;96.04;90.05 2002-01-28;95.39;4378.1;146.592;100.55;96.26;90.41 2002-01-29;95.39;4319.18;146.921;100.04;95.51;89.36 2002-01-30;95.46;4246.22;146.647;99.97;95.36;89.14 2002-01-31;95.42;4265.15;146.883;100.25;95.79;89.76 2002-02-01;95.55;4261.93;147.537;100.34;95.85;89.78 2002-02-04;95.82;4237.35;147.317;100.11;95.36;88.96 2002-02-05;95.99;4194.14;147.245;99.86;94.89;88.24 2002-02-06;95.95;4175.97;147.171;99.75;94.7;87.94 2002-02-07;95.67;4251.3;147.075;99.77;94.84;88.2 2002-02-08;95.57;4262.79;147.233;99.84;95.02;88.51 2002-02-11;95.53;4286.25;147.328;100.04;95.32;88.94 2002-02-12;95.59;4270.03;146.859;100.01;95.27;88.87 2002-02-13;95.44;4322.32;147.415;100.39;95.84;89.67 2002-02-14;95.47;4377.77;146.748;100.63;96.2;90.15 2002-02-15;95.57;4374.97;147.005;100.5;95.95;89.74 2002-02-18;95.63;4350.83;146.804;100.5;95.9;89.66 2002-02-19;95.74;4256.29;146.959;99.95;95.04;88.43 2002-02-20;95.71;4232.31;147.013;100.05;95.17;88.61 2002-02-21;95.64;4253.44;147.127;99.99;95.11;88.54 2002-02-22;95.79;4224.52;146.946;99.95;95;88.36 2002-02-25;95.74;4255.18;146.914;100.31;95.52;89.07 2002-02-26;95.68;4240.05;147.024;100.26;95.49;89.07 2002-02-27;95.58;4310.91;147.02;100.61;96.03;89.83 2002-02-28;95.59;4332.86;147.318;100.58;95.99;89.77 2002-03-01;95.51;4332.68;147.153;100.85;96.44;90.45 2002-03-04;95.38;4393.54;147.172;101.27;97.13;91.47 2002-03-05;95.23;4376.22;147.409;101.02;96.83;91.12 2002-03-06;95.21;4380.48;147.741;101.05;96.91;91.27 2002-03-07;95.15;4399.7;147.464;100.88;96.73;91.04 2002-03-08;95.02;4460.83;147.836;101.13;97.13;91.63 2002-03-11;95.03;4438.62;147.987;101.09;97.08;91.58 2002-03-12;95.18;4410.21;148.131;100.97;96.87;91.25 2002-03-13;95.13;4437.94;147.845;100.89;96.72;91.01 2002-03-14;95.1;4468.83;147.833;100.74;96.53;90.74 2002-03-15;95.1;4485.27;148.03;100.93;96.81;91.14 2002-03-18;95.16;4518.81;148.504;101.08;97;91.37 2002-03-19;95.14;4524.13;147.97;101.19;97.17;91.6 2002-03-20;95.18;4513.65;148.023;100.94;96.77;91.01 2002-03-21;95.04;4506.75;148.684;100.86;96.7;90.96 2002-03-22;94.95;4519.69;149.176;100.76;96.61;90.89 2002-03-25;94.88;4515.98;149.045;100.58;96.36;90.52 2002-03-26;94.95;4537.96;149.208;100.82;96.66;90.9 2002-03-27;95.16;4545.63;149.477;101.12;97.01;91.32 2002-03-28;95.32;4561.61;149.59;101.39;97.34;91.71 2002-03-29;95.32;4561.61;149.59;101.35;97.28;91.64 2002-04-01;95.32;4561.61;149.59;101.01;96.85;91.09 2002-04-02;95.3;4573.11;149.689;101.11;96.89;91.05 2002-04-03;95.5;4591.52;150.872;101.22;96.96;91.05 2002-04-04;95.7;4575.79;150.973;101.28;96.94;90.92 2002-04-05;95.76;4572.06;150.653;101.46;97.12;91.11 2002-04-08;95.72;4521.36;150.816;101.35;96.95;90.88 2002-04-09;95.61;4556.94;150.699;101.33;96.93;90.85 2002-04-10;95.67;4580.77;150.928;101.52;97.22;91.26 2002-04-11;95.65;4527.6;150.331;101.04;96.47;90.18 2002-04-12;95.8;4522.59;150.481;101.22;96.69;90.46 2002-04-15;95.94;4536.31;150.125;101.4;96.84;90.57 2002-04-16;95.76;4578.03;150.809;101.7;97.36;91.36 2002-04-17;95.65;4601.89;150.261;101.69;97.38;91.4 2002-04-18;95.71;4599.26;150.023;101.56;97.19;91.13 2002-04-19;95.74;4597.1;150.35;101.61;97.25;91.21 2002-04-22;95.9;4600.12;149.326;101.61;97.14;90.96 2002-04-23;95.93;4594.98;149.941;101.56;97.02;90.75 2002-04-24;95.91;4598.15;149.844;101.44;96.84;90.48 2002-04-25;96.22;4541.01;150.944;101.27;96.5;89.95 2002-04-26;96.19;4503.45;150.371;101.13;96.21;89.48 2002-04-29;96.18;4525.27;150.134;101.01;96.03;89.2 2002-04-30;96.15;4519.16;149.755;100.99;96.06;89.29 2002-05-01;96.15;4519.16;149.755;100.87;95.92;89.13 2002-05-02;96.49;4515.65;149.32;101.02;96.02;89.17 2002-05-03;96.58;4544.63;149.476;100.98;95.85;88.83 2002-05-06;96.67;4529.34;149.535;100.83;95.56;88.35 2002-05-07;96.82;4466.67;149.748;100.76;95.38;88.08 2002-05-08;96.72;4540.36;149.154;101.31;96.26;89.34 2002-05-09;96.72;4542.65;148.824;101.16;96.03;89.01 2002-05-10;96.66;4508.76;149.078;100.8;95.5;88.28 2002-05-13;96.66;4508.76;149.078;101.05;95.89;88.84 2002-05-14;96.54;4566.84;149.501;101.48;96.58;89.85 2002-05-15;96.53;4599.06;149.646;101.45;96.56;89.83 2002-05-16;96.53;4599.06;149.646;101.54;96.69;89.99 2002-05-17;96.53;4599.06;149.646;101.37;96.44;89.66 2002-05-20;96.53;4599.06;149.646;101.21;96.17;89.26 2002-05-21;96.62;4575.14;151.477;101.23;96.15;89.18 2002-05-22;96.79;4553.35;150.921;101.17;95.99;88.9 2002-05-23;96.77;4536.18;150.642;101.41;96.29;89.29 2002-05-24;96.7;4543.34;150.894;101.36;96.21;89.18 2002-05-27;96.47;4565.67;150.711;101.35;96.28;89.32 2002-05-28;96.35;4550.01;151.444;101.01;95.85;88.78 2002-05-29;96.44;4559.23;151.706;101.06;95.86;88.74 2002-05-30;96.47;4523.85;152.098;100.84;95.5;88.21 2002-05-31;96.5;4546.05;152.138;100.94;95.64;88.4 2002-06-03;96.49;4529.68;153.373;100.76;95.31;87.88 2002-06-04;96.58;4442.31;153.995;100.42;94.79;87.16 2002-06-05;96.58;4436.43;153.952;100.66;95.09;87.53 2002-06-06;96.52;4411.94;154.056;100.34;94.6;86.85 2002-06-07;96.59;4335.71;154.758;99.97;94.08;86.16 2002-06-10;96.59;4347.46;154.19;100.13;94.27;86.4 2002-06-11;96.57;4389.8;154.769;100.25;94.4;86.51 2002-06-12;96.62;4264.96;155.037;99.96;93.93;85.88 2002-06-13;96.7;4205.63;155.175;99.74;93.57;85.35 2002-06-14;96.9;4153.43;154.984;99.52;93.16;84.73 2002-06-17;96.86;4269.49;154.712;100.26;94.22;86.14 2002-06-18;96.93;4213.68;154.57;100.09;93.96;85.81 2002-06-19;97.01;4148.48;154.566;99.58;93.18;84.69 2002-06-20;97.07;4023.65;153.639;98.96;92.26;83.43 2002-06-21;97.06;4030.79;153.888;98.79;91.97;83 2002-06-24;97.17;3902.35;153.508;98.4;91.36;82.16 2002-06-25;97.14;4023.73;154.426;98.74;91.81;82.7 2002-06-26;97.35;3919.18;154.688;98.16;90.93;81.49 2002-06-27;97.14;3979.29;154.621;98.64;91.64;82.46 2002-06-28;97.17;4146.93;153.961;99.05;92.28;83.31 2002-07-01;97.19;4146.72;154.384;98.92;92.04;82.95 2002-07-02;97.28;4063.18;154.324;98.43;91.28;81.9 2002-07-03;97.39;3963.86;154.125;98.22;90.96;81.47 2002-07-04;97.35;4053.61;154.262;98.55;91.43;82.08 2002-07-05;97.25;4169.92;154.91;99.36;92.65;83.77 2002-07-08;97.25;4170.08;155.107;99.15;92.32;83.29 2002-07-09;97.27;4147.14;154.728;98.88;91.89;82.65 2002-07-10;97.45;4023.31;155.312;98.39;91.06;81.47 2002-07-11;97.65;3867.54;154.808;97.91;90.3;80.44 2002-07-12;97.69;3911.01;154.831;98.08;90.49;80.64 2002-07-15;97.85;3746.08;155.252;97.33;89.33;79.05 2002-07-16;97.96;3658.2;154.979;96.92;88.7;78.19 2002-07-17;97.79;3706.01;154.518;97.15;89.07;78.72 2002-07-18;97.79;3689.69;154.549;96.97;88.81;78.37 2002-07-19;98.04;3498.09;154.921;96.04;87.38;76.4 2002-07-22;98.26;3314.62;154.944;95.3;86.19;74.75 2002-07-23;98.3;3262.26;154.814;95.14;85.88;74.28 2002-07-24;98.63;3234.84;154.615;95.33;86.12;74.6 2002-07-25;98.49;3427.53;154.146;95.83;86.81;75.43 2002-07-26;98.52;3503.19;154.193;96.26;87.42;76.22 2002-07-29;98.33;3664.06;154.577;97.37;89.12;78.58 2002-07-30;98.04;3632.58;154.431;97.15;88.88;78.32 2002-07-31;98.11;3623.48;154.977;97.24;89.03;78.57 2002-08-01;98.11;3559.72;154.499;96.59;88.08;77.27 2002-08-02;98.49;3522.24;155.064;96.52;87.82;76.81 2002-08-05;98.71;3395.24;155.324;95.96;86.87;75.47 2002-08-06;98.58;3569.3;155.382;97.07;88.45;77.53 2002-08-07;98.55;3523.49;155.333;97.07;88.49;77.63 2002-08-08;98.46;3646.47;155.836;97.83;89.63;79.16 2002-08-09;98.42;3689.19;155.319;98.01;89.88;79.48 2002-08-12;98.53;3636.94;155.427;97.75;89.46;78.89 2002-08-13;98.64;3687.37;155.238;97.86;89.53;78.89 2002-08-14;98.74;3662.5;155.761;97.96;89.65;79.05 2002-08-15;98.46;3766.81;155.627;98.5;90.49;80.19 2002-08-16;98.42;3754.47;156.007;98.37;90.38;80.1 2002-08-19;98.34;3842.09;156.176;99;91.29;81.29 2002-08-20;98.44;3742.47;156.294;98.67;90.77;80.61 2002-08-21;98.28;3811.47;156.154;98.86;91.09;81.04 2002-08-22;98.1;3833.42;156.4;99.22;91.66;81.85 2002-08-23;97.99;3824.2;156.221;98.98;91.29;81.33 2002-08-26;98.01;3782.08;156.834;98.89;91.19;81.24 2002-08-27;98.03;3823.61;156.432;98.79;91.05;81.02 2002-08-28;98.27;3678.62;155.902;98.27;90.17;79.81 2002-08-29;98.51;3586.7;155.553;97.99;89.68;79.11 2002-08-30;98.56;3652.39;155.39;98.38;90.15;79.64 2002-09-02;98.67;3562.88;155.517;98.12;89.71;79.03 2002-09-03;98.88;3446.33;155.531;97.15;88.22;76.99 2002-09-04;99.03;3470.97;155.517;97.38;88.51;77.35 2002-09-05;99.31;3465.93;155.572;97.33;88.34;77.04 2002-09-06;99.28;3559.01;154.934;97.88;89.12;78.05 2002-09-09;99.22;3511.75;155.457;97.82;89.06;77.99 2002-09-10;99.16;3571.13;155.025;98.23;89.69;78.86 2002-09-11;99.11;3652.78;154.841;98.62;90.24;79.56 2002-09-12;99.35;3542.09;155.386;98.09;89.38;78.36 2002-09-13;99.67;3460.38;154.762;97.89;88.97;77.76 2002-09-16;99.89;3460.31;154.84;98.2;89.28;78.07 2002-09-17;99.87;3429.34;154.948;98.14;89.12;77.82 2002-09-18;100.12;3363.21;154.713;97.66;88.38;76.79 2002-09-19;100.18;3305.07;154.922;97.19;87.65;75.79 2002-09-20;100.15;3309.07;154.805;97.12;87.55;75.66 2002-09-23;100.21;3193.19;154.165;96.62;86.8;74.66 2002-09-24;100.29;3190.1;154.376;96.47;86.53;74.26 2002-09-25;100.1;3243.34;154.071;96.82;87.08;75.01 2002-09-26;100.03;3406.91;154.486;97.6;88.23;76.52 2002-09-27;100.08;3415.4;154.312;97.41;87.94;76.11 2002-09-30;100.34;3336.21;154.613;96.7;86.86;74.62 2002-10-01;100.3;3292.04;154.755;97.08;87.38;75.32 2002-10-02;100.17;3372.69;154.93;97.17;87.52;75.47 2002-10-03;100.2;3332.14;155.367;96.8;87.04;74.88 2002-10-04;100.17;3258.46;155.329;96.4;86.48;74.19 2002-10-07;100.3;3183.83;155.462;95.99;85.82;73.31 2002-10-08;100.24;3138.05;155.981;96.09;85.94;73.46 2002-10-09;100.24;3095.92;156.006;95.53;85.16;72.47 2002-10-10;100.19;3153.42;155.648;95.98;85.84;73.37 2002-10-11;99.87;3310.08;155.724;96.82;87.15;75.13 2002-10-14;99.69;3281.04;156.677;96.56;86.9;74.9 2002-10-15;99.42;3461.79;156.827;97.81;88.76;77.34 2002-10-16;99.42;3416.55;156.598;97.37;88.16;76.58 2002-10-17;99.37;3464.51;156.937;97.97;89.06;77.8 2002-10-18;99.51;3452.97;157.877;98.09;89.18;77.92 2002-10-21;99.57;3420.19;157.581;98.22;89.31;78.08 2002-10-22;99.57;3395.74;157.215;97.89;88.85;77.49 2002-10-23;99.63;3322.09;157.93;97.65;88.5;77.06 2002-10-24;99.59;3407.36;158.258;97.9;88.84;77.44 2002-10-25;99.69;3433.97;158.244;98.1;89.1;77.76 2002-10-28;99.83;3411.14;158.447;98.05;88.97;77.55 2002-10-29;100.04;3312.07;158.862;97.54;88.17;76.48 2002-10-30;100.06;3401.27;159.261;98.05;88.87;77.34 2002-10-31;100.12;3442.53;159.753;98.08;88.9;77.34 2002-11-01;100.31;3406.67;159.878;98.1;88.86;77.27 2002-11-04;100.22;3494.5;159.523;98.6;89.59;78.2 2002-11-05;100.2;3502.28;159.433;98.59;89.62;78.27 2002-11-06;100.13;3486.49;159.245;98.64;89.7;78.4 2002-11-07;100.32;3415.46;159.624;98.13;88.9;77.31 2002-11-08;100.4;3380.12;159.366;97.99;88.6;76.84 2002-11-11;100.51;3343.83;159.509;97.75;88.19;76.25 2002-11-12;100.63;3385.19;156.998;98.05;88.57;76.7 2002-11-13;100.7;3368.72;157.03;98.06;88.53;76.62 2002-11-14;100.61;3443.95;156.313;98.58;89.31;77.65 2002-11-15;100.58;3498.54;156.569;98.79;89.63;78.07 2002-11-18;100.58;3501.09;156.992;98.75;89.54;77.94 2002-11-19;100.77;3478.95;155.837;98.65;89.34;77.64 2002-11-20;101.01;3498.26;155.687;99.13;89.93;78.34 2002-11-21;100.89;3565.01;154.842;99.71;90.78;79.46 2002-11-22;100.7;3584.02;154.474;99.77;90.91;79.66 2002-11-25;100.4;3579.13;154.389;99.78;91;79.85 2002-11-26;100.44;3539.76;154.268;99.35;90.4;79.07 2002-11-27;100.38;3599;154.53;99.91;91.22;80.15 2002-11-28;100.29;3580.1;154.26;99.83;91.14;80.08 2002-11-29;100.4;3561.69;155.653;99.79;91.07;79.98 2002-12-02;100.35;3585.53;156.291;99.84;91.12;80.03 2002-12-03;100.55;3490.59;156.936;99.32;90.35;79 2002-12-04;100.56;3491.15;157.391;99.29;90.24;78.8 2002-12-05;100.64;3451.89;157.609;99.05;89.86;78.29 2002-12-06;100.91;3438.78;156.86;99.07;89.8;78.15 2002-12-09;101.01;3392.6;157.134;98.82;89.34;77.47 2002-12-10;101.11;3422.18;156.952;99.08;89.66;77.85 2002-12-11;101.25;3423.98;157.777;99.23;89.82;78.02 2002-12-12;101.4;3407.57;157.574;99.19;89.68;77.76 2002-12-13;101.44;3385.86;157.372;98.93;89.25;77.16 2002-12-16;101.43;3442.48;156.964;99.41;89.94;78.05 2002-12-17;101.51;3418.85;157.115;99.03;89.41;77.37 2002-12-18;101.7;3356.58;156.654;98.7;88.87;76.62 2002-12-19;101.78;3341.09;156.724;98.64;88.74;76.41 2002-12-20;101.74;3337.78;156.214;98.8;88.94;76.66 2002-12-23;101.77;3309.28;156.31;98.68;88.77;76.45 2002-12-24;101.77;3309.28;156.31;98.52;88.55;76.16 2002-12-25;101.77;3309.28;156.31;98.51;88.55;76.16 2002-12-26;101.77;3309.28;156.31;98.49;88.52;76.11 2002-12-27;102;3209.09;156.419;97.98;87.75;75.1 2002-12-30;102.02;3245.5;156.627;98.21;87.99;75.35 2002-12-31;102.02;3245.5;156.627;98.1;87.86;75.2 2003-01-01;102.02;3245.5;156.627;98.49;88.21;75.49 2003-01-02;102.02;3245.5;156.627;98.64;88.68;76.31 2003-01-03;101.83;3417.43;157.211;99.15;89.38;77.13 2003-01-06;101.89;3430.28;157.594;99.38;89.73;77.61 2003-01-07;102.03;3411.9;157.655;99.35;89.63;77.43 2003-01-08;102.08;3405.45;158.238;99.35;89.53;77.23 2003-01-09;101.96;3389.64;158.361;99.36;89.57;77.31 2003-01-10;101.8;3389.29;158.725;99.34;89.55;77.29 2003-01-13;101.64;3410.45;158.696;99.22;89.49;77.28 2003-01-14;101.76;3459.71;158.801;99.5;89.85;77.7 2003-01-15;101.76;3391.01;158.358;99.21;89.38;77.07 2003-01-16;101.75;3370.79;158.98;99.11;89.25;76.91 2003-01-17;101.95;3321.32;158.924;98.67;88.57;76.01 2003-01-20;101.93;3272.52;159.562;98.49;88.29;75.65 2003-01-21;101.97;3255.16;159.432;98.33;88.02;75.25 2003-01-22;102.05;3170.01;159.903;98;87.48;74.53 2003-01-23;102.01;3170.21;160.423;98.07;87.56;74.63 2003-01-24;102.18;3136.77;160.16;97.72;87.02;73.89 2003-01-27;102.23;3027.03;160.074;97.16;86.17;72.79 2003-01-28;102.16;3015.55;160.648;97.15;86.2;72.86 2003-01-29;102.21;3029.9;160.263;97.17;86.26;72.96 2003-01-30;102.03;3081.59;161.018;97.4;86.54;73.28 2003-01-31;102.06;3089.68;161.925;97.47;86.7;73.51 2003-02-03;102.01;3123.71;162.683;97.73;87.04;73.94 2003-02-04;102.14;3048.78;162.912;97.15;86.2;72.85 2003-02-05;102.14;3066.13;162.902;97.29;86.37;73.05 2003-02-06;102.17;2984.36;162.427;96.91;85.81;72.35 2003-02-07;102.21;2960.73;162.654;96.76;85.58;72.04 2003-02-10;102.22;2918.45;165.18;96.72;85.53;71.99 2003-02-11;102.2;2982.91;166.913;97.05;85.96;72.49 2003-02-12;102.34;2915.64;167.081;96.76;85.49;71.88 2003-02-13;102.45;2918.01;165.583;96.7;85.36;71.65 2003-02-14;102.45;2990.05;166.448;97.23;86.08;72.56 2003-02-17;102.41;3056.94;166.246;97.62;86.63;73.24 2003-02-18;102.4;3025.16;167.024;97.78;86.89;73.62 2003-02-19;102.49;2951.85;166.656;97.43;86.34;72.89 2003-02-20;102.57;2954.85;167.461;97.25;86.06;72.51 2003-02-21;102.51;2963.78;167.465;97.32;86.22;72.75 2003-02-24;102.6;2931.68;167.008;97.15;85.94;72.38 2003-02-25;102.63;2873.4;167.49;96.84;85.48;71.79 2003-02-26;102.41;2845.4;167.454;96.52;85.08;71.33 2003-02-27;102.35;2861.25;167.641;96.68;85.36;71.72 2003-02-28;102.35;2907.11;167.55;96.84;85.6;72.02 2003-03-03;102.39;2933.19;167.519;96.89;85.6;71.96 2003-03-04;102.51;2839.85;167.75;96.32;84.78;70.93 2003-03-05;102.72;2785.8;167.621;96.19;84.55;70.62 2003-03-06;102.98;2781.45;167.493;96.3;84.58;70.56 2003-03-07;103.29;2741.9;167.758;96.29;84.44;70.31 2003-03-10;103.39;2643.19;168.217;95.73;83.57;69.16 2003-03-11;103.41;2632.91;167.947;95.62;83.4;68.94 2003-03-12;103.3;2603.37;167.889;95.44;83.18;68.7 2003-03-13;102.93;2679.89;167.998;96.11;84.24;70.13 2003-03-14;102.6;2825.76;167.489;96.72;85.22;71.41 2003-03-17;102.27;2900.74;166.782;97.29;86.13;72.65 2003-03-18;101.57;2926.65;166.863;97.33;86.37;73.09 2003-03-19;101.03;2993.01;166.963;97.44;86.73;73.67 2003-03-20;101.2;3010.09;167.087;97.45;86.79;73.76 2003-03-21;100.92;3121.09;166.304;98.24;87.91;75.18 2003-03-24;100.95;2974.94;166.779;97.13;86.38;73.28 2003-03-25;100.84;2996.06;166.666;97.25;86.56;73.51 2003-03-26;100.64;2987.57;166.602;97.22;86.56;73.55 2003-03-27;100.99;2951.78;166.523;97.1;86.33;73.21 2003-03-28;101.08;2962.41;166.321;97.07;86.21;73.01 2003-03-31;101.5;2882.43;165.429;96.48;85.24;71.67 2003-04-01;101.58;2914.61;165.48;96.88;85.73;72.24 2003-04-02;101.33;3005.82;165.306;97.74;86.95;73.79 2003-04-03;100.97;3042.55;164.314;97.76;87.09;74.03 2003-04-04;100.92;3087.52;163.434;98.03;87.49;74.54 2003-04-07;100.48;3159.86;163.849;98.4;88.11;75.39 2003-04-08;100.55;3142.15;164.261;98.15;87.8;75.01 2003-04-09;100.66;3164.46;163.833;98.16;87.74;74.86 2003-04-10;100.84;3099.26;164.273;97.98;87.42;74.43 2003-04-11;100.65;3149.41;164.451;98.24;87.76;74.85 2003-04-14;100.54;3178.3;164.425;98.39;88.04;75.24 2003-04-15;100.59;3252.02;165.39;98.9;88.73;76.08 2003-04-16;100.72;3222.17;165.198;98.62;88.31;75.53 2003-04-17;100.92;3214.4;165.25;98.82;88.52;75.76 2003-04-18;100.92;3214.4;165.25;98.83;88.54;75.77 2003-04-21;100.92;3214.4;165.25;99.03;88.79;76.07 2003-04-22;100.93;3220.2;165.096;99.14;88.9;76.19 2003-04-23;100.84;3261.43;165.769;99.48;89.37;76.77 2003-04-24;100.99;3215.22;166.109;99.09;88.8;76.04 2003-04-25;101.03;3187.02;165.112;98.82;88.38;75.47 2003-04-28;101.14;3242.31;164.954;99.39;89.13;76.38 2003-04-29;100.93;3212.84;164.047;99.3;89.02;76.27 2003-04-30;100.91;3235.31;163.862;99.36;89.1;76.36 2003-05-01;100.91;3235.31;163.862;99.16;88.84;76.02 2003-05-02;101.1;3220.02;164.623;99.39;89.13;76.39 2003-05-05;101.13;3265.39;163.977;99.64;89.4;76.65 2003-05-06;101.21;3304.84;163.985;99.9;89.73;77.04 2003-05-07;101.6;3297.21;163.813;99.87;89.58;76.76 2003-05-08;101.72;3223.82;163.615;99.5;88.93;75.86 2003-05-09;101.7;3218.21;165.428;99.62;89.12;76.11 2003-05-12;101.86;3198.13;165.561;99.83;89.34;76.37 2003-05-13;101.88;3237.22;166.253;100.06;89.61;76.66 2003-05-14;102.06;3244.52;166.281;100.07;89.61;76.65 2003-05-15;102.24;3256.68;166.373;100.35;89.91;76.96 2003-05-16;102.42;3276.1;166.565;100.43;89.94;76.94 2003-05-19;102.63;3209.08;166.896;99.93;89.12;75.78 2003-05-20;102.54;3227.66;167.006;100.08;89.3;75.98 2003-05-21;102.6;3184.84;167.025;99.84;88.97;75.59 2003-05-22;102.55;3263.69;167.391;100.3;89.62;76.39 2003-05-23;102.63;3269.11;167.48;100.42;89.72;76.49 2003-05-26;102.61;3245.1;167.475;100.4;89.65;76.37 2003-05-27;102.74;3263.14;167.618;100.6;89.91;76.68 2003-05-28;102.32;3329.62;168.059;100.96;90.5;77.48 2003-05-29;102.32;3329.62;168.059;100.91;90.42;77.37 2003-05-30;102.41;3310.52;168.789;101.11;90.7;77.76 2003-06-02;102.2;3393.3;169.543;101.36;91.14;78.35 2003-06-03;102.43;3365.93;169.272;101.58;91.35;78.56 2003-06-04;102.58;3389.89;169.522;101.95;91.83;79.17 2003-06-05;102.84;3363.3;169.653;102.03;91.8;79.03 2003-06-06;102.82;3419.33;169.22;102.6;92.57;79.99 2003-06-09;102.82;3419.33;169.22;102.29;92.12;79.38 2003-06-10;103.06;3421.17;169.113;102.64;92.51;79.82 2003-06-11;103.14;3458.46;167.734;102.84;92.78;80.13 2003-06-12;102.92;3484.5;166.482;103.06;93.1;80.55 2003-06-13;102.81;3427.04;166.839;102.68;92.59;79.93 2003-06-16;102.85;3495.65;166.862;103.01;93.08;80.55 2003-06-17;102.53;3529.01;167.078;103.13;93.32;80.91 2003-06-18;101.98;3556.37;166.994;103.15;93.54;81.35 2003-06-19;101.58;3506.64;166.824;102.72;93.04;80.78 2003-06-20;101.64;3517.26;166.831;102.67;93.04;80.84 2003-06-23;101.51;3443.99;165.555;102.16;92.35;79.99 2003-06-24;101.62;3443.64;164.572;102.12;92.28;79.89 2003-06-25;101.77;3445.79;165.038;102.18;92.29;79.85 2003-06-26;101.47;3456.46;164.431;102.41;92.68;80.39 2003-06-27;101.58;3459.41;165.199;102.41;92.7;80.45 2003-06-30;101.63;3437.73;166.017;102.48;92.7;80.38 2003-07-01;101.8;3361.85;165.488;102.18;92.24;79.79 2003-07-02;101.72;3421.83;165.289;102.68;92.97;80.73 2003-07-03;101.65;3444.6;164.528;102.6;92.9;80.67 2003-07-04;101.82;3446.07;164.653;102.66;92.96;80.73 2003-07-07;101.74;3517.45;164.394;103.44;94.04;82.12 2003-07-08;101.76;3505.59;164.108;103.48;94.11;82.24 2003-07-09;101.78;3473.19;163.977;103.18;93.69;81.69 2003-07-10;101.93;3466.8;164.001;103.08;93.49;81.37 2003-07-11;101.95;3503.65;164.206;103.44;93.95;81.92 2003-07-14;102.03;3550.97;164.361;103.79;94.42;82.51 2003-07-15;101.81;3535.93;164.369;103.64;94.25;82.32 2003-07-16;101.5;3525.45;164.235;103.27;93.85;81.9 2003-07-17;101.35;3501.89;164.488;102.78;93.26;81.2 2003-07-18;101.33;3504.59;164.391;102.82;93.35;81.34 2003-07-21;100.95;3484.06;164.652;102.34;92.74;80.6 2003-07-22;100.86;3479.71;164.973;102.37;92.86;80.82 2003-07-23;101.08;3499.48;164.268;102.45;92.92;80.85 2003-07-24;100.96;3545.35;164.897;102.64;93.15;81.11 2003-07-25;101.06;3529.94;165.423;102.65;93.18;81.16 2003-07-28;100.88;3570.05;165.773;102.86;93.5;81.59 2003-07-29;100.88;3562.27;165.587;102.66;93.25;81.28 2003-07-30;100.77;3596.62;166.331;102.92;93.6;81.72 2003-07-31;100.72;3620.38;165.675;103.03;93.84;82.08 2003-08-01;100.72;3599.7;165.314;102.6;93.3;81.43 2003-08-04;100.31;3563.67;165.456;102.18;92.81;80.87 2003-08-05;100.29;3601.93;165.667;102.06;92.68;80.71 2003-08-06;100.18;3568.38;166.131;101.89;92.45;80.42 2003-08-07;100.35;3560.43;166.091;102.09;92.67;80.68 2003-08-08;100.73;3575.15;166.082;102.5;93.13;81.18 2003-08-11;100.65;3573.29;166.429;102.68;93.33;81.42 2003-08-12;100.62;3604.75;166.837;102.98;93.76;81.97 2003-08-13;100.39;3596.36;166.703;102.86;93.65;81.89 2003-08-14;100.08;3625.19;167.206;102.95;93.9;82.3 2003-08-15;100.15;3668.65;166.753;103.06;94.07;82.52 2003-08-18;100.2;3688.91;166.822;103.58;94.74;83.36 2003-08-19;100.09;3703.86;166.421;103.77;95;83.7 2003-08-20;100.2;3683.21;167.194;103.56;94.73;83.36 2003-08-21;100.04;3721.07;166.967;103.93;95.26;84.06 2003-08-22;99.98;3751.83;167.496;104.07;95.48;84.34 2003-08-25;100.09;3699.88;167.758;103.82;95.1;83.86 2003-08-26;99.95;3688.65;167.758;103.71;94.96;83.68 2003-08-27;100.02;3706.28;167.669;103.82;95.11;83.87 2003-08-28;99.91;3723.14;168.006;103.93;95.28;84.1 2003-08-29;99.89;3674.7;167.939;103.7;94.98;83.75 2003-09-01;99.81;3739.17;168.287;103.97;95.38;84.26 2003-09-02;99.32;3719.11;168.367;103.9;95.46;84.54 2003-09-03;98.86;3792.97;168.47;103.99;95.8;85.11 2003-09-04;98.92;3797.81;168.564;103.97;95.79;85.12 2003-09-05;99.12;3805.07;167.857;103.86;95.54;84.7 2003-09-08;99.31;3822.53;167.926;104.08;95.78;84.95 2003-09-09;99.29;3798.6;166.36;104.02;95.61;84.67 2003-09-10;99.41;3801.71;166.981;104.03;95.54;84.49 2003-09-11;99.48;3805.35;166.626;104.08;95.59;84.55 2003-09-12;99.74;3801.65;166.787;104.2;95.66;84.56 2003-09-15;99.83;3818;165.851;104.35;95.77;84.61 2003-09-16;99.83;3846.31;166.643;104.79;96.4;85.45 2003-09-17;99.81;3866.93;166.433;104.79;96.38;85.4 2003-09-18;99.73;3884.34;166.203;105.14;96.85;86 2003-09-19;99.81;3855.39;166.227;104.81;96.37;85.37 2003-09-22;100.02;3773.24;166.439;104.33;95.6;84.29 2003-09-23;100.08;3740.99;166.527;104.36;95.59;84.26 2003-09-24;100;3754.69;167.098;104.29;95.47;84.07 2003-09-25;100.13;3704.43;167.642;103.85;94.85;83.27 2003-09-26;100.22;3684.26;167.313;103.73;94.66;83 2003-09-29;100.17;3667.42;167.839;103.64;94.53;82.83 2003-09-30;100.5;3626.43;167.374;103.31;93.98;82.05 2003-10-01;100.56;3636.46;168.287;103.66;94.44;82.64 2003-10-02;100.31;3651.95;168.276;103.71;94.59;82.9 2003-10-03;100.07;3737.14;168.576;104.19;95.38;83.99 2003-10-06;100.04;3710.3;169.385;104.08;95.26;83.88 2003-10-07;100.14;3687.1;170.053;103.94;95.05;83.6 2003-10-08;100.1;3704.51;169.95;103.92;95;83.5 2003-10-09;100.11;3753;170.645;104.26;95.5;84.15 2003-10-10;100.19;3746.25;171.123;104.25;95.43;84.04 2003-10-13;100.07;3793.67;170.999;104.66;96.04;84.84 2003-10-14;100.07;3782.46;170.814;104.57;95.93;84.73 2003-10-15;99.99;3790.74;171.47;104.66;96.09;84.94 2003-10-16;99.97;3791.73;171.522;104.61;96.03;84.88 2003-10-17;99.83;3783.72;172.27;104.63;96.05;84.91 2003-10-20;99.85;3796.41;171.744;104.64;96.08;84.96 2003-10-21;99.94;3789.27;171.932;104.72;96.15;85.01 2003-10-22;100.08;3735.61;171.807;104.3;95.48;84.09 2003-10-23;100.14;3698.2;172.276;104;95.05;83.52 2003-10-24;100.14;3700.2;172.511;103.94;94.94;83.36 2003-10-27;99.96;3724.15;172.563;104.16;95.27;83.8 2003-10-28;99.85;3746;172.685;104.58;95.91;84.68 2003-10-29;99.83;3743.17;172.804;104.59;95.94;84.73 2003-10-30;99.74;3775.43;172.542;104.62;96.02;84.85 2003-10-31;99.91;3769.49;171.589;104.74;96.17;85.04 2003-11-03;99.72;3842.24;172.508;105.36;97.04;86.17 2003-11-04;99.7;3798.32;172.47;105.28;96.93;86.07 2003-11-05;99.59;3764.87;171.928;105.22;96.85;85.96 2003-11-06;99.42;3787.63;172.994;105.27;96.99;86.19 2003-11-07;99.2;3835.57;172.942;105.28;97.09;86.38 2003-11-10;99.25;3796.61;173.221;105.15;96.87;86.08 2003-11-11;99.32;3806.77;172.997;104.98;96.62;85.73 2003-11-12;99.34;3812.19;173.345;105.04;96.7;85.82 2003-11-13;99.5;3848.76;173.703;105.3;96.99;86.12 2003-11-14;99.75;3877.43;173.752;105.27;96.84;85.83 2003-11-17;99.91;3809.14;174.277;104.8;96.11;84.81 2003-11-18;99.92;3793.31;174.269;104.63;95.82;84.39 2003-11-19;99.98;3753.8;174.596;104.42;95.52;84.01 2003-11-20;99.99;3756.13;175.365;104.32;95.38;83.83 2003-11-21;100.06;3761.22;174.719;104.32;95.38;83.82 2003-11-24;99.83;3826.36;174.578;104.96;96.31;85.05 2003-11-25;99.67;3831.89;175.088;104.89;96.29;85.1 2003-11-26;99.58;3824.9;174.749;104.63;95.99;84.74 2003-11-27;99.4;3841.26;175.13;104.66;96.08;84.89 2003-11-28;99.38;3842.74;174.48;104.5;95.89;84.67 2003-12-01;99.28;3881.74;174.568;104.84;96.42;85.41 2003-12-02;99.25;3883.42;174.522;104.64;96.17;85.09 2003-12-03;99.48;3924.52;174.954;104.91;96.48;85.44 2003-12-04;99.54;3919.51;173.881;105.08;96.67;85.66 2003-12-05;99.78;3876.77;173.837;104.8;96.21;84.99 2003-12-08;100.02;3871.87;174.197;104.76;96.05;84.72 2003-12-09;99.94;3891;174.298;104.84;96.13;84.78 2003-12-10;100.03;3856.74;174.357;104.64;95.82;84.36 2003-12-11;99.99;3895.47;174.459;105.09;96.45;85.17 2003-12-12;100.24;3892.75;175.378;105.05;96.36;85.02 2003-12-15;100.3;3912.77;175.929;105.25;96.55;85.18 2003-12-16;100.46;3883.9;176.524;105.19;96.41;84.97 2003-12-17;100.5;3867.08;176.468;105.18;96.34;84.85 2003-12-18;100.53;3908.27;176.205;105.5;96.78;85.4 2003-12-19;100.47;3907.72;175.6;105.54;96.86;85.53 2003-12-22;100.5;3892.85;176.505;105.51;96.8;85.46 2003-12-23;100.49;3911.68;175.744;105.71;97.06;85.76 2003-12-24;100.49;3911.68;175.744;105.57;96.87;85.53 2003-12-25;100.49;3911.68;175.744;105.57;96.87;85.53 2003-12-26;100.49;3911.68;175.744;105.66;96.99;85.68 2003-12-29;100.35;3931.16;176.363;105.84;97.28;86.08 2003-12-30;100.22;3961.58;176.55;105.81;97.31;86.17 2003-12-31;100.22;3961.58;176.55;105.75;97.23;86.06 2004-01-01;100.22;3961.58;176.55;105.75;97.23;86.07 2004-01-02;100.22;3961.58;176.55;105.81;97.33;86.21 2004-01-05;100.02;4029.01;177.494;106.06;97.75;86.8 2004-01-06;100.16;4037.99;178.517;106.23;97.88;86.89 2004-01-07;100.25;4028.7;179.16;106.35;97.99;86.99 2004-01-08;100.3;4046.59;179.578;106.48;98.16;87.2 2004-01-09;100.51;4025.16;179.947;106.42;97.94;86.79 2004-01-12;100.59;3981.89;179.766;106.43;97.91;86.75 2004-01-13;100.6;4016.71;179.676;106.45;97.94;86.76 2004-01-14;100.52;4062.66;179.584;106.72;98.37;87.36 2004-01-15;100.65;4068.69;179.384;106.99;98.65;87.66 2004-01-16;100.78;4115.33;180.229;107.64;99.51;88.75 2004-01-19;100.75;4118.96;180.526;107.73;99.64;88.91 2004-01-20;100.8;4096.94;180.292;107.47;99.25;88.38 2004-01-21;100.79;4109.15;181.209;107.48;99.29;88.44 2004-01-22;100.81;4136.19;180.799;107.51;99.3;88.41 2004-01-23;100.94;4166.34;182.134;107.67;99.45;88.53 2004-01-26;100.73;4157.66;181.982;107.7;99.61;88.86 2004-01-27;100.64;4185.99;180.495;107.68;99.58;88.81 2004-01-28;100.72;4195.42;180.129;107.67;99.52;88.67 2004-01-29;100.37;4170.22;180.237;107.36;99.3;88.57 2004-01-30;100.42;4152.32;179.925;107.36;99.23;88.44 2004-02-02;100.62;4188.93;179.451;107.68;99.57;88.79 2004-02-03;100.82;4154.36;180.194;107.58;99.33;88.4 2004-02-04;100.79;4180.25;180.998;107.59;99.33;88.37 2004-02-05;100.76;4169.78;180.772;107.44;99.13;88.12 2004-02-06;100.79;4209.26;181.326;107.6;99.35;88.38 2004-02-09;100.86;4251.55;181.49;107.93;99.76;88.86 2004-02-10;100.95;4257.65;181.616;108.05;99.88;88.99 2004-02-11;100.86;4259.92;181.441;108.22;100.15;89.38 2004-02-12;101.15;4238.07;181.191;108.23;100.02;89.08 2004-02-13;101.32;4240.62;181.055;108.43;100.2;89.24 2004-02-16;101.27;4248.11;181.096;108.41;100.19;89.23 2004-02-17;101.46;4256.46;180.56;108.65;100.45;89.53 2004-02-18;101.56;4228.44;179.625;108.61;100.34;89.34 2004-02-19;101.24;4259.29;180.092;108.65;100.55;89.74 2004-02-20;101.09;4246.92;179.219;108.56;100.49;89.71 2004-02-23;100.98;4264.25;178.709;108.58;100.54;89.8 2004-02-24;101.08;4210.47;178.08;108.25;100.01;89.06 2004-02-25;101.09;4214.07;178.381;108.49;100.35;89.51 2004-02-26;101.09;4205.94;178.59;108.64;100.56;89.8 2004-02-27;101.19;4221.29;178.545;108.9;100.85;90.12 2004-03-01;101.19;4246.29;178.5;109.14;101.2;90.59 2004-03-02;101.1;4291.7;178.165;109.49;101.7;91.26 2004-03-03;100.98;4277.22;178.733;109.36;101.62;91.24 2004-03-04;101.02;4319.43;178.725;109.5;101.8;91.43 2004-03-05;101.35;4294.97;178.796;109.5;101.6;91.02 2004-03-08;101.63;4288.98;178.981;109.81;101.85;91.21 2004-03-09;101.57;4268.56;179.061;109.55;101.49;90.74 2004-03-10;101.51;4278.36;178.978;109.49;101.43;90.67 2004-03-11;101.67;4158.04;178.956;108.86;100.45;89.32 2004-03-12;101.7;4154.04;178.819;109.01;100.66;89.62 2004-03-15;101.78;4096.41;177.502;108.63;100.06;88.78 2004-03-16;101.65;4112.84;174.798;108.63;100.12;88.9 2004-03-17;101.69;4143.35;176.546;109.11;100.8;89.8 2004-03-18;101.58;4087.59;175.895;108.51;100.01;88.81 2004-03-19;101.52;4095.49;176.734;108.47;99.96;88.76 2004-03-22;101.61;3987.98;176.95;107.93;99.13;87.62 2004-03-23;101.51;4015.52;176.867;107.96;99.23;87.79 2004-03-24;101.59;4011.59;176.997;108.15;99.43;88.02 2004-03-25;101.63;4075.05;177.203;108.6;100.07;88.85 2004-03-26;101.56;4073.54;177.374;108.72;100.27;89.15 2004-03-29;101.21;4111.39;178.02;108.84;100.61;89.72 2004-03-30;101.3;4097.9;178.1;108.82;100.55;89.63 2004-03-31;101.26;4098.05;178.139;108.69;100.37;89.4 2004-04-01;101.17;4164.45;178.742;108.86;100.67;89.81 2004-04-02;100.75;4211.32;178.267;109.21;101.39;90.94 2004-04-05;100.65;4232.99;178.196;109.5;101.86;91.61 2004-04-06;100.75;4201.26;178.886;109.34;101.57;91.2 2004-04-07;100.76;4205.17;178.758;108.98;101.09;90.55 2004-04-08;100.57;4228.66;178.667;108.95;101.14;90.7 2004-04-09;100.57;4228.66;178.667;108.93;101.1;90.64 2004-04-12;100.57;4228.66;178.667;109;101.22;90.82 2004-04-13;100.37;4236.17;178.552;109.04;101.35;91.05 2004-04-14;100.37;4205.2;178.346;108.67;100.84;90.39 2004-04-15;100.44;4222.29;178.141;108.77;100.94;90.47 2004-04-16;100.53;4229.89;177.637;108.87;101.01;90.51 2004-04-19;100.61;4241.58;177.658;108.93;101.06;90.54 2004-04-20;100.36;4270.48;175.266;109.04;101.3;90.92 2004-04-21;100.22;4245.77;173.967;108.85;101.1;90.73 2004-04-22;100.2;4247.55;173.122;109.06;101.42;91.16 2004-04-23;100.11;4270.56;173.252;109.17;101.63;91.47 2004-04-26;99.95;4314.27;174.13;109.13;101.62;91.49 2004-04-27;99.78;4306.19;174.497;108.74;101.17;90.97 2004-04-28;99.83;4269.66;173.817;108.54;100.84;90.5 2004-04-29;99.84;4258.51;173.445;108.19;100.34;89.82 2004-04-30;100.1;4252.4;174.334;108.33;100.36;89.71 2004-05-03;100.19;4281.06;174.71;108.6;100.7;90.12 2004-05-04;100.22;4288.54;174.374;108.49;100.55;89.92 2004-05-05;100.24;4331.23;174.132;108.61;100.72;90.11 2004-05-06;99.99;4291.27;174.33;108.25;100.3;89.66 2004-05-07;99.68;4286.81;174.28;107.9;99.99;89.38 2004-05-10;99.55;4154.51;174.388;107.07;98.84;87.92 2004-05-11;99.51;4208.9;174.501;107.35;99.28;88.5 2004-05-12;99.5;4159.72;175.312;107.07;98.9;88.05 2004-05-13;99.42;4206.25;175.835;107.19;99.1;88.33 2004-05-14;99.49;4188.24;175.766;107.16;99;88.15 2004-05-17;99.77;4132.97;175.678;106.82;98.35;87.14 2004-05-18;99.74;4155.04;175.943;106.98;98.61;87.52 2004-05-19;99.59;4208.25;175.455;107.08;98.85;87.89 2004-05-20;99.59;4208.25;175.455;107.2;99;88.08 2004-05-21;99.7;4166.82;175.032;107.15;98.88;87.9 2004-05-24;99.53;4193.32;175.701;107.29;99.13;88.29 2004-05-25;99.56;4170.16;175.111;107.17;98.96;88.07 2004-05-26;99.44;4189.37;175.054;107.34;99.24;88.45 2004-05-27;99.48;4213.32;174.716;107.25;99.11;88.26 2004-05-28;99.43;4161.32;175.318;107.09;98.92;88.07 2004-05-31;99.43;4161.32;175.318;107.1;98.93;88.08 2004-06-01;99.26;4134.03;174.965;106.85;98.66;87.8 2004-06-02;99.17;4163.85;174.47;106.73;98.56;87.71 2004-06-03;99.02;4184.87;175.135;106.63;98.46;87.6 2004-06-04;98.87;4206.96;174.402;106.64;98.57;87.81 2004-06-07;98.83;4246.96;173.901;106.95;99.03;88.43 2004-06-08;98.72;4240.75;174.158;106.89;99;88.43 2004-06-09;98.55;4229.63;174.305;106.73;98.87;88.35 2004-06-10;98.45;4206.06;174.695;106.5;98.62;88.1 2004-06-11;98.43;4213.27;174.497;106.66;98.84;88.38 2004-06-14;98.55;4174.41;174.861;106.43;98.43;87.77 2004-06-15;98.71;4199.61;174.225;106.84;98.89;88.28 2004-06-16;98.83;4225.41;174.06;107.21;99.37;88.87 2004-06-17;98.61;4222.58;174.751;106.8;98.92;88.39 2004-06-18;98.8;4215.37;174.465;106.76;98.78;88.13 2004-06-21;98.87;4231.48;174.498;106.96;99;88.36 2004-06-22;98.78;4192.75;174.492;106.83;98.85;88.21 2004-06-23;98.7;4190.18;174.798;106.95;99.05;88.5 2004-06-24;98.84;4203.22;174.746;107.02;99.07;88.46 2004-06-25;98.74;4207.45;174.812;107.08;99.17;88.61 2004-06-28;98.52;4225.26;174.694;106.98;99.14;88.64 2004-06-29;98.39;4213.54;174.857;107.15;99.4;89.01 2004-06-30;98.57;4166.47;175.013;107.02;99.14;88.62 2004-07-01;98.53;4173.04;174.978;106.96;99.04;88.48 2004-07-02;98.78;4160;175.079;106.74;98.61;87.79 2004-07-05;98.88;4145.4;175.353;106.84;98.67;87.83 2004-07-06;98.91;4117.02;174.801;106.68;98.42;87.48 2004-07-07;98.93;4111.27;174.955;106.63;98.34;87.36 2004-07-08;99.02;4135.91;175.386;106.63;98.27;87.21 2004-07-09;99.04;4114.74;175.259;106.69;98.35;87.31 2004-07-12;99.14;4104.79;175.143;106.75;98.37;87.29 2004-07-13;98.97;4102.1;175.363;106.81;98.53;87.57 2004-07-14;99;4109.85;175.569;106.68;98.32;87.26 2004-07-15;98.99;4061.7;175.547;106.58;98.16;87.05 2004-07-16;99.1;4052.76;175.95;106.57;98.06;86.86 2004-07-19;99.14;4029.22;175.32;106.61;98.09;86.87 2004-07-20;99.14;4067.89;175.349;106.89;98.47;87.36 2004-07-21;98.96;4112.62;175.505;107.01;98.71;87.73 2004-07-22;99.07;4050.59;175.318;106.72;98.26;87.1 2004-07-23;99.1;4055.3;175.492;106.87;98.43;87.3 2004-07-26;99.07;4028.66;175.594;106.73;98.22;87.02 2004-07-27;98.97;4068.12;175.186;107.01;98.67;87.65 2004-07-28;98.82;4077.13;175.089;106.97;98.69;87.74 2004-07-29;98.85;4103.74;175.351;107.16;98.93;88.04 2004-07-30;99.1;4098.61;175.61;107.51;99.28;88.39 2004-08-02;99.17;4092.78;175.573;107.56;99.32;88.41 2004-08-03;99.26;4128.68;175.374;107.71;99.46;88.53 2004-08-04;99.52;4079.05;175.635;107.64;99.24;88.15 2004-08-05;99.69;4075.69;175.682;107.66;99.16;87.95 2004-08-06;99.98;3995.03;175.78;107.23;98.35;86.74 2004-08-09;100.06;3962.76;175.764;107.21;98.27;86.59 2004-08-10;99.95;3980.65;175.934;107.27;98.41;86.83 2004-08-11;99.83;3968.6;175.859;107.3;98.49;86.98 2004-08-12;99.92;3958.4;175.874;107.13;98.2;86.55 2004-08-13;100.03;3928.35;175.856;106.86;97.78;85.96 2004-08-16;99.96;3958.45;176.409;107.07;98.11;86.43 2004-08-17;99.95;3976.2;175.995;107.27;98.38;86.76 2004-08-18;100.01;3941.62;175.754;107.39;98.54;86.99 2004-08-19;99.96;3962.41;175.956;107.35;98.51;86.95 2004-08-20;100.03;3956.92;175.801;107.57;98.76;87.26 2004-08-23;99.85;3994.87;176.09;107.76;99.11;87.77 2004-08-24;99.66;3987.62;176.04;107.68;99.09;87.83 2004-08-25;99.65;3985.14;175.862;107.81;99.28;88.1 2004-08-26;99.64;4022.6;176.387;107.99;99.53;88.41 2004-08-27;99.73;4044.75;175.927;108.29;99.9;88.86 2004-08-30;99.8;4036.6;176.313;108.22;99.76;88.63 2004-08-31;99.97;4016.27;175.969;108.2;99.63;88.38 2004-09-01;99.91;4047.91;176.723;108.23;99.71;88.51 2004-09-02;99.85;4034.47;176.577;108.2;99.74;88.61 2004-09-03;99.66;4069.97;176.618;108.15;99.79;88.76 2004-09-06;99.63;4096.32;176.511;108.29;99.97;88.98 2004-09-07;99.69;4109.19;176.713;108.46;100.19;89.24 2004-09-08;99.71;4105.63;177.156;108.45;100.14;89.14 2004-09-09;99.84;4082.51;177.106;108.47;100.07;89 2004-09-10;99.89;4095.51;176.863;108.52;100.11;89 2004-09-13;99.81;4121.66;176.835;108.7;100.39;89.4 2004-09-14;99.87;4099.09;177.144;108.7;100.36;89.34 2004-09-15;99.87;4098.02;177.257;108.75;100.41;89.39 2004-09-16;99.88;4091.08;176.812;108.85;100.54;89.57 2004-09-17;100.01;4105.47;177.324;109.06;100.76;89.8 2004-09-20;100.03;4108.93;176.614;109.14;100.83;89.85 2004-09-21;99.94;4145.01;176.621;109.06;100.78;89.81 2004-09-22;99.98;4123.01;177.129;108.95;100.56;89.47 2004-09-23;100.06;4078.92;177.085;108.79;100.27;89.06 2004-09-24;99.99;4067.7;177.422;108.76;100.27;89.09 2004-09-27;100.01;4038.19;178.106;108.62;100.02;88.73 2004-09-28;100.08;4075.98;178.16;108.86;100.33;89.11 2004-09-29;99.99;4099.99;177.996;108.92;100.47;89.33 2004-09-30;100.07;4057.34;178.225;108.73;100.16;88.91 2004-10-01;100.08;4100.13;178.265;109.08;100.69;89.62 2004-10-04;100.13;4152.46;179.174;109.63;101.44;90.58 2004-10-05;100.25;4147.97;178.9;109.69;101.44;90.52 2004-10-06;100.29;4146.86;179.145;109.79;101.57;90.68 2004-10-07;100.18;4106.89;179.672;109.5;101.22;90.27 2004-10-08;100.36;4085.64;179.078;109.36;100.9;89.76 2004-10-11;100.53;4064.64;179.778;109.45;100.95;89.77 2004-10-12;100.75;4043.19;179.926;109.64;101.07;89.82 2004-10-13;100.69;4056.09;180.01;109.47;100.88;89.59 2004-10-14;100.77;4014.65;180.283;109.13;100.33;88.82 2004-10-15;100.77;3986.81;180.094;108.9;100.03;88.45 2004-10-18;100.83;3986.98;179.903;108.94;100.05;88.44 2004-10-19;100.81;4023.78;180.378;109;100.14;88.55 2004-10-20;100.98;3995.34;180.835;108.92;99.91;88.16 2004-10-21;100.96;4011.35;181.24;108.98;100.01;88.31 2004-10-22;100.91;4007.81;181.527;108.86;99.85;88.1 2004-10-25;100.96;3950.41;181.795;108.42;99.2;87.21 2004-10-26;100.96;3964.39;182.074;108.62;99.48;87.6 2004-10-27;100.94;3996.4;182.563;108.85;99.84;88.09 2004-10-28;100.73;4022.25;183.177;108.78;99.88;88.25 2004-10-29;100.87;3987.29;183.673;108.85;99.89;88.21 2004-11-01;100.96;4027.66;182.923;109.12;100.21;88.56 2004-11-02;100.74;4071.7;184.097;109.22;100.47;88.98 2004-11-03;100.73;4110.38;183.831;109.31;100.61;89.16 2004-11-04;100.96;4118.02;184.556;109.51;100.79;89.33 2004-11-05;100.87;4165.52;184.844;109.62;101;89.64 2004-11-08;100.69;4150.08;184.414;109.38;100.73;89.34 2004-11-09;100.81;4129.71;184.625;109.43;100.75;89.32 2004-11-10;100.83;4155.73;184.419;109.45;100.77;89.33 2004-11-11;101.1;4184.29;184.589;109.76;101.1;89.67 2004-11-12;101.26;4214.24;183.92;110.19;101.6;90.24 2004-11-15;101.35;4204.62;183.308;110.32;101.72;90.36 2004-11-16;101.28;4189.38;182.786;110.11;101.44;90 2004-11-17;101.14;4209.16;182.345;110.01;101.4;90.02 2004-11-18;100.96;4205.18;182.605;109.91;101.34;90.01 2004-11-19;100.93;4159.63;182.742;109.5;100.78;89.29 2004-11-22;101.1;4128.27;183.263;109.63;100.85;89.31 2004-11-23;101.2;4105.18;183.236;109.59;100.74;89.14 2004-11-24;101.32;4090.45;183.183;109.57;100.67;89.01 2004-11-25;101.43;4122.2;183.042;109.67;100.76;89.07 2004-11-26;101.47;4124.02;183.432;109.75;100.84;89.15 2004-11-29;101.4;4103.99;183.312;109.63;100.7;88.99 2004-11-30;101.48;4052.75;184.1;109.42;100.36;88.54 2004-12-01;101.48;4097.44;184.277;109.92;101.04;89.4 2004-12-02;101.4;4138.18;184.803;110.19;101.44;89.94 2004-12-03;101.45;4128.61;184.889;110.08;101.25;89.64 2004-12-06;101.66;4103.96;184.53;110.17;101.22;89.51 2004-12-07;101.76;4131.68;184.849;110.24;101.24;89.45 2004-12-08;101.79;4135.13;185.572;110.56;101.65;89.97 2004-12-09;101.87;4129.16;185.907;110.53;101.57;89.83 2004-12-10;101.82;4147.41;185.478;110.65;101.75;90.06 2004-12-13;101.85;4177.6;184.732;110.84;101.99;90.36 2004-12-14;101.82;4196.82;185.085;110.95;102.16;90.59 2004-12-15;101.67;4187.55;185.268;110.69;101.87;90.25 2004-12-16;101.68;4195.28;184.839;110.97;102.24;90.73 2004-12-17;101.48;4165.4;186.958;110.72;101.98;90.48 2004-12-20;101.54;4199.16;187.216;110.75;101.98;90.41 2004-12-21;101.37;4193.7;187.637;110.83;102.17;90.74 2004-12-22;101.28;4227.28;187.343;110.94;102.36;91.01 2004-12-23;101.32;4233.15;187.911;110.92;102.3;90.9 2004-12-24;101.32;4233.15;187.911;110.96;102.35;90.96 2004-12-27;101.4;4226.79;187.931;110.89;102.2;90.72 2004-12-28;101.39;4226.88;188.22;110.96;102.32;90.89 2004-12-29;101.3;4233.35;188.788;110.82;102.2;90.79 2004-12-30;101.21;4234.56;188.295;110.84;102.24;90.86 2004-12-31;101.21;4234.56;188.295;110.92;102.35;91 2005-01-03;101.59;4289.16;189.175;111.43;102.86;91.49 2005-01-04;101.56;4294.56;189.38;111.58;103.06;91.74 2005-01-05;101.63;4259.73;189.967;111.47;102.85;91.43 2005-01-06;101.71;4271.48;190.504;111.68;103.11;91.75 2005-01-07;101.74;4266.76;190.878;111.88;103.36;92.07 2005-01-10;101.79;4265.26;191.661;111.88;103.33;92 2005-01-11;101.75;4252.5;191.903;111.73;103.12;91.73 2005-01-12;101.74;4220.95;193.422;111.49;102.79;91.29 2005-01-13;101.9;4235.99;193.633;111.75;103.03;91.53 2005-01-14;101.82;4267.54;193.522;112.01;103.44;92.09 2005-01-17;101.95;4291.68;193.897;112.17;103.6;92.24 2005-01-18;101.95;4277.75;193.927;112.26;103.74;92.44 2005-01-19;102.03;4286.75;193.335;112.2;103.61;92.22 2005-01-20;101.94;4272.08;193.267;112.1;103.49;92.1 2005-01-21;101.94;4277.91;193.833;112.12;103.49;92.06 2005-01-24;101.99;4285.03;194.093;112.09;103.41;91.91 2005-01-25;102.01;4297.05;193.71;112.33;103.74;92.34 2005-01-26;101.94;4300.16;193.279;112.24;103.65;92.26 2005-01-27;101.89;4303.48;192.122;112.22;103.66;92.3 2005-01-28;101.99;4288.54;191.725;112.31;103.71;92.31 2005-01-31;102.06;4305.72;193.486;112.55;104.01;92.68 2005-02-01;102.24;4324.85;193.309;112.96;104.49;93.23 2005-02-02;102.28;4325.3;193.805;113;104.54;93.29 2005-02-03;102.25;4342.58;193.943;113.19;104.79;93.62 2005-02-04;102.5;4363.04;193.846;113.65;105.31;94.19 2005-02-07;102.58;4384.04;193.961;113.98;105.72;94.68 2005-02-08;102.6;4392.72;193.923;114.06;105.83;94.82 2005-02-09;102.87;4383.13;193.801;114.1;105.74;94.59 2005-02-10;102.81;4390.3;193.436;114.01;105.64;94.48 2005-02-11;102.73;4421.12;193.097;114.12;105.86;94.81 2005-02-14;102.61;4421.55;192.538;113.99;105.73;94.68 2005-02-15;102.49;4424.57;190.703;113.87;105.65;94.64 2005-02-16;102.3;4392.22;190.411;113.52;105.26;94.22 2005-02-17;102;4401.48;190.787;113.18;104.92;93.87 2005-02-18;101.77;4417.08;190.335;112.99;104.79;93.82 2005-02-21;101.7;4434.73;188.401;112.96;104.79;93.83 2005-02-22;101.73;4420.74;187.315;112.51;104.13;92.93 2005-02-23;101.59;4387.16;186.607;112.36;103.98;92.8 2005-02-24;101.41;4399.19;186.668;112.39;104.11;93.04 2005-02-25;101.28;4437.11;186.625;112.63;104.51;93.62 2005-02-28;101.37;4435.52;186.457;112.47;104.25;93.23 2005-03-01;101.25;4465.88;185.631;112.63;104.55;93.67 2005-03-02;101.18;4491.93;185.097;112.81;104.82;94.05 2005-03-03;101.41;4490.76;184.547;113.07;105.06;94.26 2005-03-04;101.61;4513.74;184.31;113.34;105.32;94.51 2005-03-07;101.69;4518.14;185.048;113.67;105.7;94.96 2005-03-08;101.76;4494.66;186.714;113.3;105.17;94.24 2005-03-09;101.37;4485.88;188.639;112.98;104.89;94.01 2005-03-10;101.16;4471.28;188.482;112.58;104.44;93.5 2005-03-11;101.27;4490.44;187.724;112.64;104.46;93.45 2005-03-14;101.16;4484.18;187.981;112.73;104.62;93.7 2005-03-15;101.31;4518.76;188.073;113;104.9;93.98 2005-03-16;101.27;4471.79;188.37;112.52;104.23;93.1 2005-03-17;101.33;4461.05;188.497;112.58;104.29;93.17 2005-03-18;101.26;4440.15;189.185;112.68;104.45;93.42 2005-03-21;101.16;4445.78;189.601;112.69;104.51;93.52 2005-03-22;101.2;4449.04;189.892;112.68;104.44;93.39 2005-03-23;100.97;4452.34;189.853;112.68;104.55;93.63 2005-03-24;101.03;4460;188.547;112.82;104.7;93.79 2005-03-25;101.03;4460;188.547;112.83;104.72;93.82 2005-03-28;101.03;4460;188.547;112.92;104.86;94.01 2005-03-29;101.14;4474.02;188.868;112.95;104.8;93.85 2005-03-30;101.36;4457.45;189.658;113;104.8;93.78 2005-03-31;101.65;4456.72;190.048;113.24;104.98;93.9 2005-04-01;101.66;4473.72;189.954;113.42;105.2;94.16 2005-04-04;101.68;4440.26;189.546;113.54;105.33;94.33 2005-04-05;101.72;4470.68;189.175;113.65;105.49;94.53 2005-04-06;101.75;4510.03;189.004;113.82;105.71;94.8 2005-04-07;101.92;4526.26;189.062;114.01;105.89;94.96 2005-04-08;101.79;4524.17;188.931;113.86;105.76;94.84 2005-04-11;101.97;4522.63;190.073;113.87;105.66;94.61 2005-04-12;102.08;4505.29;191.864;114.05;105.84;94.81 2005-04-13;102.22;4524.27;191.769;114.15;105.89;94.78 2005-04-14;102.23;4535.39;192.064;114.23;105.97;94.85 2005-04-15;102.47;4520.67;192.392;113.92;105.38;93.93 2005-04-18;102.72;4447.49;192.22;113.57;104.75;93 2005-04-19;102.82;4484.36;192.008;113.83;105.08;93.4 2005-04-20;102.73;4460.72;192.117;113.52;104.67;92.89 2005-04-21;102.71;4453.39;192.498;113.59;104.8;93.09 2005-04-22;102.72;4480.12;192.653;113.78;105.04;93.38 2005-04-25;102.71;4469.8;192.675;113.99;105.33;93.79 2005-04-26;102.68;4478.56;192.192;113.89;105.2;93.61 2005-04-27;102.76;4422.01;192.394;113.76;104.96;93.27 2005-04-28;102.83;4427.51;192.984;113.75;104.89;93.13 2005-04-29;102.77;4444.06;192.864;113.86;105.09;93.42 2005-05-02;102.74;4484.77;192.785;114.24;105.61;94.08 2005-05-03;102.84;4489.38;193.1;114.3;105.63;94.06 2005-05-04;102.71;4534.37;193.199;114.37;105.83;94.38 2005-05-05;102.71;4534.37;193.199;114.57;106.08;94.69 2005-05-06;102.61;4566.17;193.525;114.71;106.34;95.09 2005-05-09;102.58;4551.49;193.381;114.73;106.37;95.13 2005-05-10;102.68;4491.09;193.836;114.45;105.9;94.47 2005-05-11;102.82;4492.08;194.474;114.63;106.08;94.64 2005-05-12;102.77;4516.11;194.939;114.71;106.19;94.79 2005-05-13;102.78;4512.58;195.518;114.74;106.22;94.8 2005-05-16;102.78;4512.58;195.518;114.8;106.31;94.94 2005-05-17;102.78;4512.37;195.612;114.83;106.34;94.98 2005-05-18;102.9;4548.28;195.502;115.2;106.81;95.55 2005-05-19;102.84;4563.28;195.574;115.35;107.07;95.92 2005-05-20;102.75;4566.69;195.52;115.46;107.25;96.19 2005-05-23;102.73;4579.15;195.537;115.55;107.37;96.33 2005-05-24;102.91;4609.61;195.247;115.76;107.57;96.52 2005-05-25;102.99;4620.81;196.072;115.75;107.51;96.38 2005-05-26;102.91;4652.55;196.533;115.98;107.88;96.91 2005-05-27;102.92;4667.09;196.783;116.06;107.99;97.04 2005-05-30;102.94;4667.03;196.234;116.18;108.15;97.25 2005-05-31;103.19;4645.39;196.4;116.26;108.14;97.14 2005-06-01;103.19;4704.55;196;116.65;108.69;97.87 2005-06-02;103.12;4718.59;196.395;116.68;108.75;97.97 2005-06-03;103.18;4706.65;196.362;116.64;108.68;97.84 2005-06-06;103.18;4691.31;196.851;116.59;108.58;97.72 2005-06-07;103.32;4727.53;196.902;116.86;108.89;98.04 2005-06-08;103.45;4728.71;197.853;116.97;108.95;98.04 2005-06-09;103.38;4733.82;198.131;117.1;109.17;98.38 2005-06-10;103.34;4732.84;198.718;117.24;109.38;98.68 2005-06-13;103.27;4754.67;198.253;117.4;109.65;99.07 2005-06-14;103.21;4757.5;197.983;117.41;109.7;99.16 2005-06-15;102.86;4748.84;198.012;117.07;109.4;98.92 2005-06-16;102.77;4751.42;198.08;117.15;109.57;99.2 2005-06-17;102.91;4754.63;198.002;117.26;109.65;99.22 2005-06-20;102.83;4735.37;197.064;117.29;109.71;99.34 2005-06-21;103.04;4775.61;195.575;117.56;109.97;99.56 2005-06-22;103.24;4770.74;194.791;117.78;110.15;99.7 2005-06-23;102.98;4763.36;194.894;117.57;109.98;99.57 2005-06-24;102.97;4728.28;195.277;117.34;109.62;99.09 2005-06-27;102.99;4703.42;195.648;117.2;109.38;98.72 2005-06-28;102.81;4718.69;196.048;117.39;109.75;99.32 2005-06-29;102.92;4755.96;195.55;117.58;109.97;99.55 2005-06-30;103.06;4752.39;195.865;117.67;109.99;99.47 2005-07-01;103.1;4771.11;195.953;117.95;110.39;100.01 2005-07-04;103.12;4777.61;196.219;118.07;110.54;100.22 2005-07-05;103.12;4778.32;196.515;118.15;110.67;100.4 2005-07-06;103.17;4799.37;196.591;118.2;110.71;100.42 2005-07-07;103.21;4755.78;196.816;117.92;110.28;99.83 2005-07-08;103.01;4804.43;196.988;118.24;110.83;100.63 2005-07-11;102.63;4838.67;197.307;118.02;110.72;100.63 2005-07-12;102.69;4820.08;197.309;117.91;110.52;100.35 2005-07-13;102.77;4870.06;197.195;118.29;111.03;100.98 2005-07-14;102.65;4909.55;197.907;118.36;111.19;101.24 2005-07-15;102.65;4916.48;197.604;118.46;111.33;101.42 2005-07-18;102.74;4919.88;197.832;118.51;111.32;101.35 2005-07-19;102.66;4933.05;198.397;118.73;111.69;101.87 2005-07-20;102.72;4950.75;198.816;118.79;111.74;101.93 2005-07-21;102.92;4939.66;199.236;118.75;111.59;101.63 2005-07-22;103.28;4944.96;199.607;119.17;111.97;101.98 2005-07-25;103.24;4951.06;199.627;119.22;112.04;102.07 2005-07-26;103.06;4964.9;200.556;119.13;112.02;102.12 2005-07-27;103.11;4994.99;201.145;119.33;112.28;102.44 2005-07-28;103.1;5029.87;201.205;119.4;112.4;102.6 2005-07-29;102.91;5025.01;199.775;119.13;112.09;102.25 2005-08-01;102.91;5032.11;199.048;118.99;111.94;102.07 2005-08-02;102.49;5076.25;198.928;118.92;112.06;102.41 2005-08-03;102.6;5067.41;199.239;118.88;111.94;102.19 2005-08-04;102.67;5039.72;199.468;118.71;111.64;101.74 2005-08-05;102.48;5033.13;199.242;118.49;111.41;101.5 2005-08-08;102.5;5052.37;198.017;118.5;111.41;101.48 2005-08-09;102.31;5055.9;197.681;118.47;111.48;101.67 2005-08-10;102.34;5090.99;198.106;118.64;111.71;101.95 2005-08-11;102.23;5084.18;198.015;118.54;111.62;101.89 2005-08-12;102.51;5062.28;199.845;118.64;111.6;101.74 2005-08-15;102.53;5055.58;198.826;118.78;111.77;101.94 2005-08-16;102.72;5058.99;198.511;118.93;111.85;101.93 2005-08-17;102.77;5053.39;198.606;118.87;111.74;101.78 2005-08-18;102.78;5028.18;198.519;118.94;111.83;101.88 2005-08-19;102.88;5059.53;198.57;119.2;112.14;102.26 2005-08-22;102.86;5051.88;198.869;119.23;112.18;102.31 2005-08-23;102.86;5010.43;199.188;119.17;112.06;102.14 2005-08-24;102.85;4988.17;199.015;118.92;111.7;101.66 2005-08-25;102.88;4949.78;198.645;118.69;111.37;101.21 2005-08-26;102.91;4925.01;198.242;118.49;111.06;100.77 2005-08-29;102.93;4937.75;198.452;118.69;111.31;101.09 2005-08-30;102.91;4944.82;198.107;118.89;111.59;101.45 2005-08-31;103.02;4977.17;197.984;119.02;111.73;101.6 2005-09-01;103.29;5005.49;197.333;119.14;111.76;101.52 2005-09-02;103.24;4991.38;197.381;118.91;111.46;101.14 2005-09-05;103.32;4998.19;197.808;119.17;111.77;101.5 2005-09-06;103.29;5047.24;197.853;119.4;112.15;102.04 2005-09-07;103.34;5102.37;197.656;119.63;112.47;102.44 2005-09-08;103.32;5100.4;198.5;119.64;112.46;102.42 2005-09-09;103.24;5117.54;199.278;119.8;112.73;102.81 2005-09-12;103.06;5139.25;199.083;119.91;113;103.26 2005-09-13;103.18;5116.31;198.39;119.94;112.94;103.11 2005-09-14;103.25;5142.54;199.299;119.96;112.94;103.08 2005-09-15;103.22;5157.4;199.36;120.2;113.28;103.53 2005-09-16;103.07;5198.02;198.887;120.33;113.57;103.99 2005-09-19;103.17;5196.42;198.579;120.53;113.77;104.19 2005-09-20;103.26;5220.31;198.22;120.65;113.88;104.28 2005-09-21;103.44;5167.57;198.74;120.48;113.5;103.67 2005-09-22;103.5;5147.05;198.626;120.6;113.64;103.84 2005-09-23;103.22;5181.37;198.4;120.63;113.83;104.2 2005-09-26;102.92;5229.51;198.272;120.7;114.09;104.7 2005-09-27;102.82;5228.12;198.2;120.63;114.05;104.68 2005-09-28;102.77;5266.81;198.36;120.77;114.28;105.01 2005-09-29;102.63;5237.18;198.522;120.74;114.33;105.17 2005-09-30;102.75;5271.01;198.359;120.79;114.35;105.13 2005-10-03;102.66;5346.17;198.306;121.05;114.78;105.75 2005-10-04;102.68;5371.96;197.789;121.04;114.74;105.65 2005-10-05;102.77;5358.31;198.13;120.75;114.25;104.9 2005-10-06;102.72;5292.05;198.797;120.07;113.28;103.6 2005-10-07;102.59;5293.58;198.265;120.09;113.35;103.75 2005-10-10;102.62;5297.15;198.28;120.19;113.46;103.86 2005-10-11;102.61;5309.04;198.66;120.24;113.56;104.02 2005-10-12;102.63;5275.6;199.094;119.99;113.18;103.5 2005-10-13;102.49;5233.28;198.887;119.84;113.04;103.37 2005-10-14;102.51;5233.64;199.207;119.76;112.92;103.21 2005-10-17;102.44;5243.53;199.38;119.9;113.13;103.5 2005-10-18;102.44;5283.9;199.073;120.03;113.28;103.67 2005-10-19;102.54;5187.48;199.002;119.79;112.88;103.11 2005-10-20;102.52;5234.28;199.178;119.68;112.74;102.91 2005-10-21;102.5;5207.01;198.49;119.51;112.51;102.6 2005-10-24;102.41;5253.48;199.035;119.8;112.98;103.28 2005-10-25;102.1;5272.24;198.615;119.45;112.66;102.98 2005-10-26;101.76;5295.02;198.71;119.29;112.61;103.07 2005-10-27;101.72;5253.5;198.693;118.92;112.09;102.36 2005-10-28;101.57;5221.61;199.131;118.85;112.08;102.47 2005-10-31;101.34;5338.4;197.754;119.42;113.02;103.81 2005-11-01;101.27;5383.51;197.121;119.48;113.15;104.02 2005-11-02;100.98;5397.09;196.31;119.2;112.95;103.9 2005-11-03;100.85;5466.11;195.293;119.48;113.44;104.62 2005-11-04;100.51;5462.27;195.069;119.49;113.64;105.05 2005-11-07;100.62;5496.27;194.723;119.71;113.89;105.33 2005-11-08;100.67;5498.08;195.127;119.82;113.99;105.43 2005-11-09;100.4;5485.02;194.764;119.59;113.83;105.35 2005-11-10;100.49;5490.08;194.955;119.65;113.88;105.38 2005-11-11;100.55;5563.78;195.052;120.04;114.42;106.07 2005-11-14;100.6;5537.73;194.878;120.04;114.38;106 2005-11-15;100.61;5544.75;193.699;120.14;114.47;106.09 2005-11-16;100.9;5505.04;193.738;120.44;114.71;106.26 2005-11-17;100.76;5547.36;193.52;120.51;114.91;106.6 2005-11-18;100.52;5617.29;192.932;120.54;115.13;107.02 2005-11-21;100.62;5632.25;193.048;120.78;115.38;107.29 2005-11-22;100.58;5644.33;192.714;120.86;115.51;107.49 2005-11-23;100.64;5664.5;192.929;121.02;115.7;107.71 2005-11-24;100.85;5650.02;192.914;121.2;115.82;107.76 2005-11-25;100.78;5669.12;193.249;121.23;115.91;107.93 2005-11-28;100.73;5613.74;192.827;120.9;115.44;107.3 2005-11-29;100.84;5624.34;192.688;121.04;115.6;107.48 2005-11-30;100.9;5601.68;193.024;120.95;115.42;107.18 2005-12-01;100.87;5691.9;193.261;121.43;116.14;108.19 2005-12-02;100.8;5732.2;193.294;121.53;116.34;108.49 2005-12-05;100.62;5730.66;192.898;121.25;116.03;108.13 2005-12-06;100.93;5747.1;193.394;121.48;116.19;108.22 2005-12-07;100.85;5732.14;193.142;121.41;116.15;108.21 2005-12-08;101.02;5712.21;193.794;121.31;115.89;107.76 2005-12-09;100.95;5716.48;194.801;121.29;115.93;107.86 2005-12-12;101;5714.89;195.494;121.32;115.91;107.78 2005-12-13;100.92;5722.66;195.716;121.46;116.15;108.14 2005-12-14;100.58;5681.13;195.894;121.01;115.66;107.62 2005-12-15;100.73;5639.56;196.027;121.11;115.72;107.65 2005-12-16;100.85;5663.82;196.605;121.38;116;107.94 2005-12-19;100.84;5692.1;198.335;121.5;116.14;108.09 2005-12-20;100.91;5682.81;198.265;121.74;116.45;108.51 2005-12-21;100.97;5707.41;199.654;122.01;116.84;109.03 2005-12-22;100.99;5686.73;199.069;122.04;116.86;109.04 2005-12-23;101.03;5674.04;198.936;122.11;116.92;109.1 2005-12-26;101.03;5674.04;198.936;122.12;116.94;109.13 2005-12-27;101.1;5711.45;199.494;122.2;116.98;109.11 2005-12-28;101.43;5721.06;199.793;122.48;117.19;109.22 2005-12-29;101.44;5765.29;200.279;122.65;117.44;109.57 2005-12-30;101.38;5742.41;200.016;122.48;117.21;109.27 2006-01-02;101.38;5742.41;200.016;122.5;117.24;109.32 2006-01-03;101.3;5780.41;199.956;122.42;117.22;109.34 2006-01-04;101.28;5851.15;200.406;122.59;117.46;109.65 2006-01-05;101.26;5837.79;199.832;122.51;117.35;109.51 2006-01-06;101.22;5850.81;200.22;122.53;117.42;109.65 2006-01-09;101.31;5849.79;199.536;122.79;117.74;110.05 2006-01-10;101.23;5811.98;199.794;122.61;117.52;109.78 2006-01-11;101.2;5876.23;198.562;122.83;117.86;110.24 2006-01-12;101.42;5910.93;198.4;123.18;118.23;110.62 2006-01-13;101.29;5914.65;196.879;123.07;118.12;110.5 2006-01-16;101.3;5939.35;196.687;123.12;118.17;110.54 2006-01-17;101.37;5903.46;196.695;123.01;117.94;110.18 2006-01-18;101.55;5861.67;197.241;122.79;117.52;109.51 2006-01-19;101.3;5890.47;198.937;122.86;117.78;110.01 2006-01-20;101.23;5839.37;197.589;122.53;117.32;109.39 2006-01-23;101.12;5839.84;198.674;122.08;116.72;108.61 2006-01-24;101.04;5834.18;197.837;122.09;116.78;108.73 2006-01-25;100.91;5826.92;197.2;121.98;116.72;108.74 2006-01-26;100.79;5875.77;198.118;122.21;117.14;109.38 2006-01-27;100.71;5904.32;198.595;122.56;117.72;110.26 2006-01-30;100.73;5912.75;198.413;122.81;118.05;110.67 2006-01-31;100.71;5928.95;198.977;122.79;118;110.6 2006-02-01;100.6;5948.78;199.073;122.76;118.06;110.75 2006-02-02;100.56;5917.74;198.889;122.57;117.78;110.37 2006-02-03;100.67;5954.72;199.406;122.79;118.02;110.61 2006-02-06;100.72;5954.78;199.349;122.97;118.24;110.88 2006-02-07;100.74;5952.6;199.315;122.89;118.09;110.66 2006-02-08;100.73;5947.96;200.039;122.82;117.99;110.53 2006-02-09;100.77;5979.71;200.014;123.08;118.34;110.97 2006-02-10;100.86;5973.56;199.798;123.17;118.41;111.03 2006-02-13;100.79;5991.82;200.291;123.09;118.32;110.9 2006-02-14;100.81;5988.75;200.288;123.34;118.66;111.38 2006-02-15;100.85;5929.55;200.714;123.22;118.47;111.13 2006-02-16;100.76;6006.64;200.742;123.47;118.89;111.74 2006-02-17;100.85;6014.36;201.061;123.65;119.07;111.89 2006-02-20;100.96;6039.98;201.893;123.72;119.09;111.86 2006-02-21;100.85;6078.54;202.412;123.75;119.21;112.06 2006-02-22;100.86;6105.55;203.142;124.03;119.6;112.59 2006-02-23;100.71;6068.62;204.388;123.75;119.3;112.27 2006-02-24;100.59;6051.98;203.946;123.84;119.48;112.58 2006-02-27;100.41;6084.58;204.757;123.94;119.72;113 2006-02-28;100.52;6012.26;205.105;123.6;119.13;112.11 2006-03-01;100.32;6075.75;205.299;123.68;119.36;112.51 2006-03-02;100.05;6050.42;204.269;123.29;118.96;112.09 2006-03-03;100.05;6061.05;204.049;123.15;118.75;111.8 2006-03-06;100.04;6063.84;204.301;123.07;118.63;111.62 2006-03-07;99.99;6021.37;203.61;122.98;118.52;111.5 2006-03-08;99.85;5995.95;203.895;122.69;118.18;111.1 2006-03-09;99.57;6017.18;204.137;122.69;118.31;111.39 2006-03-10;99.38;6095.15;203.531;122.9;118.73;112.05 2006-03-13;99.35;6145.67;203.735;123.06;118.98;112.41 2006-03-14;99.53;6142.41;203.289;123.15;119.03;112.39 2006-03-15;99.52;6131.56;203.285;123.18;119.09;112.5 2006-03-16;99.75;6135.65;202.83;123.35;119.17;112.47 2006-03-17;99.5;6162.17;203.211;123.27;119.2;112.63 2006-03-20;99.64;6175.51;203.059;123.42;119.32;112.71 2006-03-21;99.52;6173.81;202.745;123.44;119.4;112.85 2006-03-22;99.62;6182.01;202.533;123.63;119.61;113.09 2006-03-23;99.4;6155.37;203.018;123.57;119.63;113.24 2006-03-24;99.36;6172.46;202.811;123.59;119.68;113.31 2006-03-27;99.37;6129.74;202.719;123.44;119.45;112.99 2006-03-28;99.07;6125.28;203.532;122.91;118.87;112.34 2006-03-29;98.92;6130.95;202.891;123.05;119.17;112.85 2006-03-30;98.94;6169.12;203.467;123.09;119.22;112.89 2006-03-31;98.96;6163.39;202.711;123.19;119.33;113.02 2006-04-03;98.64;6206.34;202.393;123.13;119.44;113.33 2006-04-04;98.69;6190.11;202.491;122.95;119.15;112.92 2006-04-05;98.6;6219.6;202.622;122.94;119.21;113.05 2006-04-06;98.54;6229.23;202.868;122.98;119.32;113.25 2006-04-07;98.61;6232.42;202.764;123.1;119.43;113.36 2006-04-10;98.61;6232.52;203.412;123.12;119.47;113.4 2006-04-11;98.77;6173.13;204.634;122.96;119.11;112.81 2006-04-12;98.72;6154.77;204.175;122.81;118.93;112.59 2006-04-13;98.36;6178.99;203.843;122.56;118.78;112.58 2006-04-14;98.36;6178.99;203.843;122.57;118.8;112.6 2006-04-17;98.36;6178.99;203.843;122.18;118.26;111.85 2006-04-18;98.29;6147.98;203.701;122.29;118.44;112.15 2006-04-19;98.23;6215.32;203.905;122.48;118.76;112.62 2006-04-20;98.18;6241.49;204.771;122.74;119.13;113.12 2006-04-21;98.09;6271.76;204.765;122.77;119.22;113.28 2006-04-24;98.09;6261.14;205.1;122.63;118.99;112.94 2006-04-25;97.89;6235.05;204.988;122.35;118.7;112.64 2006-04-26;97.77;6264.42;204.701;122.46;118.91;112.96 2006-04-27;97.64;6269.96;205.289;122.29;118.72;112.74 2006-04-28;97.76;6251.53;205.706;121.97;118.21;111.99 2006-05-01;97.76;6251.53;205.706;121.82;118.01;111.72 2006-05-02;97.68;6271.5;206.539;121.96;118.27;112.12 2006-05-03;97.49;6197.04;206.82;121.63;117.87;111.67 2006-05-04;97.47;6215.75;207.077;121.57;117.82;111.61 2006-05-05;97.62;6285.98;207.163;121.95;118.31;112.22 2006-05-08;97.6;6324.92;207.035;122.18;118.63;112.66 2006-05-09;97.46;6340.86;206.588;121.99;118.44;112.47 2006-05-10;97.42;6332.07;206.492;121.93;118.35;112.32 2006-05-11;97.04;6325.13;205.955;121.35;117.71;111.6 2006-05-12;96.94;6212.36;205.356;120.52;116.55;110.04 2006-05-15;97.04;6129.67;205.366;120.44;116.31;109.63 2006-05-16;97.28;6149.84;205.232;120.68;116.49;109.73 2006-05-17;97.07;5977.6;204.957;119.9;115.46;108.43 2006-05-18;97.24;5919.83;204.994;119.77;115.11;107.83 2006-05-19;97.44;5930.78;205.327;120.15;115.55;108.33 2006-05-22;97.72;5778.58;205.014;119.62;114.56;106.8 2006-05-23;97.71;5889.25;205.254;119.95;115.04;107.44 2006-05-24;97.83;5824.15;204.628;120;115.02;107.35 2006-05-25;97.83;5824.15;204.628;120.2;115.32;107.78 2006-05-26;97.85;5976.62;203.858;120.93;116.38;109.22 2006-05-29;97.84;5987.22;204.417;120.91;116.36;109.18 2006-05-30;97.78;5869.59;204.05;120.13;115.23;107.63 2006-05-31;97.79;5924.57;205.047;120.37;115.58;108.11 2006-06-01;97.65;5933.68;204.302;120.45;115.81;108.52 2006-06-02;97.87;5975.32;204.283;120.72;116.05;108.73 2006-06-05;97.87;5975.32;204.283;120.41;115.59;108.07 2006-06-06;97.73;5843.39;204.546;119.98;115.02;107.36 2006-06-07;97.73;5876.43;204.231;120.06;115.09;107.42 2006-06-08;97.84;5717.72;203.953;119.72;114.49;106.54 2006-06-09;97.97;5789.23;204.723;119.98;114.82;106.93 2006-06-12;98.05;5709.34;203.965;119.76;114.43;106.34 2006-06-13;98.17;5573.99;202.815;119.25;113.54;105.03 2006-06-14;98.26;5586.67;202.531;119.29;113.59;105.08 2006-06-15;98.05;5708.48;201.641;119.74;114.41;106.34 2006-06-16;98.07;5691.8;201.465;119.85;114.54;106.51 2006-06-19;97.83;5738.62;200.825;119.83;114.62;106.7 2006-06-20;97.71;5760.81;200.135;119.71;114.53;106.62 2006-06-21;97.63;5780.33;199.874;119.78;114.68;106.86 2006-06-22;97.47;5823.25;199.571;119.86;114.89;107.22 2006-06-23;97.22;5826.43;199.729;119.7;114.8;107.24 2006-06-26;97.15;5811.92;199.641;119.68;114.8;107.27 2006-06-27;97.06;5772.23;198.946;119.43;114.46;106.81 2006-06-28;97.08;5788.21;198.83;119.54;114.61;107.02 2006-06-29;97.13;5870.06;199.067;120.16;115.52;108.26 2006-06-30;97.07;5955.64;199.073;120.23;115.65;108.45 2006-07-03;97.05;6008.19;199.079;120.44;115.98;108.9 2006-07-04;97.02;6019.99;198.047;120.53;116.12;109.1 2006-07-05;96.86;5967.2;197.717;120.2;115.71;108.61 2006-07-06;96.94;6000.49;197.679;120.37;115.91;108.84 2006-07-07;97.01;5965.8;197.766;120.22;115.63;108.4 2006-07-10;96.99;6001.6;197.908;120.47;116;108.91 2006-07-11;97.1;5978.63;197.746;120.47;115.92;108.74 2006-07-12;97.06;6005.42;197.623;120.45;115.9;108.71 2006-07-13;97.11;5914.27;197.156;119.96;115.12;107.6 2006-07-14;97.26;5853.24;197.73;119.89;114.89;107.18 2006-07-17;97.32;5839.99;198.376;119.99;114.98;107.26 2006-07-18;97.21;5807.34;197.961;119.87;114.86;107.15 2006-07-19;97.29;5915.3;197.268;120.47;115.69;108.25 2006-07-20;97.3;5962.95;197.562;120.57;115.82;108.38 2006-07-21;97.35;5931.2;197.771;120.36;115.45;107.82 2006-07-24;97.42;6046.42;198.42;121.06;116.45;109.15 2006-07-25;97.44;6050.09;198.737;121.25;116.71;109.52 2006-07-26;97.36;6076.37;199.402;121.26;116.77;109.64 2006-07-27;97.49;6110.25;199.962;121.35;116.84;109.65 2006-07-28;97.58;6173.5;199.124;121.7;117.3;110.25 2006-07-31;97.56;6175.15;200.012;121.69;117.29;110.22 2006-08-01;97.56;6175.15;200.012;121.67;117.23;110.12 2006-08-02;97.61;6151.09;199.273;121.7;117.26;110.15 2006-08-03;97.46;6083.68;198.423;121.48;117.02;109.92 2006-08-04;97.59;6141.98;199.44;121.69;117.23;110.11 2006-08-07;97.61;6068.12;198.944;121.43;116.82;109.52 2006-08-08;97.64;6071.48;199.776;121.56;116.98;109.73 2006-08-09;97.65;6137.27;199.847;121.67;117.14;109.93 2006-08-10;97.68;6105.91;200.065;121.84;117.36;110.22 2006-08-11;97.66;6116.27;200.03;121.79;117.3;110.15 2006-08-14;97.5;6165.49;199.624;121.9;117.55;110.56 2006-08-15;97.64;6257.76;199.977;122.37;118.16;111.32 2006-08-16;97.88;6285.77;199.772;122.66;118.46;111.63 2006-08-17;97.96;6304.05;199.368;122.83;118.66;111.85 2006-08-18;98.06;6283.52;199.87;122.97;118.79;111.99 2006-08-21;98.27;6264.61;199.477;122.91;118.56;111.54 2006-08-22;98.59;6284.29;199.087;123.46;119.17;112.22 2006-08-23;98.46;6282.94;199.626;123.3;118.98;112.01 2006-08-24;98.53;6295.65;199.172;123.4;119.08;112.1 2006-08-25;98.54;6299.84;199.043;123.5;119.21;112.26 2006-08-28;98.52;6311.2;199.645;123.49;119.21;112.25 2006-08-29;98.46;6349.66;199.362;123.57;119.38;112.54 2006-08-30;98.54;6367.2;199.599;123.62;119.4;112.51 2006-08-31;98.63;6357.87;200.35;123.79;119.58;112.7 2006-09-01;98.75;6377.78;200.654;124.06;119.9;113.08 2006-09-04;98.78;6406.94;200.134;124.21;120.09;113.33 2006-09-05;98.73;6404.22;200.424;124.23;120.15;113.45 2006-09-06;98.56;6366.52;200.04;123.85;119.68;112.86 2006-09-07;98.6;6327.77;199.681;123.74;119.46;112.51 2006-09-08;98.73;6359.73;200.264;124.04;119.83;112.95 2006-09-11;98.6;6305.08;199.431;123.64;119.3;112.27 2006-09-12;98.63;6378.29;198.796;124.04;119.87;113.06 2006-09-13;98.81;6397.76;198.643;124.42;120.31;113.56 2006-09-14;98.73;6376.73;198.984;124.3;120.16;113.39 2006-09-15;98.78;6411.43;198.805;124.65;120.62;113.99 2006-09-18;98.55;6435.75;198.637;124.41;120.44;113.84 2006-09-19;98.68;6419.24;198.466;124.43;120.36;113.66 2006-09-20;98.85;6498.32;198.28;124.78;120.78;114.13 2006-09-21;98.9;6524.18;198.239;124.97;120.99;114.37 2006-09-22;99.09;6464.5;198.652;124.59;120.31;113.31 2006-09-25;99.3;6446.96;198.028;124.83;120.54;113.55 2006-09-26;99.35;6530.12;198.685;125.26;121.16;114.38 2006-09-27;99.23;6553.68;198.438;125.37;121.4;114.77 2006-09-28;99.23;6558.31;198.376;125.49;121.57;115.02 2006-09-29;99.1;6567.56;199.105;125.51;121.66;115.18 2006-10-02;99.1;6534.75;197.873;125.27;121.3;114.68 2006-10-03;99.02;6538.83;198.054;125.2;121.24;114.64 2006-10-04;99.21;6582.51;197.71;125.72;121.88;115.42 2006-10-05;99.18;6629.85;198.354;125.97;122.28;116 2006-10-06;99.12;6636.58;197.917;125.95;122.3;116.07 2006-10-09;99.1;6656.83;198.09;126.01;122.38;116.17 2006-10-10;98.9;6716.92;197.826;126.13;122.69;116.71 2006-10-11;98.94;6724.09;198.4;126.2;122.75;116.75 2006-10-12;98.81;6752.66;199.048;126.3;122.99;117.16 2006-10-13;98.69;6738.76;199.396;126.33;123.12;117.42 2006-10-16;98.65;6726.39;198.76;126.33;123.13;117.47 2006-10-17;98.77;6656.12;199.146;126.12;122.73;116.84 2006-10-18;98.71;6717.33;198.725;126.35;123.1;117.38 2006-10-19;98.55;6724.17;198.837;126.08;122.81;117.06 2006-10-20;98.56;6741.73;198.486;126.12;122.87;117.13 2006-10-23;98.38;6779;198.244;126.26;123.18;117.66 2006-10-24;98.39;6755.23;198.308;126.28;123.2;117.67 2006-10-25;98.32;6774.49;198.648;126.32;123.29;117.83 2006-10-26;98.36;6770.31;198.409;126.35;123.31;117.83 2006-10-27;98.58;6788.27;198.462;126.39;123.2;117.52 2006-10-30;98.75;6755.83;198.362;126.38;123.08;117.26 2006-10-31;99.03;6700.4;198.676;126.49;123.05;117.08 2006-11-01;99.27;6733.15;198.385;126.74;123.25;117.21 2006-11-02;99.25;6756.27;198.784;126.76;123.29;117.27 2006-11-03;99.21;6796.92;198.84;126.98;123.64;117.76 2006-11-06;99.16;6870.58;199.786;127.32;124.17;118.53 2006-11-07;99.52;6897.22;200.575;127.61;124.39;118.64 2006-11-08;99.4;6856.47;201.296;127.48;124.27;118.55 2006-11-09;99.49;6852.48;201.978;127.45;124.15;118.3 2006-11-10;99.58;6834.18;201.015;127.39;124;118.05 2006-11-13;99.44;6844.59;200.948;127.37;124.05;118.18 2006-11-14;99.51;6834.88;201.494;127.55;124.27;118.46 2006-11-15;99.34;6881.16;201.24;127.63;124.49;118.84 2006-11-16;99.36;6881.77;201.184;127.67;124.53;118.9 2006-11-17;99.41;6850.03;200.834;127.56;124.32;118.57 2006-11-20;99.56;6858.84;200.859;127.62;124.31;118.46 2006-11-21;99.55;6869.8;200.479;127.67;124.4;118.59 2006-11-22;99.57;6875.84;200.188;127.59;124.28;118.42 2006-11-23;99.48;6856.32;200.059;127.34;123.99;118.08 2006-11-24;99.56;6774.18;200.033;127.04;123.46;117.27 2006-11-27;99.43;6678.73;200.076;126.56;122.79;116.39 2006-11-28;99.5;6635.46;200.204;126.59;122.76;116.3 2006-11-29;99.46;6721.62;200.038;126.97;123.37;117.19 2006-11-30;99.5;6663.75;200.234;126.77;123.05;116.72 2006-12-01;99.48;6621.07;200.365;126.6;122.77;116.31 2006-12-04;99.43;6664.6;202.789;126.85;123.16;116.88 2006-12-05;99.31;6645.89;202.921;126.71;123.06;116.83 2006-12-06;99.26;6693.74;202.689;126.79;123.2;117.04 2006-12-07;99.13;6743.73;202.655;126.82;123.32;117.25 2006-12-08;98.97;6724.1;204.056;126.62;123.13;117.07 2006-12-11;98.68;6766.03;204.551;126.68;123.37;117.54 2006-12-12;98.69;6818.9;205.336;126.81;123.54;117.74 2006-12-13;98.7;6829.92;204.892;126.96;123.75;118.03 2006-12-14;98.73;6899.15;204.31;127.41;124.41;118.95 2006-12-15;98.66;6908.09;206.698;127.51;124.62;119.29 2006-12-18;98.36;6939.71;205.714;127.4;124.59;119.38 2006-12-19;98.28;6896.88;205.926;127.09;124.17;118.82 2006-12-20;98.46;6907.6;204.947;127.34;124.44;119.1 2006-12-21;98.45;6914.1;207.322;127.28;124.35;118.98 2006-12-22;98.52;6879.49;205.834;127.21;124.2;118.73 2006-12-25;98.52;6879.49;205.834;127.2;124.19;118.71 2006-12-26;98.52;6879.49;205.834;127.28;124.3;118.87 2006-12-27;98.41;6950.95;207.142;127.64;124.89;119.75 2006-12-28;98.26;6936.82;206.926;127.41;124.66;119.51 2006-12-29;98.37;6929.18;206.511;127.47;124.65;119.42 2007-01-01;98.37;6929.18;206.511;127.47;124.65;119.42 2007-01-02;98.37;6929.18;206.511;127.52;124.73;119.53 2007-01-03;98.49;7032.74;206.762;127.97;125.29;120.19 2007-01-04;98.49;7033.64;207.05;128.02;125.36;120.3 2007-01-05;98.19;7015.51;206.932;127.65;124.99;119.92 2007-01-08;98.04;6983.72;206.66;127.5;124.83;119.76 2007-01-09;97.9;7006.67;206.787;127.53;124.94;119.98 2007-01-10;97.77;6996.38;206.393;127.38;124.79;119.82 2007-01-11;97.79;7091.34;206.606;127.76;125.36;120.62 2007-01-12;97.6;7129.93;206.372;127.78;125.54;120.99 2007-01-15;97.42;7188.17;207.16;127.9;125.8;121.42 2007-01-16;97.68;7171.38;208.071;128.06;125.87;121.39 2007-01-17;97.85;7197.25;207.296;128.2;125.97;121.43 2007-01-18;97.83;7197.03;206.91;128.23;126.01;121.49 2007-01-19;98.01;7232.38;207.177;128.55;126.39;121.92 2007-01-22;98.1;7200.17;207.314;128.56;126.31;121.74 2007-01-23;98.12;7196.52;207.732;128.46;126.17;121.54 2007-01-24;98.02;7240.03;208.422;128.78;126.71;122.36 2007-01-25;97.93;7227.5;208.637;128.44;126.26;121.76 2007-01-26;97.85;7158.49;209.291;128.31;126.1;121.6 2007-01-29;97.69;7211.84;210.069;128.35;126.23;121.82 2007-01-30;97.68;7242.25;211.797;128.49;126.45;122.13 2007-01-31;97.65;7241.78;211.807;128.43;126.37;122.03 2007-02-01;97.75;7307.27;211.917;128.71;126.75;122.53 2007-02-02;97.89;7340.04;212.371;128.99;127.08;122.92 2007-02-05;98.01;7340.21;213.021;129.11;127.17;122.97 2007-02-06;97.98;7346.91;212.56;129.09;127.17;122.98 2007-02-07;97.91;7368.52;211.441;129.07;127.17;123.01 2007-02-08;97.95;7323.81;212.181;129.16;127.23;123.04 2007-02-09;97.86;7371.58;211.915;129.18;127.32;123.22 2007-02-12;97.85;7341.4;211.344;129.06;127.14;122.95 2007-02-13;97.71;7323.91;211.642;129.04;127.18;123.09 2007-02-14;97.73;7374.17;212.04;129.25;127.48;123.5 2007-02-15;97.85;7385.15;211.587;129.35;127.56;123.54 2007-02-16;97.79;7407.77;211.206;129.32;127.55;123.55 2007-02-19;97.7;7414.4;209.321;129.25;127.5;123.52 2007-02-20;97.66;7390.19;210.328;129.28;127.53;123.58 2007-02-21;97.77;7317.24;211.033;129.25;127.41;123.35 2007-02-22;97.65;7345.89;210.894;129.29;127.55;123.62 2007-02-23;97.71;7340.8;210.969;129.18;127.34;123.28 2007-02-26;97.87;7315.13;210.392;129.32;127.44;123.32 2007-02-27;98.02;7058.26;210.309;128.33;125.78;120.85 2007-02-28;98.05;6974.44;210.251;127.99;125.26;120.1 2007-03-01;98.14;6960.79;210.124;127.95;125.11;119.82 2007-03-02;98.04;6977.27;209.947;127.69;124.77;119.35 2007-03-05;98.12;6877.09;210.859;127.28;124.06;118.29 2007-03-06;98.03;6957.55;209.947;127.67;124.72;119.29 2007-03-07;97.85;7040.07;209.818;127.72;124.89;119.58 2007-03-08;97.74;7124.53;210.285;128.19;125.65;120.69 2007-03-09;97.62;7126.88;210.849;128.22;125.77;120.92 2007-03-12;97.8;7104.3;210.593;128.28;125.73;120.77 2007-03-13;97.85;7049.26;210.289;127.9;125.1;119.82 2007-03-14;97.95;6853.21;209.648;127.26;124.08;118.36 2007-03-15;97.97;6955.09;211.318;127.67;124.7;119.23 2007-03-16;97.92;6962.95;211.485;127.51;124.48;118.92 2007-03-19;97.7;7064.57;211.994;127.87;125.15;119.97 2007-03-20;97.71;7094;212.626;128.12;125.51;120.48 2007-03-21;97.65;7146.91;213.954;128.43;126.02;121.24 2007-03-22;97.65;7247.45;215.188;128.71;126.46;121.85 2007-03-23;97.56;7259.77;215.265;128.78;126.63;122.15 2007-03-26;97.54;7204.92;215.319;128.61;126.37;121.8 2007-03-27;97.56;7170.75;215.093;128.48;126.16;121.49 2007-03-28;97.65;7100.32;214.988;128.2;125.68;120.77 2007-03-29;97.43;7179.96;215.708;128.47;126.2;121.6 2007-03-30;97.39;7183.53;215.32;128.51;126.28;121.72 2007-04-02;97.39;7173.11;215.557;128.39;126.11;121.48 2007-04-03;97.27;7247.63;216.799;128.72;126.68;122.36 2007-04-04;97.29;7257.11;216.46;128.89;126.91;122.66 2007-04-05;97.22;7293.49;216.696;128.86;126.91;122.69 2007-04-06;97.22;7293.49;216.696;128.86;126.9;122.68 2007-04-09;97.22;7293.49;216.696;129.13;127.29;123.23 2007-04-10;97.11;7339.8;216.676;129.07;127.26;123.23 2007-04-11;97.13;7332.14;216.39;129.08;127.25;123.19 2007-04-12;97.05;7309.08;216.506;128.96;127.13;123.07 2007-04-13;96.8;7365.76;216.606;128.94;127.26;123.37 2007-04-16;96.84;7435.69;216.811;129.32;127.8;124.12 2007-04-17;96.95;7407.32;216.652;129.35;127.77;124.01 2007-04-18;97.14;7446.56;215.978;129.49;127.86;124.03 2007-04-19;97;7447.89;216.005;129.26;127.59;123.69 2007-04-20;96.91;7558.24;216.01;129.71;128.31;124.75 2007-04-23;96.98;7585.84;215.435;129.86;128.47;124.91 2007-04-24;97.05;7546.47;214.908;129.65;128.1;124.34 2007-04-25;97.01;7613.98;214.439;129.88;128.48;124.9 2007-04-26;96.91;7655.55;214.661;129.95;128.66;125.2 2007-04-27;96.85;7609.91;214.39;129.76;128.38;124.82 2007-04-30;97.05;7620.11;215.724;130.01;128.57;124.92 2007-05-01;97.05;7620.11;215.724;130.18;128.8;125.24 2007-05-02;96.82;7634.1;216.145;130.07;128.83;125.46 2007-05-03;96.68;7594.94;216.592;129.95;128.75;125.46 2007-05-04;96.68;7644.82;216.782;130.09;128.97;125.75 2007-05-07;96.61;7647.57;216.872;130.14;129.08;125.94 2007-05-08;96.74;7587.88;215.962;130.24;129.12;125.93 fBasics/data/PensionFund.csv0000644000176200001440000013062713202116740015507 0ustar liggesusers%Y-%m-%d;SBI;SPI;SII;LMI;MPI;ALT;LPP25;LPP40;LPP60 2005-11-01;-0.000612745;0.008414595;-0.003190926;-0.001108882;0.001548062;-0.002572971;-0.000130008;0.00019998;0.000809672 2005-11-02;-0.002762009;0.002519342;-0.004117638;-0.001175939;0.000342876;-0.001141604;-0.001561421;-0.001120404;-0.00046973 2005-11-03;-0.001153092;0.012707292;-0.005209409;-0.000992456;0.010502959;0.005007442;0.001541418;0.003317548;0.005731589 2005-11-04;-0.00323575;-0.000702757;-0.001127165;-0.001198528;0.011679558;0.009482677;0.000439969;0.002421248;0.004838735 2005-11-07;0.00131097;0.006205226;-0.001795839;0.000360366;0.002709618;0.004723952;0.001638182;0.002246611;0.003012363 2005-11-08;0.000539312;0.00032926;0.002103374;0.00232704;0.000346843;0.000853619;0.001087309;0.000962708;0.000828043 2005-11-09;-0.002545021;-0.0023782;-0.001897972;-0.002039593;0.001692726;0.003602934;-0.001366809;-0.000625158;0.000226607 2005-11-10;0.001003358;0.000922087;0.001026378;0.00143984;-0.000171668;0.002422505;0.001067667;0.001061545;0.001024015 2005-11-11;0.000616951;0.013334906;0.000461527;0.000652177;0.007348639;0.010709585;0.003166356;0.004748253;0.006816392 2005-11-14;0.000693615;-0.004693064;-0.000871951;-0.000695799;1.01E-05;-0.001002283;-0.000387788;-0.0005923;-0.000948567 2005-11-15;0.000154071;0.001266865;-0.006073414;0.001779738;-0.000148583;-0.001434784;1.99E-05;-1.97E-05;-3.91E-05 2005-11-16;0.002999656;-0.007187498;0.000206484;0.002773424;0.003871208;0.000191623;0.001867915;0.001549141;0.000997477 2005-11-17;-0.001306436;0.007658103;-0.001136188;0.000673362;0.005170833;0.005588204;0.001200379;0.00232414;0.003833945 2005-11-18;-0.002232573;0.012527202;-0.003053438;-0.002104413;0.005676968;0.005405238;0.000406413;0.001955573;0.004071465 2005-11-21;0.001155402;0.002659666;0.000621794;0.002349427;0.001677965;0.002109444;0.001663581;0.001765572;0.001918234 2005-11-22;-0.000230974;0.002142494;-0.001762755;0.000883765;0.003480177;0.005291468;0.000988914;0.001723328;0.002609857 2005-11-23;0.000692761;0.003567128;0.001140961;-0.000315378;0.001870197;0.003493888;0.001047183;0.001456636;0.001967385 2005-11-24;0.002075407;-0.002559544;-0.00010367;0.001707429;0.000505441;-0.001649214;0.000996768;0.000556676;-3.85E-05 2005-11-25;-0.000614487;0.003374818;0.001760929;0.000681961;0.002518483;0.002451201;0.000808527;0.001248951;0.001867432 2005-11-28;-0.000307385;-0.009816739;-0.002175716;-8.52E-07;-0.008162671;-0.005523342;-0.002457186;-0.003643881;-0.005264693 2005-11-29;0.001228973;0.001886444;-0.000726292;-0.001980281;0.002193327;0.005370683;0.000760498;0.001369234;0.002018515 2005-11-30;0.000613921;-0.004037055;0.001711131;-0.000366191;-0.004253317;-0.004359738;-0.000879069;-0.001711835;-0.002782557 2005-12-01;-0.000230176;0.015977559;0.001242622;0.000348006;0.014596229;0.010461728;0.003895603;0.00614894;0.009178131 2005-12-02;-0.000537284;0.00705529;0.000155219;-5.65E-05;0.004264267;0.002115979;0.001003493;0.001711064;0.002728489 2005-12-05;-0.001536689;-0.000268694;-0.002019732;-0.001625599;-0.005194156;-0.002476306;-0.0020277;-0.002324259;-0.002680556 2005-12-06;0.00307102;0.002864672;0.002536956;0.002149458;-0.001485749;-0.002711165;0.001781839;0.001060688;0.00022046 2005-12-07;-0.000690158;-0.002606446;-0.001293561;-0.000948407;0.001778648;0.000431817;-0.000550948;-0.000301549;-3.83E-05 2005-12-08;0.00176279;-0.003482945;0.003359784;0.001752929;-0.009195043;-0.006490018;-0.00050202;-0.002113394;-0.004129856 2005-12-09;-0.000612792;0.000747242;0.005198293;-0.002691115;0.003052889;0.004749016;0.000265807;0.000935508;0.001730853 2005-12-12;0.000765931;-0.000278182;0.003535836;0.000257145;-0.00267821;-0.001505105;0.000167324;-0.000331226;-0.000941982 2005-12-13;-0.000689312;0.001358683;0.001175839;0.000632011;0.007700805;0.002986434;0.001258951;0.002102395;0.003206793 2005-12-14;-0.003223086;-0.007283576;0.000868211;0.00224813;-0.006470125;-0.003808002;-0.00230272;-0.003067472;-0.004014912 2005-12-15;0.00145935;-0.007344108;0.000714432;-7.05E-05;0.002986747;0.004739377;0.000797696;0.00103328;0.001086962 2005-12-16;0.001303931;0.004292528;0.002903499;0.000852779;0.001570742;0.000456166;0.001505024;0.001518736;0.001613833 2005-12-19;0.000153292;0.004980672;0.008811522;0.000457343;0.000270519;4.89E-05;0.001247551;0.00113754;0.001151146 2005-12-20;0.000689523;-0.00163342;-0.000403429;-0.000318402;0.008696206;0.008467319;0.00176552;0.002969002;0.004314578 2005-12-21;0.000689048;0.004319502;0.006986533;-0.001193163;0.009555658;0.008563446;0.002661997;0.003945007;0.005540444 2005-12-22;0.000306091;-0.00362994;-0.002909312;0.001204272;0.000908941;-0.000361747;1.95E-05;-4.83E-05;-0.00019938 2005-12-23;0.000458961;-0.002234004;-0.00065325;0.001265583;0.001335563;0.002723089;0.000654613;0.000810318;0.000920614 2005-12-26;0;0;0;6.00E-05;0.001399134;0.003066865;0.000419899;0.000751851;0.001118781 2005-12-27;0.000993694;0.006571546;0.002760838;0.001125977;-0.005278183;0.000431264;0.000751472;0.000327553;-0.000113717 2005-12-28;0.003355964;0.001681171;0.001502705;0.000462542;-0.000996576;-0.000946489;0.001501253;0.001001261;0.000350586 2005-12-29;7.61E-05;0.007701353;0.002449573;-0.000321804;0.004767873;0.004371403;0.001635164;0.002460381;0.00359352 2005-12-30;-0.000456934;-0.003976473;-0.001299026;0.000431143;-0.004250871;-2.47E-06;-0.001002194;-0.001363995;-0.001908632 2006-01-02;0;0;0;1.66E-05;0.000561133;0.001215944;0.00016548;0.000297932;0.000444413 2006-01-03;-0.000533354;0.006595632;-0.000300015;0.000334917;-0.000355364;-0.003715627;1.95E-05;-7.69E-05;9.45E-06 2006-01-04;-7.62E-05;0.012163609;0.002247922;0.002039427;0.001228654;0.001783573;0.001847585;0.002227044;0.002945121 2006-01-05;-0.000152451;-0.002285923;-0.002898263;0.000506401;-0.00141687;-0.00136291;-0.000602521;-0.000805771;-0.001093968 2006-01-06;-0.000381228;0.002227813;0.001949757;-5.88E-05;0.003312961;-8.41E-05;0.000553944;0.000844125;0.001291886 2006-01-09;0.001143249;-0.00017435;-0.003402045;0.000263664;0.007228328;0.009143196;0.001844267;0.003025315;0.004325551 2006-01-10;-0.00060957;-0.006484459;0.001252097;-0.001388653;-0.002024178;-0.000593047;-0.001280919;-0.001540235;-0.001981789 2006-01-11;-0.000228685;0.010994095;-0.006175494;-0.000751219;0.004694347;0.003892447;0.000960843;0.002094522;0.003631846 2006-01-12;0.002208431;0.00588778;-0.000806127;0.001737927;0.002749454;0.006738779;0.002548068;0.003119294;0.003796029 2006-01-13;-0.001217842;0.000629145;-0.007690789;0.001146523;-0.002405188;-0.001747116;-0.001161811;-0.001200778;-0.001223253 2006-01-16;0.000380735;0.004167376;-0.000965521;-0.000126656;-0.000776466;-0.000933092;0.000193729;0.000162094;0.000196195 2006-01-17;0.000761035;-0.00606108;0;0.000853881;-0.005753658;-0.009087876;-0.001337495;-0.002720934;-0.004437794 2006-01-18;0.001748186;-0.007104074;0.002792376;-0.000182261;-0.012487147;-0.010516779;-0.00201932;-0.004157731;-0.006873332 2006-01-19;-0.00228085;0.004901245;0.00858201;-0.002176146;0.01121058;0.009260265;0.00165071;0.003430897;0.005727921 2006-01-20;-0.000609106;-0.008712876;-0.006809095;-6.25E-05;-0.009303988;-0.002303598;-0.002759185;-0.003613313;-0.004887407 2006-01-23;-0.000838127;8.05E-05;0.00545098;0.000301725;-0.015576463;-0.013647762;-0.0028156;-0.005072953;-0.007675798 2006-01-24;-0.000762544;-0.000969675;-0.004186534;-0.000286856;0.004337176;0.006332422;0.000253631;0.00122487;0.002318423 2006-01-25;-0.001144907;-0.001245166;-0.003240181;-0.002815259;0.00261833;0.007546242;-0.000604919;0.000462553;0.001621599 2006-01-26;-0.001069764;0.008348556;0.004654466;-0.002209309;0.011148716;0.006057385;0.001842887;0.003443139;0.005584311 2006-01-27;-0.00068831;0.004847171;0.002419844;7.44E-05;0.01667598;0.013617398;0.003394103;0.005791901;0.008762193 2006-01-30;0.000458926;0.00142675;-0.000957155;-9.04E-06;0.00639509;0.004048016;0.001319517;0.002116907;0.003086897 2006-01-31;-0.000152952;0.002736095;0.00286872;0.000310696;-0.002555899;0.001408194;0.000222982;0.000133349;5.59E-05 2006-02-01;-0.001071319;0.003339025;0.000452205;-0.001294361;0.002901341;0.003081589;0.000126011;0.000818751;0.001721067 2006-02-02;-0.000306302;-0.005231537;-0.000904614;-0.000205406;-0.005122147;-0.002149007;-0.001435528;-0.002048137;-0.002904273 2006-02-03;0.00114815;0.006229563;0.002611099;0.000894786;2.18E-05;0.002320324;0.001522757;0.001629324;0.001834769 2006-02-06;0.000764701;1.01E-05;-0.000300933;0.000304395;0.005366735;0.003557854;0.001297846;0.001883276;0.00256489 2006-02-07;0.000229296;-0.000366159;-0.0001505;-0.001032759;-0.004885409;0.00132512;-0.000716513;-0.000960218;-0.001346677 2006-02-08;0;-0.000779795;0.003605773;-0.000348383;-0.002291161;-0.005855661;-0.000600717;-0.001303949;-0.002083954 2006-02-09;0.000458435;0.005323768;-0.000149981;0.001117685;0.005975302;0.004387832;0.00192683;0.002739181;0.003811087 2006-02-10;0.000992556;-0.001029007;-0.001050499;-0.000559031;0.000610734;-0.001207842;8.71E-05;-2.85E-05;-0.000204129 2006-02-13;-0.00045798;0.003052141;0.00244945;-0.00057257;-0.003606305;-0.007010043;-0.000890257;-0.001596989;-0.002294676 2006-02-14;0.000229016;-0.000512497;0;-0.000231878;0.009024345;0.008108776;0.001731401;0.002992265;0.004454474 2006-02-15;0.000457875;-0.009934384;0.002094764;5.71E-05;4.78E-05;-0.002090305;-0.000541345;-0.001043901;-0.001816514 2006-02-16;-0.000763242;0.012917199;0.000149458;0.000562857;0.007207128;0.001846858;0.001854822;0.002901246;0.00448894 2006-02-17;0.000992101;0.001284419;0.001592833;0.002231158;-0.000176786;-0.002577009;0.00095505;0.000530037;8.31E-05 2006-02-20;0.00129588;0.004250758;0.004119624;0.000477737;-0.003239016;-0.002864775;0.00064583;3.78E-05;-0.000609632 2006-02-21;-0.000990816;0.006363835;0.002572349;-0.000323622;0.002937757;0.008581215;0.001203793;0.002277765;0.003633819 2006-02-22;0.000152497;0.004433658;0.003600053;0.001094524;0.007620528;0.01017505;0.002652853;0.003938386;0.005517648 2006-02-23;-0.001373312;-0.006066962;0.006134537;-0.001702962;-0.001543948;0.004623183;-0.000816252;-0.000667868;-0.00064109 2006-02-24;-0.001069437;-0.00274574;-0.002155068;-0.00053351;0.007358391;0.005241543;0.000384202;0.001448049;0.002680685 2006-02-27;-0.001529754;0.005372211;0.003963696;-0.000873101;0.006676545;0.004810702;0.001065387;0.002158774;0.003629867 2006-02-28;0.001071074;-0.011956984;0.001659104;0.001447958;-0.013280777;-0.011403581;-0.002497288;-0.004868522;-0.007924254 2006-03-01;-0.001607041;0.010504721;0.000974659;-0.001252501;0.005387752;0.002797315;0.00078828;0.00186374;0.003416865 2006-03-02;-0.002684154;-0.004177747;-0.005029676;-0.002352125;-0.005006072;-0.003155809;-0.003214694;-0.003419515;-0.003719724 2006-03-03;0.000153574;0.001755361;-0.001077586;-0.001091874;-0.00560182;-0.004597778;-0.001205767;-0.001860677;-0.002619427 2006-03-06;0.000153551;0.00046021;0.00122444;-0.000799747;-0.004074304;0.005665754;-9.65E-05;2.84E-05;5.52E-05 2006-03-07;-0.000460723;-0.007028455;-0.003383102;-0.000404715;0.00030208;-0.003156706;-0.001265328;-0.001504251;-0.001888296 2006-03-08;-0.001306537;-0.004230567;0.001423278;-0.000514856;-0.005217603;-0.005094417;-0.001896157;-0.002654508;-0.003583737 2006-03-09;-0.002695316;0.00353447;0.001176355;4.94E-05;0.005252363;0.007586787;0.000513091;0.001802042;0.003445429 2006-03-10;-0.001775171;0.012874662;-0.002992619;-0.001491678;0.0093266;0.007969806;0.001421726;0.003367739;0.005957543 2006-03-13;-7.73E-05;0.008254396;0.001031257;-0.000686457;0.004076902;0.001173296;0.001091519;0.00170791;0.002636447 2006-03-14;0.001929534;-0.000530596;-0.00221114;0.002416174;-0.001254603;-0.001803416;0.000878145;0.000377045;-0.000265161 2006-03-15;0;-0.00176797;0;-0.001182134;0.003856598;0.005838227;0.00049181;0.00123383;0.002028065 2006-03-16;0.002310537;0.000666818;-0.002265341;0.001977064;-0.002673989;-0.004761951;0.000607197;-0.000207102;-0.001187106 2006-03-17;-0.002464763;0.004312966;0.001871737;-0.001036394;0.00225927;0.006136014;-3.85E-05;0.000950432;0.002226949 2006-03-20;0.001618186;0.002162482;-0.000738425;0.000851449;-9.12E-05;-0.001183003;0.000866818;0.000639386;0.000382827 2006-03-21;-0.001001425;-0.000275319;-0.001527809;-0.001339995;0.002181992;0.002324939;-0.000423684;0.00011279;0.000747003 2006-03-22;0.001078416;0.00132731;-0.001085669;9.92E-05;0.003448039;0.004484951;0.001241656;0.001784155;0.002392117 2006-03-23;-0.002157997;-0.00431859;0.002416473;3.11E-07;0.005771496;0.004945502;8.66E-05;0.000937752;0.001933157 2006-03-24;-0.000308666;0.00277259;-0.001034916;0.001733867;0.000373619;-0.002134066;0.000326973;0.000234301;0.000235716 2006-03-27;0.000308666;-0.006945127;-0.000443864;-9.71E-05;-0.003367561;-0.001660917;-0.001000491;-0.001566171;-0.002405102 2006-03-28;-0.002858801;-0.000727865;0.003987698;-0.003365184;-0.008242396;-0.003029465;-0.002997838;-0.003506978;-0.004097434 2006-03-29;-0.001393728;0.000925244;-0.003149454;-0.001491383;0.010195799;0.009986866;0.000926337;0.002755846;0.004933068 2006-03-30;0.000232423;0.006206489;0.002854614;-0.001069441;-0.001485063;-0.004903791;-4.82E-05;-0.000413363;-0.000672086 2006-03-31;0.000232369;-0.000929251;-0.003742188;0.000305868;0.001377181;0.006545954;0.000482151;0.001108179;0.001733787 2006-04-03;-0.002947338;0.006944399;-0.001579857;-0.001780872;0.00568243;0.000905848;-0.00044357;0.000647434;0.002201477 2006-04-04;0.000543584;-0.002618493;0.000493974;-0.000204468;-0.006362263;-0.006088935;-0.001244976;-0.002300762;-0.003608247 2006-04-05;-0.000854336;0.004752739;0.000641801;0.000606638;0.000926314;0.002547149;0.000521341;0.000939726;0.001542804 2006-04-06;-0.000466309;0.001547134;0.001233076;-0.001795536;0.004970445;0.003455002;0.000453539;0.001229707;0.002192129 2006-04-07;0.000854734;0.000511971;-0.000542366;-0.001522458;0.001122031;0.000477382;0.000135057;0.000272021;0.000407098 2006-04-10;0.000155328;1.60E-05;0.003200633;-0.000290052;0.000814416;-0.005464587;-7.72E-05;-0.000506581;-0.000922993 2006-04-11;0.001707015;-0.009574743;0.005979824;0.000943125;-0.009626984;-0.008309656;-0.001177629;-0.003129599;-0.005646963 2006-04-12;-0.000465261;-0.002978612;-0.002201513;-0.000855846;-0.002496517;-0.001173969;-0.001188687;-0.001394083;-0.001713094 2006-04-13;-0.003418541;0.003927437;-0.001666585;-0.002748793;0.002051797;-0.002030196;-0.001780841;-0.001160077;-0.000218904 2006-04-14;0;0;0;-0.000184454;-0.000204378;0.001084638;9.69E-06;8.49E-05;0.000155062 2006-04-17;0;0;0;0.000866943;-0.014189288;-0.013512449;-0.002570359;-0.004691336;-0.007167046 2006-04-18;-0.000311357;-0.005031255;-0.000687049;0.0011108;0.009662646;0.008145238;0.001543008;0.00274559;0.004079524 2006-04-19;-0.000623004;0.010893639;0.001030397;3.96E-05;0.005027196;0.006269589;0.001753613;0.002907775;0.004491108 2006-04-20;-0.000389575;0.004201724;0.004208678;8.50E-05;0.006928022;0.002729687;0.001566929;0.002325791;0.003382375 2006-04-21;-0.000701618;0.004838081;-4.88E-05;0.000241358;0.001746404;-0.002700814;0.000154625;0.000263311;0.00057169 2006-04-24;0.000155958;-0.00169474;0.001659104;0.000709905;-0.006505857;-0.006628796;-0.001073205;-0.002193241;-0.00352609 2006-04-25;-0.00195122;-0.004175679;-0.000536468;-0.002513616;-0.003143165;0.002397504;-0.001975386;-0.001801488;-0.001713 2006-04-26;-0.001094349;0.004699408;-0.001415705;-0.001214239;0.005183172;-0.002555296;-3.88E-05;0.000481343;0.001303241 2006-04-27;-0.001252152;0.000883969;0.002878121;0.000805477;-0.004529297;-0.003080855;-0.000814561;-0.001350235;-0.001914435 2006-04-28;0.00133036;-0.002943741;0.002043796;0.002010892;-0.014077895;-0.005224939;-0.001184236;-0.002990218;-0.005288258 2006-05-01;0;0;0;-0.000765691;-0.003693616;-0.006322298;-0.001127297;-0.001840206;-0.002645456 2006-05-02;-0.000547581;0.003189327;0.004026688;-0.000154107;0.006448564;0.00529182;0.001486599;0.002408657;0.003599042 2006-05-03;-0.001722923;-0.011943802;0.001354752;-0.00085779;-0.001696372;0.000456333;-0.001875617;-0.002085902;-0.002551045 2006-05-04;-0.000156777;0.003014635;0.001256342;-0.000750863;-0.002082786;0.000334305;-0.000165379;-0.000199336;-0.000202159 2006-05-05;0.001566662;0.011235363;0.00038625;0.001263903;0.006955693;0.007085147;0.003215109;0.004319538;0.005800411 2006-05-08;7.83E-05;0.00617563;-0.00057943;-0.000586246;0.005895404;0.008723688;0.001695663;0.002982457;0.004567113 2006-05-09;-0.001409775;0.00251702;-0.002175859;-0.000302384;-0.003534437;-0.004524736;-0.001395079;-0.001726098;-0.002012064 2006-05-10;-0.000235156;-0.001387209;-0.000484168;-2.58E-05;-0.003395082;-0.002510121;-0.000853507;-0.001294168;-0.001842629 2006-05-11;-0.003770033;-0.001096609;-0.00257001;-0.001331943;-0.011424488;-0.008233491;-0.004161568;-0.005155481;-0.00627392 2006-05-12;-0.000944733;-0.017989732;-0.002917439;-0.001062453;-0.023574182;-0.013320491;-0.006157354;-0.009153666;-0.013141839 2006-05-15;0.001259446;-0.013399941;4.87E-05;0.001748199;-0.005396723;-0.008904148;-0.001402917;-0.003025053;-0.005180077 2006-05-16;0.002435672;0.00328515;-0.000681929;0.002295672;-0.002894224;-0.004946128;0.001010691;0.000163491;-0.00079572 2006-05-17;-0.001963788;-0.028406916;-0.001316463;-0.001878467;-0.014009893;-0.008094844;-0.005842735;-0.00788755;-0.010894595 2006-05-18;0.001806827;-0.009711417;0.000146359;0.003293557;-0.013548388;-0.005974732;-0.001312913;-0.003368952;-0.006096827 2006-05-19;0.002038577;0.001848007;0.001657244;0.000493379;0.008701687;0.004725704;0.002643808;0.003427105;0.004372215 2006-05-22;0.003050094;-0.025997761;-0.001559683;0.003505067;-0.030090802;-0.017271885;-0.005027246;-0.009670662;-0.015868797 2006-05-23;0;0.018970677;0.00116999;0.001795336;0.006914439;0.008215166;0.003439826;0.004929797;0.007066896 2006-05-24;0.001326622;-0.011115589;-0.003025278;-0.00206778;0.001191832;-0.000796416;-0.000957613;-0.001159488;-0.001675788 2006-05-25;0;0;0;-0.000758079;0.01077888;0.003775567;0.001441008;0.002570495;0.003969455 2006-05-26;0.000389848;0.025842125;-0.003769987;-0.0007468;0.021929104;0.014575251;0.005458932;0.008935416;0.013586689 2006-05-29;0.000155897;0.001772007;0.002743217;-3.90E-05;-0.000990566;-0.002127153;0.000107894;-0.000163855;-0.000423863 2006-05-30;-0.000623733;-0.019842413;-0.001811639;-0.000217462;-0.027883281;-0.010728806;-0.006217983;-0.009491413;-0.013926798 2006-05-31;0.000233945;0.009323326;0.00488879;-0.001564347;0.007849425;0.000994201;0.001824143;0.002653102;0.003899681 2006-06-01;-0.001404495;0.001536483;-0.00366435;-0.001106631;0.009620619;0.001869367;0.000344734;0.001532285;0.003068988 2006-06-02;0.00233973;0.006993059;-9.79E-05;0.003679165;-0.000808576;0.005508104;0.002684856;0.002796663;0.002946096 2006-06-05;0;0;0;-0.000513408;-0.014571716;0.000306106;-0.001926859;-0.002971109;-0.004379652 2006-06-06;-0.001091193;-0.022326545;0.001320843;-0.001317502;-0.004788572;-0.009436487;-0.003647588;-0.005130658;-0.007237046 2006-06-07;7.80E-05;0.005638327;-0.001565635;6.93E-05;-0.002186765;-0.002128673;-7.90E-05;-0.000233838;-0.000306273 2006-06-08;0.001168998;-0.02737931;-0.001371944;0.001919417;-0.009237181;-0.008977958;-0.003036885;-0.005266075;-0.008469128 2006-06-09;0.001478772;0.01242917;0.003768326;0.000607425;0.003026002;0.007100429;0.00286896;0.003666715;0.004776911 2006-06-12;0.000932836;-0.013895865;-0.003670268;0.000767802;-0.008836615;-0.001082229;-0.001938119;-0.003069346;-0.004815527 2006-06-13;0.001397624;-0.023992295;-0.005654038;0.002343773;-0.022707064;-0.015119018;-0.005050791;-0.008603155;-0.013392884 2006-06-14;0.000930665;0.002272268;-0.001430863;-0.002227792;0.000425405;-0.002537102;-0.000258683;-0.000306159;-0.000332727 2006-06-15;-0.002095217;0.021569386;-0.004404095;-0.003023161;0.024075309;0.016793504;0.003962446;0.008037624;0.01335868 2006-06-16;0.00031068;-0.002926246;-0.000843442;-0.000584275;0.004197635;0.001820827;0.000356743;0.000754203;0.001167914 2006-06-19;-0.002176787;0.008192221;-0.003231503;-0.001189575;0.00126123;0.001244341;-0.000545075;0.000205593;0.001301437 2006-06-20;-0.001168088;0.003859327;-0.003441829;-0.001533678;-0.002300243;-0.004950402;-0.001478153;-0.00164593;-0.001716325 2006-06-21;-0.000701508;0.003382685;-0.0013;-0.000436571;0.004900516;-0.000686068;0.000327565;0.000852695;0.00161998 2006-06-22;-0.00148258;0.007397751;-0.001502103;-0.001833336;0.00634693;0.006804069;0.000694479;0.002143225;0.004009717 2006-06-23;-0.002501956;0.000545938;0.000801403;-0.001438792;0.00172859;-0.000642461;-0.001091541;-0.000694332;-0.000115163 2006-06-26;-0.000469814;-0.002493482;-0.00045071;-0.000618372;0.002004891;0.003772477;-2.98E-05;0.000430347;0.000901757 2006-06-27;-0.0008619;-0.006852493;-0.003462208;0.000703537;-0.006736107;-0.003638492;-0.002057379;-0.002869218;-0.003977677 2006-06-28;0.000313504;0.002764602;-0.000603349;-0.000783933;0.003541448;0.001895032;0.000676321;0.001176102;0.001817859 2006-06-29;0.000626714;0.014041765;0.001206333;0.001828827;0.019972786;0.010914546;0.005166689;0.007650012;0.010952363 2006-06-30;-0.000548353;0.014473814;0;0.001521697;-0.00237578;0.002364343;0.001126972;0.00146671;0.002136317 2006-07-03;7.84E-05;0.008784869;5.02E-05;-0.000685714;0.00633254;0.004986231;0.001688081;0.002781805;0.004249546 2006-07-04;-0.000235082;0.00196206;-0.00518723;0.000439379;0.00334792;0.005191498;0.000581777;0.001402504;0.002367736 2006-07-05;-0.001568628;-0.008807793;-0.001667636;-0.00264074;-0.005906715;0.000503473;-0.002773872;-0.003068719;-0.003652998 2006-07-06;0.000941472;0.005563327;-0.000202327;0.001069288;0.001619045;-0.000969688;0.00117564;0.001220871;0.001398588 2006-07-07;0.000783883;-0.00579797;0.000455178;0.00228539;-0.007781564;-0.004549545;-0.00082972;-0.00210354;-0.003756042 2006-07-10;0;0.005982938;0.000707643;-0.000225849;0.007805466;0.006983881;0.001944806;0.003197182;0.004794267 2006-07-11;0.001174674;-0.003834656;-0.000808775;0.001524074;-0.002940692;-0.003247174;-0.000108494;-0.000841902;-0.001803427 2006-07-12;-0.000313112;0.00447095;-0.000657612;-0.000510019;-0.002934499;0.001553854;-0.000217022;-0.000135545;0 2006-07-13;0.000547881;-0.01529432;-0.002330413;0.001449753;-0.017238482;-0.01187541;-0.003785731;-0.006420646;-0.009896275 2006-07-14;0.001641844;-0.010372721;0.002886882;0.002134163;-0.008038026;-0.003441194;-0.000634002;-0.002097326;-0.004103011 2006-07-17;0.000936988;-0.00226627;0.00328192;-0.000532494;0.001824619;-0.002919534;0.000326958;3.91E-05;-0.000306728 2006-07-18;-0.001093238;-0.00560645;-0.002119393;-0.00131767;0.000242444;0.001420792;-0.001209286;-0.000996512;-0.000863177 2006-07-19;0.000859073;0.01841958;-0.003491641;0.001842914;0.015637766;0.006081043;0.004334752;0.00633339;0.009140508 2006-07-20;0.000234165;0.00802311;0.001468987;0.001154924;-0.001930229;0.005337982;0.001253374;0.001591646;0.002070532 2006-07-21;0.000624171;-0.005338772;0.001062404;0.000588033;-0.01125735;-0.007391624;-0.001885592;-0.003536113;-0.005632746 2006-07-24;0.0008576;0.019239808;0.003281257;-0.000257105;0.020241619;0.00993538;0.005243199;0.007832533;0.011366023 2006-07-25;0.000389575;0.000606787;0.001611442;-0.000629919;0.007051999;0.00386332;0.001335966;0.002122037;0.003080099 2006-07-26;-0.000857265;0.00433433;0.00331542;0.000377291;0.001065609;-0.000222588;0.000441655;0.000597216;0.000930639 2006-07-27;0.00148027;0.005560211;0.002804489;0.000834329;-0.003271172;1.10E-05;0.001019968;0.000654601;0.000272448 2006-07-28;0.00093378;0.010298249;-0.004209689;0.001520162;0.007630774;0.003780762;0.002447598;0.003496776;0.00494749 2006-07-31;7.78E-05;0.000267236;0.004459707;0.00035812;-0.000716132;0.002939118;0.000606078;0.000642307;0.000663424 2006-08-01;0;0;0;-2.51E-05;-0.002281254;-0.001718422;-0.000420306;-0.000719028;-0.001074782 2006-08-02;0.000621987;-0.003903872;-0.003706676;0.000562387;0.003105718;0.001282845;0.000303029;0.000536923;0.000719764 2006-08-03;-0.001400016;-0.011019526;-0.004274693;-0.000755279;0.000891714;0.000837148;-0.001721642;-0.001582833;-0.001627218 2006-08-04;0.001322289;0.00953739;0.005127443;0.002322977;-0.001806093;0.001195614;0.002073432;0.001889517;0.00183277 2006-08-07;0.000466273;-0.012098329;-0.002510168;0.000427364;-0.007921485;-0.00283237;-0.002004901;-0.003119139;-0.004757187 2006-08-08;0.000388395;0.00055356;0.004213489;0.000212044;0.003504705;5.14E-05;0.001007843;0.001133613;0.00134142 2006-08-09;0.000155316;0.01077762;0.000350324;-0.000635088;-0.000649147;0.00049772;0.000694136;0.000959684;0.001470678 2006-08-10;0.000388184;-0.005122863;0.00110022;-0.000710066;0.007741051;0.005483401;0.001054945;0.001887887;0.002766874 2006-08-11;-7.76E-05;0.001695279;-0.00019995;-0.001161518;-0.00177454;0.00262348;-0.000234336;-5.74E-05;0.000121343 2006-08-14;-0.001398276;0.008015181;-0.002051796;-0.001352662;0.006006259;0.003411974;0.000556459;0.001721961;0.003307914 2006-08-15;0.0014759;0.014854679;0.001801802;0.002298591;0.007844854;0.004741306;0.003750449;0.004758213;0.006259671 2006-08-16;0.002480814;0.004466055;-0.001050657;0.00243761;0.003210456;0.00160209;0.002379347;0.002508243;0.002705012 2006-08-17;0.000928721;0.002903936;-0.00200431;0.000507121;0.002597922;0.002216918;0.00105675;0.001422341;0.001879042 2006-08-18;0.001082419;-0.003261951;0.00250476;0.0008575;0.003432674;-0.000294437;0.000997555;0.000937638;0.000827868 2006-08-21;0.002315531;-0.003013997;-0.001953175;0.001369273;-0.009282359;-0.005255545;-0.000658468;-0.002075348;-0.003915414 2006-08-22;0.003309605;0.003136533;-0.001956997;0.001539833;0.009765837;0.007847656;0.003606569;0.004646967;0.005844444 2006-08-23;-0.00115327;-0.000214844;0.002708669;-0.000473661;-0.003975623;-0.001528519;-0.001004278;-0.001351166;-0.001745153 2006-08-24;0.000768994;0.002020895;-0.002306922;0.000404007;0.000461904;-0.002325382;0.000270482;0.000141816;3.68E-05 2006-08-25;0.000153728;0.000665318;-0.000652922;0.001539084;0.002137852;0.002059827;0.00086891;0.001124365;0.001442213 2006-08-28;7.69E-05;0.001801597;0.003060024;0.000178105;-0.000922057;0.000946053;0.000395587;0.000349335;0.000321229 2006-08-29;-0.000615006;0.006075435;-0.001453598;-0.000645603;0.004572093;0.004375355;0.000838898;0.001791963;0.003041967 2006-08-30;0.000922367;0.002758544;0.001203128;0.001219177;-0.002355205;-0.001439447;0.000568508;0.000169599;-0.000265345 2006-08-31;0.000921518;-0.001466397;0.003750473;0.001785674;0.003102312;0.005546821;0.001790132;0.00212696;0.002458609 2006-09-01;0.001304031;0.003126659;0.00149626;0.000581154;0.005369764;0.003024886;0.001911707;0.002422605;0.003080712 2006-09-04;0.00053646;0.004561703;-0.002594941;-0.000377088;0.002339958;0.002506699;0.000748316;0.00125594;0.001909282 2006-09-05;-0.000459805;-0.00042463;0.001448009;-0.001432716;0.004066206;0.003263157;0.000287665;0.000908167;0.0016427 2006-09-06;-0.001610986;-0.005904139;-0.001897818;-0.001099098;-0.008707857;-0.003321636;-0.00284192;-0.003628237;-0.004699304 2006-09-07;0.000460547;-0.006105126;-0.001801261;0.000593757;-0.005673297;-0.004648055;-0.001318087;-0.002275528;-0.003550456 2006-09-08;0.001380368;0.00503804;0.002900437;0.000793461;0.005917384;0.005269641;0.002480794;0.003195552;0.004115176 2006-09-11;-0.000996742;-0.008630266;-0.004153225;-0.000315437;-0.009551577;-0.003913185;-0.002923754;-0.003930091;-0.005341137 2006-09-12;0.000306796;0.011544379;-0.003164003;-0.000210278;0.010711884;0.00681976;0.002549145;0.004211562;0.006415046 2006-09-13;0.001915343;0.003047893;-0.000805153;0.001128145;0.006899516;0.003373355;0.00233182;0.00295067;0.003722438 2006-09-14;-0.000765697;-0.003292502;0.001710176;-0.000504851;-0.001789078;-0.00258309;-0.000968532;-0.0013197;-0.001759622 2006-09-15;0.000612604;0.005426908;-0.000854722;0.00032869;0.008410457;0.008096154;0.002328647;0.003645988;0.005278634 2006-09-18;-0.002069046;0.003786049;-0.000855454;-0.001328313;-0.001956744;-0.003619625;-0.001455967;-0.001484837;-0.001364522 2006-09-19;0.001379839;-0.002568654;-0.000856186;0.001867601;-0.003520425;-0.00173632;0.000191696;-0.000476736;-0.001366386 2006-09-20;0.001760362;0.012243951;-0.000957782;0.000868315;0.001942664;0.003188766;0.002249677;0.002745125;0.003507221 2006-09-21;0.000611574;0.003971593;-0.000201755;0.001545393;0.001293783;0.002225236;0.001242331;0.001472164;0.001803053 2006-09-22;0.001985037;-0.009189605;0.002066064;0.002799483;-0.017456474;-0.010596544;-0.00201718;-0.004741026;-0.008230276 2006-09-25;0.002285541;-0.002716968;-0.003125948;0.001610564;0.00479675;-0.001348507;0.001377095;0.001336855;0.001234333 2006-09-26;0.000608596;0.012816618;0.003327287;-0.000186757;0.010900135;0.004921623;0.003139181;0.004511524;0.006446356 2006-09-27;-0.001141422;0.003601404;-0.001259034;-0.000655026;0.006539285;0.006329963;0.00084751;0.002081108;0.003625295 2006-09-28;7.61E-05;0.000706224;-0.000302404;-0.00075506;0.00468215;0.004813548;0.000818261;0.001585793;0.002484228 2006-09-29;-0.001218862;0.001409431;0.003622828;-0.000701547;0.002236721;0.00312206;0.000228232;0.000731769;0.001387404 2006-10-02;0.000304855;-0.005008288;-0.006196962;0.000315785;-0.007003375;-0.003657178;-0.001789216;-0.002605315;-0.003736949 2006-10-03;-0.000762311;0.00062416;0.000909275;-0.000326612;-0.000754755;0.003608714;-9.53E-05;0.00020422;0.000538551 2006-10-04;0.001980802;0.006657881;-0.001718214;0.001637655;0.010863163;0.005694918;0.003357224;0.004528519;0.006038801 2006-10-05;-0.000228354;0.007166048;0.003231836;-0.000875704;0.008712384;0.008808677;0.002219273;0.003698328;0.005585762 2006-10-06;-0.000533029;0.001014591;-0.002170238;-0.001888177;0.001629543;0.001764772;-0.000435878;4.60E-05;0.000620688 2006-10-09;7.62E-05;0.003046625;0.000858564;-0.000296246;0.001170102;-0.001609882;0.000274815;0.000303729;0.000434253 2006-10-10;-0.001905852;0.008986321;-0.001313397;-0.001974727;0.007335648;0.005940936;0.000681973;0.002224531;0.004270431 2006-10-11;0.000457736;0.001066884;0.002877119;-0.000776714;-0.000804003;-0.001824984;4.73E-05;-0.000202026;-0.000467708 2006-10-12;-0.001221095;0.004239901;0.003270855;0.000525734;0.007142062;0.006033547;0.001551576;0.002659796;0.004113619 2006-10-13;-0.001069682;-0.00206057;0.001756808;-0.000849761;0.006478233;0.007746272;0.000727654;0.001848514;0.003133299 2006-10-16;-0.000152905;-0.001837336;-0.003214791;0.000425426;0.002441962;0.00176503;0.000103907;0.000447887;0.000814628 2006-10-17;0.00129895;-0.010501863;0.001960243;0.00051079;-0.007447242;-0.008725561;-0.001578667;-0.003258614;-0.005452236 2006-10-18;-0.000534657;0.009154022;-0.00211119;0.00019151;0.005490559;0.009209101;0.00173923;0.003167225;0.004988067 2006-10-19;-0.001529169;0.001017744;0.000553362;-0.00093061;-0.004447586;-0.005333763;-0.001682468;-0.002205012;-0.002736844 2006-10-20;0.000153022;0.002608071;-0.00176176;0.000264738;0.000366527;0.002645116;0.000435066;0.000741646;0.00111494 2006-10-23;-0.001531277;0.00551303;-0.001260303;-0.001268922;0.007450165;0.008202838;0.000935697;0.002495579;0.004456105 2006-10-24;0.000153233;-0.003512579;0.000353045;0.000221301;0.001937159;1.34E-05;0.000122804;0.000146068;0.000122285 2006-10-25;-0.000689734;0.002847068;0.001713019;0.001151482;0.001727728;-0.000548249;0.000528831;0.000657042;0.00093411 2006-10-26;0.000536501;-0.000617211;-0.001208886;0.002258705;-0.000752565;0.001624416;0.00067008;0.000583675;0.000436201 2006-10-27;0.002296037;0.002649247;0.000251972;0.001681503;-0.007492754;-0.009521839;-9.44E-05;-0.001624192;-0.003389923 2006-10-30;0.001909345;-0.004790287;-0.000504007;0.000664017;-0.004359134;0.001546751;0.000103785;-0.000438436;-0.00130486 2006-10-31;0.002819157;-0.00823861;0.001611929;0.002425049;-0.001503448;-0.001790206;0.000914728;1.83E-05;-0.001262693 2006-11-01;0.002431797;0.004875862;-0.001511107;0.001684354;-0.001961321;0.00103692;0.001478768;0.001241715;0.000955935 2006-11-02;-0.000151814;0.003427875;0.002014302;-0.001252626;-0.000363517;-0.003114427;-0.00024474;-0.000392434;-0.000455928 2006-11-03;-0.000303698;0.005998606;0.000301796;-0.002643124;0.006874994;0.003085771;0.000781077;0.001833081;0.003222109 2006-11-06;-0.000227834;0.010778959;0.004766334;-0.000541549;0.010752702;0.004376526;0.002611703;0.003946572;0.005831124 2006-11-07;0.003639125;0.003869904;0.003896498;0.00212791;-0.002374248;5.32E-05;0.002277318;0.001632269;0.000842654 2006-11-08;-0.001135805;-0.0059257;0.00363302;0.000313045;0.001689021;0.001495922;-0.00022469;-0.000126859;-7.82E-05 2006-11-09;0.001060124;-0.000582101;0.00337235;0.000621338;-0.005011026;-0.005285068;-0.000234105;-0.001242253;-0.002443235 2006-11-10;0.000907784;-0.002674138;-0.004814025;0.001475358;-0.004538986;-0.000576457;-0.000440267;-0.000934974;-0.001655399 2006-11-13;-0.001134859;0.001522067;-0.000298537;-0.000502389;0.002665954;0.001435783;-4.68E-05;0.000444902;0.001098097 2006-11-14;0.000756716;-0.001419646;0.002683632;0.000555487;0.006206534;0.005721417;0.00174128;0.002429848;0.003200253 2006-11-15;-0.001589765;0.006748329;-0.001241527;-0.001061841;0.004987468;0.003934595;0.000430172;0.001511142;0.002964995 2006-11-16;0.000303007;8.86E-05;-0.000298196;-0.000644854;0.00112074;0.000246324;0.00010284;0.000216983;0.000346209 2006-11-17;0.000530042;-0.004622855;-0.001741251;0.001397656;-0.005097974;-0.004347068;-0.000879154;-0.001782459;-0.002955287 2006-11-20;0.001739591;0.001285299;0.000149369;0.00104388;-0.003497125;0.001239321;0.000720215;0.000353125;-0.000156241 2006-11-21;0;0.001596663;-0.001893657;0.00018367;0.001663555;0.006632706;0.00072904;0.001429334;0.002211134 2006-11-22;0.00022668;0.000878824;-0.001447576;0.000239855;-0.002980772;-0.000458826;-0.000299029;-0.0005335;-0.000831853 2006-11-23;-0.000755801;-0.002842963;-0.000649594;-0.000651478;-0.003378958;-0.001382067;-0.001253156;-0.001556914;-0.001978429 2006-11-24;0.000906892;-0.012052528;-0.000149966;0.001308507;-0.011636379;-0.004704682;-0.002032702;-0.00371196;-0.006028786 2006-11-27;-0.001133744;-0.014190477;0.000249931;-0.000213151;-0.011830027;-0.007305125;-0.003578964;-0.005251079;-0.007517019 2006-11-28;0.000755972;-0.006499855;0.00059958;0.001208929;-8.07E-05;-0.000772121;9.41E-05;-0.000283394;-0.0008632 2006-11-29;-0.000226732;0.012901202;-0.00079952;-0.000973718;0.013358703;0.00892497;0.002912715;0.004997867;0.007750854 2006-11-30;0.000453412;-0.008646808;0.000949359;0.002092347;-0.005199421;-0.000662563;-0.000572477;-0.001401989;-0.002600326 2006-12-01;-0.000151114;-0.006425401;0.000698952;0.001952261;-0.006623416;-0.003463449;-0.00108955;-0.002106675;-0.003442465 2006-12-04;-0.000302297;0.006552949;0.012005303;6.18E-05;0.009041889;0.009064459;0.003096472;0.004345278;0.005999071 2006-12-05;-0.001058761;-0.002811318;0.000640852;-0.000343139;0.002410963;-0.000554739;-0.000412309;-0.000236364;-1.75E-05 2006-12-06;-0.000454098;0.007174143;-0.001134094;-0.000698467;0.000540868;0.001682031;0.000290508;0.000745265;0.001415602 2006-12-07;-0.001136149;0.007440423;-0.00014802;-0.000973914;0.002082111;0.00066692;0.000159275;0.000717474;0.001570544 2006-12-08;-0.00159278;-0.002915097;0.00688437;-0.001648257;-0.001217055;-0.001824254;-0.001040432;-0.001271826;-0.001526884 2006-12-11;-0.002584177;0.006216417;0.002398376;0.000585149;0.007593589;0.006931431;0.001227782;0.00264177;0.004530216 2006-12-12;0.000152195;0.007783664;0.003854698;0.000793867;-5.18E-05;-0.000156456;0.001114008;0.001141697;0.001355073 2006-12-13;0.00022825;0.001614792;-0.002193892;-0.001298696;0.003857747;0.003871253;0.000495756;0.001212758;0.002055161 2006-12-14;0.0003803;0.010085255;-0.002834802;-0.001215524;0.013068906;0.006117207;0.002484427;0.004269133;0.006613678 2006-12-15;-0.000684645;0.001294973;0.011630018;-0.000270672;0.005800173;0.005448497;0.001761507;0.00242878;0.003307663 2006-12-18;-0.002743277;0.004566798;-0.004801057;-0.000378628;0.000355941;0.001496551;-0.001052803;-0.000386411;0.000540214 2006-12-19;-0.00061064;-0.006190852;0.001068895;-0.000674182;-0.006972013;-0.009485678;-0.002379876;-0.003700923;-0.00532051 2006-12-20;0.001830804;0.001553119;-0.004770258;0.00061497;0.003596972;0.005575693;0.001512577;0.002144783;0.0028142 2006-12-21;-7.62E-05;0.00094055;0.011497446;0.000667629;-0.002568741;-0.001892295;0.000606256;-1.80E-05;-0.000679158 2006-12-22;0.000838063;-0.005018284;-0.007212908;-0.001135599;-0.002866426;0.000401452;-0.001194208;-0.001351242;-0.001747297 2006-12-25;0;0;0;4.30E-05;-0.000373642;-0.000641005;-8.40E-05;-0.000162272;-0.000249863 2006-12-26;0;0;0;0.000455073;0.003552343;0.002766094;0.000765268;0.001216397;0.001756335 2006-12-27;-0.000685636;0.01033382;0.006344308;-0.001891206;0.011668628;0.008741701;0.00261801;0.004411646;0.006789626 2006-12-28;-0.001448999;-0.002034885;-0.001014321;-0.001148325;-0.002520074;0.004282031;-0.001089228;-0.00078028;-0.000512755 2006-12-29;0.001144121;-0.001101976;-0.002031734;0.000452006;-0.00291293;0.000131532;-1.86E-05;-0.000341003;-0.000820955 2007-01-01;0;0;0;-5.70E-05;0.000342204;-0.000380226;0;0;8.56E-06 2007-01-02;0;0;0;0.000729663;0.00183618;0.00208145;0.000568047;0.000825386;0.00112863 2007-01-03;0.001523462;0.014834908;0.001209863;0.000351689;0.004217407;0.00432015;0.002751852;0.003562864;0.004774011 2007-01-04;0.000152219;0.000127965;0.00140161;0.001051541;0.001918082;-0.002731708;0.000473373;0.000312711;0.000195589 2007-01-05;-0.00297245;-0.002580941;-0.000579738;-0.001284181;-0.003836263;-0.001651946;-0.002350505;-0.002450697;-0.002562696 2007-01-08;-0.001222027;-0.004541686;-0.001305641;4.80E-05;-0.000234504;-0.003164079;-0.001181984;-0.001397975;-0.00167227 2007-01-09;-0.001300042;0.003280826;0.000628855;-0.000607347;0.002894258;0.007548395;0.000549284;0.001559154;0.002788403 2007-01-10;-0.001301735;-0.00146968;-0.001936203;-0.000691999;-0.00195746;0.000893248;-0.001126824;-0.001030203;-0.000954174 2007-01-11;0.000306443;0.013481449;0.001065375;-0.000727733;0.009659577;0.006992982;0.002763577;0.004328663;0.006456952 2007-01-12;-0.001840068;0.005427095;-0.001162284;-0.001525699;0.006109605;0.002186291;0.000130081;0.0011773;0.002604939 2007-01-15;-0.001612842;0.008135203;0.003820767;0.000491724;0.004730294;0.007547315;0.001531828;0.002697207;0.004264866 2007-01-16;0.002763281;-0.002338515;0.00438312;0.00074343;-0.001696801;0.00099659;0.001307159;0.000773103;0 2007-01-17;0.00176144;0.003600904;-0.003707542;-0.000164791;-0.001158067;-0.001621141;0.000389037;0.000195403;-2.52E-05 2007-01-18;-0.000153046;-3.06E-05;-0.001883103;3.56E-05;0.000239204;0.004435185;0.000166684;0.000577103;0.001000391 2007-01-19;0.001835003;0.004899725;0.001304065;0.000454132;0.004981053;0.007240045;0.002478454;0.003278721;0.004234257 2007-01-22;0.001221467;-0.004463529;0.000627277;0.00111448;-0.002572071;-0.000505491;0.000120067;-0.000415891;-0.001188812 2007-01-23;0.000228859;-0.000507061;0.002023902;-0.000803885;-0.003033341;-0.002762235;-0.000582;-0.001062634;-0.00164322 2007-01-24;-0.000839406;0.006027774;0.003316115;-0.000126478;0.011963113;0.011299231;0.002676241;0.004578973;0.006973447 2007-01-25;-0.000840112;-0.001732155;0.001055004;-0.001954942;-0.008657812;-0.004035997;-0.002260493;-0.003100449;-0.004158149 2007-01-26;-0.000764351;-0.00959413;0.003110571;-0.000697534;0.00137066;0.000621152;-0.000748472;-0.000805392;-0.001029681 2007-01-29;-0.001377305;0.007425055;0.003719959;-0.000789662;0.000872375;0.004771895;0.000554477;0.001247639;0.002217101 2007-01-30;0;0.004207812;0.008201625;0.00069489;0.003212604;0.002443386;0.00168926;0.001978869;0.002453989 2007-01-31;-0.000306326;-6.49E-05;4.72E-05;0.001537545;-0.001116624;-0.003334449;-0.000129132;-0.00051201;-0.00090911 2007-02-01;0.001071729;0.009002711;0.000519199;-2.15E-05;0.0058243;0.006452533;0.002349441;0.003376193;0.004720033 2007-02-02;0.001529052;0.004474549;0.002121192;0.000791213;0.004678775;0.007045721;0.002417381;0.003163086;0.004061172 2007-02-05;0.001450437;2.32E-05;0.003056022;0.001293732;-0.000335732;-9.36E-06;0.001091879;0.000780445;0.000388675 2007-02-06;-0.000228877;0.000912364;-0.002161757;0.000741243;0.000419314;0.003579255;0.000320914;0.000683485;0.001090792 2007-02-07;-0.000686944;0.002937055;-0.005283031;0.000653879;-0.000897834;0.003370596;-0.000146691;0.000280269;0.000792557 2007-02-08;0.000534331;-0.006086188;0.003493701;2.81E-05;0.001753302;0.000149621;0.000256695;0.000105081;-0.000181572 2007-02-09;-0.000839791;0.006501382;-0.001273315;-0.001406636;0.001164659;-0.001790849;-0.000284202;1.75E-05;0.000552867 2007-02-12;7.64E-05;-0.004102506;-0.002693445;-0.000636596;-0.003433135;-0.004240737;-0.001385493;-0.001972067;-0.002750852 2007-02-13;-0.001222681;-0.002385222;0.001418507;-0.000519438;0.00433739;0.005662374;0.000275416;0.001078545;0.001991613 2007-02-14;0.000229367;0.006839015;0.001888218;0.002238868;0.004145574;0.002820317;0.002035727;0.002547059;0.003321537 2007-02-15;0.001298751;0.001487874;-0.002124496;0.001610327;-0.000647236;0.001019316;0.00086988;0.000777704;0.000641606 2007-02-16;-0.000534576;0.003058222;-0.001797541;0.000377207;-0.000725726;-0.002118986;-0.000274617;-0.000331979;-0.0003043 2007-02-19;-0.000687732;0.000894606;-0.008988718;-0.000163308;0.000103474;0.003097763;-0.000677712;-0.000113597;0.000509856 2007-02-20;-0.00030581;-0.00327061;0.004813544;0.000443142;0.001918255;0.004327907;0.000668556;0.000943339;0.001199603 2007-02-21;0.001222681;-0.009920237;0.003322578;0.000252945;-0.000621548;0.00075773;3.66E-05;-0.000419152;-0.001199603 2007-02-22;-0.00114622;0.003907766;-0.000663633;-0.001104916;0.004491559;0.005168036;0.000457641;0.001466263;0.00274218 2007-02-23;0.000764292;-0.000693145;0.000379273;0.001458396;-0.006059477;-0.002795567;-0.000320327;-0.001160614;-0.002207932 2007-02-26;0.001755659;-0.003503023;-0.002752992;0.001987626;0.000991467;-0.002600749;0.000658846;0.000244452;-0.000320514 2007-02-27;0.001600305;-0.035746244;-0.000380319;0.002580652;-0.033754558;-0.029322915;-0.007842745;-0.013746767;-0.021468324 2007-02-28;0.000380648;-0.011946524;-0.000285334;-0.000354284;-0.009588308;-0.004390174;-0.002381503;-0.003741769;-0.005659439 2007-03-01;0.001141075;-0.001959064;-0.000618503;-2.70E-05;-0.005429562;-0.005586897;-0.000841342;-0.00181385;-0.003028127 2007-03-02;-0.000912756;0.002364749;-0.000809389;0.000688448;-0.009753837;-0.007537253;-0.001860862;-0.003021487;-0.004321201 2007-03-05;0.001064801;-0.014462125;0.004324999;0.001209418;-0.017844633;-0.021206396;-0.003853068;-0.007418525;-0.01184489 2007-03-06;-0.000836534;0.011631804;-0.004324999;-0.000504931;0.01657652;0.013561945;0.003176375;0.00594458;0.00945982 2007-03-07;-0.001751381;0.011790712;-0.000619387;0.00056004;0.001603786;0.001540131;0.00059329;0.001286473;0.002402086 2007-03-08;-0.000991269;0.011925646;0.00223751;-0.000179681;0.016119155;0.011852821;0.003524665;0.005972877;0.009171773 2007-03-09;-0.001144995;0.000329792;0.00265945;-0.001964384;0.005517043;0.007856069;0.000553935;0.001711395;0.003072277 2007-03-12;0.002060047;-0.003173317;-0.001233865;0.00086679;-0.002011584;-0.002548062;0.000267625;-0.000372179;-0.001244608 2007-03-13;0.000533394;-0.007777588;-0.001425585;0.001547346;-0.016234528;-0.010182467;-0.002883045;-0.005153826;-0.00805158 2007-03-14;0.001142031;-0.028205491;-0.003048057;0.000651348;-0.017476816;-0.017651684;-0.005232845;-0.008643189;-0.013252692 2007-03-15;0.00022825;0.01475661;0.007934099;-0.001159341;0.011128345;0.012536322;0.003834535;0.00581509;0.008431356 2007-03-16;-0.000380445;0.00112947;0.000804144;-0.000102306;-0.006096244;-0.003619831;-0.001066251;-0.001743664;-0.002526224 2007-03-19;-0.001980651;0.014488916;0.002361388;-0.000832051;0.015494838;0.009073924;0.002880899;0.005266412;0.008500551 2007-03-20;0.000152497;0.004157206;0.003014462;0.0005751;0.007668925;0.006022246;0.002152933;0.003164335;0.004463765 2007-03-21;-0.000533842;0.007430739;0.006188777;0.000523717;0.012340293;0.006238545;0.002949284;0.004400944;0.006373572 2007-03-22;7.63E-05;0.013969587;0.005779016;-0.001144179;0.004896546;0.008709457;0.00249089;0.003765686;0.00550832 2007-03-23;-0.000763068;0.001698465;0.000325241;-0.001590473;0.00620173;0.002640584;0.000422193;0.001275527;0.00236452 2007-03-26;0;-0.007584022;0.000278694;0.000145901;-0.003424098;-0.004981554;-0.001313053;-0.00214734;-0.00325683 2007-03-27;0.000228981;-0.004753874;-0.001068749;-0.0008264;-0.003562431;-0.001661116;-0.001121592;-0.001587064;-0.002271893 2007-03-28;0.001067887;-0.009870398;-0.00046503;-0.000433669;-0.009457395;-0.007497005;-0.002200869;-0.003792689;-0.005921098 2007-03-29;-0.002213319;0.011153959;0.003343398;-0.000422212;0.011757207;0.008341316;0.002191671;0.004136767;0.006765307 2007-03-30;-0.00030567;0.000497094;-0.001809619;-0.000259702;0.001377212;0.005682475;0.000312704;0.0009434;0.001636238 2007-04-02;0.000152847;-0.001451593;0.001113999;4.19E-05;-0.003106087;0.000144855;-0.000331101;-0.000634714;-0.00105991 2007-04-03;-0.001146921;0.010335207;0.005735977;-0.000878196;0.012709136;0.006578468;0.002609049;0.004329202;0.006682809 2007-04-04;0.000382453;0.001307159;-0.001569497;0.000604093;0.004056483;0.003142163;0.001027052;0.001570417;0.00222875 2007-04-05;-0.000688521;0.005000492;0.001108136;-0.000565091;-0.000783132;-0.003158805;-0.000293336;-0.000394566;-0.000355935 2007-04-06;0;0;0;-1.04E-05;0.000461314;-0.001712161;-7.33E-05;-0.000166641;-0.000248402 2007-04-09;0;0;0;-0.001032441;0.008179152;0.007524048;0.001328587;0.002557949;0.00399179 2007-04-10;-0.000688995;0.006329425;-9.23E-05;-3.15E-05;-0.001428291;0.001876307;0.000146495;0.000411114;0.000832712 2007-04-11;0.000306279;-0.00104417;-0.001339276;-9.09E-05;-0.000991064;-0.001934817;-0.00034796;-0.000586108;-0.00089045 fBasics/data/msft.dat.csv0000644000176200001440000002571413202116740014777 0ustar liggesusers"%Y-%m-%d";Open;High;Low;Close;Volume 2000-09-27;63.4375;63.5625;59.8125;60.625;53077800 2000-09-28;60.8125;61.875;60.625;61.3125;26180200 2000-09-29;61;61.3125;58.625;60.3125;37026800 2000-10-02;60.5;60.8125;58.25;59.125;29281200 2000-10-03;59.5625;59.8125;56.5;56.5625;42687000 2000-10-04;56.375;56.5625;54.5;55.4375;68226700 2000-10-05;55.5;57.25;55.25;55.375;40549700 2000-10-06;55.8125;56.75;54.75;55.5625;30897000 2000-10-09;55.625;55.75;53;54.1875;29161800 2000-10-10;53.9375;55.5625;53.8125;54.5625;31033100 2000-10-11;54;56.9375;54;55.75;50602900 2000-10-12;56.3125;56.875;53.8125;54.375;45109800 2000-10-13;53.875;54.875;52.125;53.75;52260600 2000-10-16;53.5;53.8125;49.5625;50.375;59879500 2000-10-17;51.875;52.4375;50.25;50.4375;40638300 2000-10-18;49.625;53.25;48.4375;51.75;55268200 2000-10-19;58.4375;62.1875;58;61.875;128496600 2000-10-20;61.3125;66.125;61.125;65.1875;80189300 2000-10-23;64.625;66.25;60.6875;62.125;92585200 2000-10-24;62.625;62.9375;60.1875;61.5;47213700 2000-10-25;61.9375;63.4375;60.4375;61.25;83801900 2000-10-26;61;65.0625;60.8125;64.4375;57413300 2000-10-27;64.6875;69.1875;64.625;67.6875;62146200 2000-10-30;67.5;70.125;67.375;69.0625;55028800 2000-10-31;69;69.5;68;68.875;52237000 2000-11-01;68.5;70.0625;68.4375;69.625;40654700 2000-11-02;70.375;70.8438;69.625;70.3125;38992600 2000-11-03;69.25;69.625;68.0625;68.25;34355500 2000-11-06;68.6875;70.125;68.25;69.5;37425700 2000-11-07;69.75;71.875;69.5;70.5;52165600 2000-11-08;71.125;72.375;68;69.4375;103074700 2000-11-09;68.5;71.3125;68.4375;70.875;45529300 2000-11-10;69.9375;70.3125;66.8125;67.375;46872200 2000-11-13;66.6875;68.125;64.4062;66.4375;41682400 2000-11-14;68;69.8125;67.3125;68.8125;42109300 2000-11-15;69.0625;70.875;68.6875;70.0625;30211100 2000-11-16;69.4375;71.5;68.9375;68.9375;46064300 2000-11-17;69.4375;70;67.7969;69.0625;53262800 2000-11-20;68.125;68.5;65.5625;67.1875;40078600 2000-11-21;67.375;69.25;67.375;67.75;29743800 2000-11-22;66.0625;69.5;66;68.25;38171600 2000-11-24;69;70.4375;68.5;69.9375;17219600 2000-11-27;71.4375;72.25;70.625;70.6875;42653800 2000-11-28;69.375;69.75;66.8125;67;63723100 2000-11-29;66.8125;67.125;63.25;65.0625;49140200 2000-11-30;62;62.0625;57;57.375;98600400 2000-12-01;58.0625;60.625;56.0625;56.625;54904900 2000-12-04;57.25;59;55.1875;56.4375;40203600 2000-12-05;59.1875;60.5;58.25;59.875;50867200 2000-12-06;60;60.0625;56.0625;56.6875;45280400 2000-12-07;53.4375;54;52.25;53.125;72654200 2000-12-08;54.625;55.875;53.4375;54.4375;60469900 2000-12-11;55.5;58.75;55;58.0625;47788100 2000-12-12;57.8125;60;56.75;58.375;31553000 2000-12-13;60.5;60.5;56.8125;57.25;49180200 2000-12-14;57.9375;58.7344;55.375;55.5;35600700 2000-12-15;51.0469;52;47.75;49.1875;58449900 2000-12-18;49;50;47;47.8125;53593700 2000-12-19;47.4375;48;44.5;44.8125;60135900 2000-12-20;42.8125;44;41.375;41.5;74518900 2000-12-21;40.75;45.125;40.3125;43.4375;81586500 2000-12-22;44.75;47.125;44.75;46.4375;54775900 2000-12-26;46.875;48.5625;45.875;46.875;33470800 2000-12-27;46.125;46.8125;45;46.4375;34501900 2000-12-28;45.125;46.25;43.875;44.5625;38809600 2000-12-29;43.9375;45.8125;43;43.375;49988800 2001-01-02;44.125;45;42.875;43.375;41206600 2001-01-03;43.1875;48.875;43.125;47.9375;67981100 2001-01-04;47.8125;50.5;46.875;48.4375;56198500 2001-01-05;48.5;49.875;47.5625;49.125;46707300 2001-01-08;48.9375;49.75;46.6875;48.9375;39908800 2001-01-09;50;52.625;49.75;51.8125;57482700 2001-01-10;51;53.8125;50.75;52.875;45115100 2001-01-11;53;55.75;52.3125;55;50927400 2001-01-12;54.875;55;52.5;53.5;36856000 2001-01-16;53.375;53.5;51.125;52.5625;34231200 2001-01-17;53.625;54.875;52.5625;52.9375;36422100 2001-01-18;53.6875;56.1875;52.625;55.5;54894400 2001-01-19;60;61.4375;58.875;61;104674400 2001-01-22;60.75;61;59;60.125;38336500 2001-01-23;59.75;60.9375;58.9375;60.5625;35147600 2001-01-24;61;63.4375;60.75;62.9375;55227500 2001-01-25;62.75;64;61.5625;61.8125;42828700 2001-01-26;61;64.3125;61;64;46540000 2001-01-29;63.5625;64.625;63.5;64.5;42491900 2001-01-30;64.5;64.75;62.875;63.375;28638400 2001-01-31;63;63.75;61;61.0625;40949400 2001-02-01;60.8125;62.625;60.375;62.375;35896400 2001-02-02;62.5;63.375;60.75;60.8125;35550000 2001-02-05;60.75;62.0625;60.25;61.9375;25699600 2001-02-06;62.0625;63.8125;61.6875;62.5625;48221000 2001-02-07;62;65.0625;61.8125;64.6875;63030900 2001-02-08;63.75;64.5;62;62.25;44020600 2001-02-09;61.3125;61.5625;58.5;59.125;50287600 2001-02-12;58.8125;59.4375;57.1875;58.75;35644700 2001-02-13;59.625;61.0625;58.125;58.1875;38035300 2001-02-14;57.625;59;56.375;58.375;30864200 2001-02-15;59;60.1875;57.875;58.8125;32813900 2001-02-16;57;58.25;56.125;57.3125;33479200 2001-02-20;57.375;58.25;55.375;55.875;30365400 2001-02-21;55.25;58.0625;55.1875;56.25;31973600 2001-02-22;56.3125;56.8125;53.875;55.1875;50408200 2001-02-23;54.4375;57.5;54.3125;56.75;46310300 2001-02-26;57.625;59.9375;57.375;59.5625;43968400 2001-02-27;59.375;61.1875;58.6719;59.375;49574300 2001-02-28;59.5625;60.0781;58.1875;59;42304200 2001-03-01;58.5625;59.5;56.25;59.3594;40890800 2001-03-02;57.5;58.125;56.4375;56.6875;39900400 2001-03-05;57.25;58.625;56.5625;57.4375;24691800 2001-03-06;58.625;60;58.375;59.4375;33390900 2001-03-07;59.875;61.125;59.3125;60.6875;29871800 2001-03-08;60.3125;60.5938;58.4375;59.25;27313000 2001-03-09;57.9375;58.1875;54.875;56.6875;51897200 2001-03-12;54.6875;55;51.625;51.9375;57188000 2001-03-13;52.1875;54.75;52;54.1875;45517800 2001-03-14;52.5;55.25;52.1875;54;45343100 2001-03-15;55.3125;56.0781;53.5;53.6875;35819200 2001-03-16;52.5;55.125;52.4844;54.5625;56424400 2001-03-19;54.5;55.5;53.125;54.3125;30518200 2001-03-20;54.5625;56.125;52.625;52.6875;45911400 2001-03-21;52.25;53.25;49.75;50.0625;62494300 2001-03-22;50.5625;54.0625;50.5;54;63181600 2001-03-23;54.9375;57;54.375;56.5625;49759800 2001-03-26;57.125;57.5;55.5625;56.0625;31559300 2001-03-27;56.0625;58.5625;55.875;58.25;47567800 2001-03-28;57.375;57.9375;55.375;55.5625;39340800 2001-03-29;55.375;57.1875;54.5625;55.375;43492500 2001-03-30;55.75;56.1875;53.875;54.6875;45600800 2001-04-02;54.8125;56.9375;54.625;55.8125;37962000 2001-04-03;55.3125;55.3125;52.75;53.375;47093800 2001-04-04;53.375;55;51.0625;51.9375;52023300 2001-04-05;53.75;57.375;53.5;56.75;56682000 2001-04-06;56.375;57.1875;55.0625;56.1875;46311000 2001-04-09;56.57;57.42;55.66;57.15;28147800 2001-04-10;57.95;60.09;57.78;59.68;54599700 2001-04-11;60.65;61.5;59.7;60.04;54939800 2001-04-12;59.56;62.31;59.35;62.18;43760000 2001-04-16;61.4;61.58;60.12;60.79;32928700 2001-04-17;60.52;62.11;60.04;61.48;42574600 2001-04-18;63.39;66.31;63;65.43;78348200 2001-04-19;65.81;69;65.75;68.04;79687800 2001-04-20;70.3;71.1;68.5;69;96459800 2001-04-23;68.11;68.47;66.9;68.25;46085600 2001-04-24;68.2;69.93;67.14;67.55;44588300 2001-04-25;67.57;69.79;67.25;69.69;38372000 2001-04-26;70.07;71;68.25;69.13;59368800 2001-04-27;69.53;69.68;66.21;67.12;60786200 2001-04-30;68.53;69.06;67.68;67.75;37184100 2001-05-01;67.66;70.3;67.6;70.17;41851400 2001-05-02;71;71.15;69.35;69.76;46432200 2001-05-03;69.25;70.18;68.14;68.53;33136700 2001-05-04;68;71.05;67.96;70.75;59769200 2001-05-07;70.83;72.15;70.7;71.38;54678100 2001-05-08;71.75;72.1;70.75;72.06;37542000 2001-05-09;71.24;71.3;69.86;70.4;38338300 2001-05-10;71.13;71.24;69.96;70;32167300 2001-05-11;69.96;70;68.65;69.4;25564400 2001-05-14;69.13;69.2;68.3;68.72;22484000 2001-05-15;68.74;69.3;68;68.27;30692800 2001-05-16;67.7;69.88;67.33;69.16;45946900 2001-05-17;69.1;70.14;67.55;68.17;53492400 2001-05-18;67.69;69.2;67.25;68.09;45302700 2001-05-21;68.05;69.99;67.75;68.79;51745800 2001-05-22;69.45;70.35;69.18;70.31;41727800 2001-05-23;70.39;71.6;69.51;69.7;46818700 2001-05-24;69.94;71.78;69.27;71.72;40390800 2001-05-25;71.66;71.9;70.36;70.91;26373800 2001-05-29;70.8;71.75;70.05;70.34;35605400 2001-05-30;69.56;70.58;68.65;69.19;43250900 2001-05-31;69.49;70.38;68.4;69.18;35341300 2001-06-01;69.6;70.7;68.7;70.34;28793800 2001-06-04;70.55;71.02;69.8;70.78;21868300 2001-06-05;70.76;73.08;70.5;72.6;44727100 2001-06-06;72.89;73.48;71.55;72.36;40011400 2001-06-07;72.12;73.73;72.08;73.68;33480000 2001-06-08;73.7;73.75;72.05;73.19;25933500 2001-06-11;72.85;72.85;71.51;72.12;23672800 2001-06-12;71.02;72.41;70.81;72.08;33357300 2001-06-13;72.05;72.3;70.64;70.69;27651200 2001-06-14;70.22;70.55;68.4;68.9;35986200 2001-06-15;67.51;68.3;66.4;68.02;54177200 2001-06-18;67.95;67.96;66.01;66.88;28423400 2001-06-19;68.21;68.85;66.85;67.32;31728700 2001-06-20;67.14;69.59;67.1;69.41;32054200 2001-06-21;69.15;70.55;68.92;69.84;34801900 2001-06-22;70;70.61;68.58;68.83;25546000 2001-06-25;69.1;69.81;67.77;68.85;24607800 2001-06-26;67.82;70.21;67.7;70.14;31538500 2001-06-27;69.86;71.53;69.36;71.14;34599900 2001-06-28;71.55;76.15;70.53;72.74;64487800 2001-06-29;72.6;73.41;71.4;73;47141900 2001-07-02;72.05;73.15;70.15;70.6;36405100 2001-07-03;70.3;70.8;69.93;70.47;14018700 2001-07-05;70.22;70.72;68.44;68.51;24621300 2001-07-06;68.3;68.4;65.67;66.06;33733900 2001-07-09;66.2;66.91;65.04;65.69;33238300 2001-07-10;65.9;66.25;64.35;64.48;33281300 2001-07-11;64.21;66.75;64.2;66.5;36911300 2001-07-12;70.7;72.05;70.33;71.6;64039000 2001-07-13;71.4;72;70.94;71.34;29467300 2001-07-16;71.45;72.16;70.15;71.18;27995400 2001-07-17;70.66;72.01;70.14;71.82;31620500 2001-07-18;70.6;71.5;69.87;70.57;28795400 2001-07-19;71.22;73;71.22;72.57;38274700 2001-07-20;68.03;69.4;67.94;69.18;62101800 2001-07-23;69.24;69.24;66.35;67.09;39999700 2001-07-24;67;67.99;65.7;66.32;33765100 2001-07-25;66.26;67.52;65.61;67.48;37032700 2001-07-26;67.12;67.32;65.5;66.59;38987000 2001-07-27;66.05;66.25;65.05;65.47;32698000 2001-07-30;65.65;66.88;65.54;65.8;21098200 2001-07-31;66.01;67.39;65.85;66.19;29515800 2001-08-01;66.8;66.81;65.76;66.47;27839500 2001-08-02;67.21;67.54;66.26;67.45;27099200 2001-08-03;67.3;67.36;66;66.89;21630200 2001-08-06;66.53;67.12;65.68;66.13;13915800 2001-08-07;66.04;67.05;65.99;66.35;15673900 2001-08-08;66.51;67.24;64.49;64.86;27498200 2001-08-09;64.98;65.55;64.3;65.01;22768100 2001-08-10;64.77;65.86;62.9;65.52;25878200 2001-08-13;65.24;65.99;64.75;65.83;16337700 2001-08-14;65.75;66.09;64.45;64.69;18240600 2001-08-15;64.71;65.05;63.2;63.2;19751500 2001-08-16;62.84;64.71;62.7;64.62;21952800 2001-08-17;63.78;64.13;61.5;61.88;26117100 2001-08-20;61.66;62.75;61.1;62.7;24185600 2001-08-21;62.7;63.2;60.71;60.78;23555900 2001-08-22;61.13;61.15;59.08;60.66;39053600 2001-08-23;60.67;61.53;59;59.12;25906600 2001-08-24;59.6;62.28;59.23;62.05;31699500 2001-08-27;61.9;63.36;61.57;62.31;22281400 2001-08-28;62.34;62.95;60.58;60.74;23711400 2001-08-29;61.05;61.3;59.54;60.25;24085000 2001-08-30;59.04;59.66;56.52;56.94;48816000 2001-08-31;56.85;58.06;56.3;57.05;28950400 2001-09-04;57.19;59.08;56.07;56.1;33594600 2001-09-05;56.18;58.39;55.39;57.74;44735300 2001-09-06;56.56;58.39;55.9;56.02;56178400 2001-09-07;56.11;57.36;55.31;55.4;44931900 2001-09-10;54.92;57.95;54.7;57.58;42235900 2001-09-17;54.02;55.1;52.8;52.91;63751000 2001-09-18;53.41;55;53.17;54.32;41591300 2001-09-19;54.46;54.7;50.6;53.87;63475100 2001-09-20;52.35;52.61;50.67;50.76;58991600 2001-09-21;47.92;50.6;47.5;49.71;92488300 2001-09-24;50.65;52.45;49.87;52.01;42790100 2001-09-25;52.27;53;50.16;51.3;42470300 2001-09-26;51.51;51.8;49.55;50.27;29262200 2001-09-27;50.1;50.68;48;49.96;40595600fBasics/R/0000755000176200001440000000000013203500424012016 5ustar liggesusersfBasics/R/utils-listIndex.R0000644000176200001440000000305013202116741015244 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # listIndex Extracts R package index ################################################################################ listIndex <- function(package, character.only = FALSE) { ## A function implemented by Diethelm Wuertz & Yohan Chalabi ## Extracts R package index ## Example: ## listIndex("timeSeries") ### --> ../man/utils-listIndex.Rd ## ~~~~~~~~~~~~~~~~~~ if (!character.only) package <- as.character(substitute(package)) ans <- library(help = package, character.only=TRUE) index <- ans$info[[2]] cat("\n", package, "Index:\n\n") cat(paste(" ", index), sep = "\n") } ################################################################################ fBasics/R/stats-sampleLmoments.R0000644000176200001440000000472413202116742016311 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # sampleLmoments Computes sample L-moments ################################################################################ sampleLmoments <- function(x, rmax=4) { # A function implemented by Diethelm Wuertz # Description # Computes sample L-moments # Note: # This function is borrowed from package ... # Author: # FUNCTION: # L Moments: data <- as.matrix(x) n <- dim(data)[1] p <- dim(data)[2] x <- array(, c(p, n)) L <- array(, c(p, rmax)) for (i in 1:p) x[i, ] <- sort(data[, i]) if (rmax == 1) return(rowMeans(x)) bcoef <- array(, c(rmax, n)) bcoefm <- array(, c(rmax, p, n)) b <- array(, c(p, rmax)) bcoef[1, ] <- seq(0, 1, by = (1/(n-1))) bcoefm[1, , ] <- t(array(rep(bcoef[1, ], p), c(n, p))) b[, 1] <- rowMeans(x) b[, 2] <- rowMeans(bcoefm[1, , ] * x) L[, 1] = b[, 1] if (rmax > 2) { for (r in 2:(rmax-1)) { rr <- r+1 bcoef[r, ]<-bcoef[r-1,]*seq((-(r-1)/(n-r)),1, by = (1/(n-r))) bcoefm[r, , ]<-t(array(rep(bcoef[r,],p),c(n, p))) b[, rr] <- rowMeans(bcoefm[r, , ]*x) } } for (r in 1:(rmax-1)) { L[, r+1] <- 0 for (k in 0:r) { kk <- k+1 L[, r+1] <- L[, r+1]+(-1)^(r-k)*gamma(r+k+1) / (gamma(k+1)^2) / gamma(r-k+1)*b[, kk] } } L = as.vector(L) names(L) = paste("L", 1:rmax, sep = "") # Return Value: L } ################################################################################ fBasics/R/matrix-tslag.R0000644000176200001440000000520113202116742014560 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # TIME SERIES DESCRIPTION: # tslag Lagged/leading vector/matrix of selected orders # .tslag1 Internal Function used by tslag ################################################################################ tslag <- function(x, k = 1, trim = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Creates a lagged or leading vector/matrix of selected order(s). # Arguments: # x - a vector of data, missing values (NA) are allowed. # k - the number of positions the new series is to lag # or to lead the input series. # trim - a logical flag, if TRUE, the missing values at the # beginning or end of the returned series will be trimmed. # The default value is FALSE. # Details: # With a positive value of "k" we get a lagged series and with # a negative value we get a leading series. # Examples: # tslag(rnorm(10), 2) # tslag(rnorm(10), -2:2) # tslag(rnorm(10), -2:2, trim = TRUE) # FUNCTION: # Bind: ans = NULL for ( i in k) { ans = cbind(ans, .tslag1(x, i)) } # Trim: if (trim) { indexes = (1:length(ans[,1]))[!is.na(apply(ans, 1, sum))] ans = ans[indexes, ] } # As Vector: if (length(k) == 1) ans = as.vector(ans) # Return Value: ans } # ------------------------------------------------------------------------------ .tslag1 <- function(x, k) { # A function implemented by Diethelm Wuertz # Description: # Internal Function used by function tslag. # FUNCTION: y = x if (k > 0) y = c(rep(NA, times = k), x[1:(length(x)-k)]) if (k < 0) y = c(x[(-k+1):length(x)], rep(NA, times = -k)) # Return Value: y } ################################################################################ fBasics/R/utils-colIds.R0000644000176200001440000000630513202116742014525 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # GENERATION: DESCRIPTION: # colIds Retrieves column names of a matrix-like object # rowIds Retrieves row names of a matrix-like object # colIds<- Sets column names of a matrix-like object # rowIds<- Sets row names of a matrix-like object ################################################################################ colIds <- function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # Retrieves row names of a matrix-like object # FUNCTION: # Convert to Matrix x = as.matrix(x) # Return Value: colnames(x, ...) } # ------------------------------------------------------------------------------ rowIds <- function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # Retrieves row names of a matrix-like object # FUNCTION: # Convert to Matrix x = as.matrix(x) # Return Value: rownames(x, ...) } # ------------------------------------------------------------------------------ "colIds<-" <- function(x, value) { # A function implemented by Diethelm Wuertz # Description: # Sets column names of a matrix-like object # FUNCTION: # Column Names: dn = dimnames(x) if(is.null(dn)) { if(is.null(value)) return(x) if((nd = length(dim(x))) < 2) stop("Object has less than two dimensions") dn = vector("list", nd) } if(length(dn) < 2) stop("Object has less than two dimensions") if(is.null(value)) dn[2] = list(NULL) else dn[[2]] = value dimnames(x) = dn # Return Value: x } # ------------------------------------------------------------------------------ "rowIds<-" <- function(x, value) { # A function implemented by Diethelm Wuertz # Description: # Sets row names of a matrix-like object # FUNCTION: # Row names: dn = dimnames(x) if(is.null(dn)) { if(is.null(value)) return(x) if((nd = length(dim(x))) < 1) stop("attempt to set rownames on object with no dimensions") dn = vector("list", nd) } if(length(dn) < 1) stop("attempt to set rownames on object with no dimensions") if(is.null(value)) dn[1] = list(NULL) else dn[[1]] = value dimnames(x) = dn # Return Value: x } ################################################################################ fBasics/R/gui-hypSlider.R0000644000176200001440000000722713202116741014702 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA # Copyrights (C) # for this R-port: # 1999 - 2008, Diethelm Wuertz, Rmetrics Foundation, GPL # Diethelm Wuertz # www.rmetrics.org # for the code accessed (or partly included) from other R-ports: # see R's copyright and license files # for the code accessed (or partly included) from contributed R-ports # and other sources # see Rmetrics's copyright file ################################################################################ # FUNCTION: DESCRIPTION: # hypSlider Displays hyperbolic distribution function ################################################################################ hypSlider <- function() { # A function implemented by Diethelm Wuertz # Description: # Displays interactively Hyperbolic Function # Details: # Hyperbolic Distribution: # dhyp(x, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c(1, 2, 3, 4)) # FUNCTION: # Internal Function: refresh.code = function(...) { # Sliders: N = .sliderMenu(no = 1) alpha = .sliderMenu(no = 2) beta = .sliderMenu(no = 3) delta = .sliderMenu(no = 4) mu = .sliderMenu(no = 5) pm = .sliderMenu(no = 6) # Plot Data: xmin = round(qhyp(0.01, alpha, beta, delta, mu, pm), digits = 2) xmax = round(qhyp(0.99, alpha, beta, delta, mu, pm), digits = 2) s = seq(xmin, xmax, length = N) y1 = dhyp(s, alpha, beta, delta, mu, pm) y2 = phyp(s, alpha, beta, delta, mu, pm) main1 = paste("HYP Density\n", "alpha = ", as.character(alpha), " | ", "beta = ", as.character(beta), " | ", "delta = ", as.character(delta), " | ", "mu = ", as.character(mu) ) main2 = paste("HYP Probability\n", "xmin 0.01% = ", as.character(xmin), " | ", "xmax 0.99% = ", as.character(xmax), " | ", "pm = ", as.character(pm) ) # Frame par(mfrow = c(2, 1), cex = 0.7) # Density: plot(s, y1, type = "l", xlim = c(xmin, xmax), col = "steelblue") abline (h = 0, lty = 3) title(main = main1) # Probability: plot(s, y2, type = "l", xlim = c(xmin, xmax), ylim = c(0, 1), col = "steelblue" ) abline(h = 0.0, lty = 3) abline(h = 1.0, lty = 3) abline(h = 0.5, lty = 3) abline(v = mu, lty = 3, col = "red") title(main = main2) # Reset Frame: par(mfrow = c(1, 1), cex = 0.7) } # Open Slider Menu: .sliderMenu(refresh.code, names = c( "N","alpha","beta","delta", "mu","pm"), minima = c( 50, 0.00, -2.00, 0.00, -5.0, 1), maxima = c(1000, 2.00, +2.00, 5.00, +5.0, 4), resolutions = c( 50, 0.20, 0.20, 1.00, 1.0, 1), starts = c( 50, 1.00, 0.00, 1.00, 0.0, 1)) } ################################################################################ fBasics/R/dist-ghMoments.R0000644000176200001440000003103713202116741015053 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghMean Returns true GH mean # ghVar Returns true GH variance # ghSkew Returns true GH skewness # ghKurt Returns true GH kurtosis # FUNCTION: DESCRIPTION: # ghMoments Returns true GH moments # FUNCTION: UTILITY FUNCTION: # .aRecursionGH Computes the moment coefficients a recursively # .besselZ Computes Bessel/Power Function ratio # FUNCTION: MOMENTS ABOUT MU: # .ghMuMoments Computes mu-moments from formula # .ghMuMomentsIntegrated Computes mu-moments by integration # .checkGHMuMoments Checks mu-moments # FUNCTION: MOMENTS ABOUT ZERO: # .ghRawMoments Computes raw moments from formula # .ghRawMomentsIntegrated Computes raw moments by Integration # .checkGHRawMoments Checks raw moments # FUNCTION: MOMENTS ABOUT MEAN: # .ghCentralMoments Computes central moments from formula ################################################################################ ghMean <- function(alpha=1, beta=0, delta=1, mu=0, lambda=-1/2) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: zeta = delta * sqrt(alpha*alpha-beta*beta) mean = mu + beta * delta^2 * .kappaGH(zeta, lambda) mean } # ------------------------------------------------------------------------------ ghVar <- function(alpha=1, beta=0, delta=1, mu=0, lambda=-1/2) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: var = .ghCentralMoments(k=2, alpha, beta, delta, mu, lambda)[[1]] var } # ------------------------------------------------------------------------------ ghSkew <- function(alpha=1, beta=0, delta=1, mu=0, lambda=-1/2) { # A function implemented by Diethelm Wuertz # FUNCTION: # Moments: k2 = .ghCentralMoments(k=2, alpha, beta, delta, mu, lambda)[[1]] k3 = .ghCentralMoments(k=3, alpha, beta, delta, mu, lambda)[[1]] # Return Value: skew = k3/(k2^(3/2)) skew } # ------------------------------------------------------------------------------ ghKurt <- function(alpha=1, beta=0, delta=1, mu=0, lambda=-1/2) { # A function implemented by Diethelm Wuertz # FUNCTION: # Moments: k2 = .ghCentralMoments(k=2, alpha, beta, delta, mu, lambda)[[1]] k4 = .ghCentralMoments(k=4, alpha, beta, delta, mu, lambda)[[1]] # Return Value: kurt = k4/k2^2 - 3 kurt } ################################################################################ ghMoments <- function(order, type = c("raw", "central", "mu"), alpha=1, beta=0, delta=1, mu=0, lambda=-1/2) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns moments of the GH distribution # FUNCTION: # Settings: type = match.arg(type) # Moments: if (type == "raw") { ans = .ghRawMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "central") { ans = .ghCentralMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "mu") { ans = .ghMuMoments(order, alpha, beta, delta, mu, lambda) } # Return Value: ans } ################################################################################ .aRecursionGH <- function(k = 12, trace = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Computes the moment coefficients recursively # Example: # .aRecursionGH() # [,1] [,2] [,3] [,4] [,5] [,6] [,7] [,8] [,9] [,10] [,11] [,12] # [1,] 1 0 0 0 0 0 0 0 0 0 0 0 # [2,] 1 1 0 0 0 0 0 0 0 0 0 0 # [3,] 0 3 1 0 0 0 0 0 0 0 0 0 # [4,] 0 3 6 1 0 0 0 0 0 0 0 0 # [5,] 0 0 15 10 1 0 0 0 0 0 0 0 # [6,] 0 0 15 45 15 1 0 0 0 0 0 0 # [7,] 0 0 0 105 105 21 1 0 0 0 0 0 # [8,] 0 0 0 105 420 210 28 1 0 0 0 0 # [9,] 0 0 0 0 945 1260 378 36 1 0 0 0 #[10,] 0 0 0 0 945 4725 3150 630 45 1 0 0 #[11,] 0 0 0 0 0 10395 17325 6930 990 55 1 0 #[12,] 0 0 0 0 0 10395 62370 51975 13860 1485 66 1 # FUNCTION: # Setting Start Values: a = matrix(rep(0, times = k*k), ncol = k) a[1, 1] = 1 if (k > 1) a[2, 1] = 1 # Compute all Cofficients by Recursion: if (k > 1) { for (d in 2:k) { for (l in 2:d) { a[d,l] = a[d-1, l-1] + a[d-1, l]*(2*l+1-d) } } } rownames(a) = paste("k=", 1:k, sep = "") colnames(a) = paste("l=", 1:k, sep = "") # Trace: if (trace) { cat("\n") print(a) cat("\n") } for (K in 1:k) { L = trunc((K+1)/2):K M = 2*L-K s1 = as.character(a[K, L]) s2 = paste("delta^", 2*L, sep = "") s3 = paste("beta^", M, sep = "") s4 = paste("Z_lambda+", L, sep = "" ) if (trace) { cat("k =", K, "\n") print(s1) print(s2) print(s3) print(s4) cat("\n") } } if (trace) cat("\n") # Return Value: list(a = a[k, L], delta = 2*L, beta = M, besselOffset = L) } # ------------------------------------------------------------------------------ .besselZ <- function(x, lambda) { # A function implemented by Diethelm Wuertz # Description: # Computes Bessel/Power Function ratio # Ratio: ratio = besselK(x, lambda)/x^lambda # Return Value: ratio } ################################################################################ .ghMuMoments <- function(k = 4, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Computes mu moments from formula # Note: # mu is not used. # FUNCTION: # Check parameters: if (lambda >= 0) stopifnot(abs(beta) < alpha) if (lambda < 0) stopifnot(abs(beta) <= alpha) if (lambda > 0) stopifnot(delta >= 0) if (lambda <= 0) stopifnot(delta > 0) zeta = delta*sqrt(alpha^2-beta^2) cLambda = 1/.besselZ(zeta, lambda) a = .aRecursionGH(k) coeff = a$a deltaPow = a$delta betaPow = a$beta besselIndex = lambda + a$besselOffset M = coeff * delta^deltaPow * beta^betaPow * .besselZ(zeta, besselIndex) ans = cLambda * sum(M) attr(ans, "M") <- M # Return Value: ans } # ------------------------------------------------------------------------------ .ghMuMomentsIntegrated <- function(k = 4, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Computes mu moments by integration # FUNCTION: # Check parameters: if (lambda >= 0) stopifnot(abs(beta) < alpha) if (lambda < 0) stopifnot(abs(beta) <= alpha) if (lambda > 0) stopifnot(delta >= 0) if (lambda <= 0) stopifnot(delta > 0) mgh <- function(x, k, alpha, beta, delta, lambda) { x^k * dgh(x, alpha, beta, delta, mu=0, lambda) } M = integrate(mgh, -Inf, Inf, k = k, alpha = alpha, beta = beta, delta = delta, lambda = lambda, subdivisions = 1000, rel.tol = .Machine$double.eps^0.5)[[1]] # Return Value: M } # ------------------------------------------------------------------------------ .checkGHMuMoments <- function(K = 10) { # A function implemented by Diethelm Wuertz # Description: # Checks mu moments # Example: # .checkGHMuMoments() # FUNCTION: # Compute Raw Moments: mu = NULL for (k in 1:K) { mu = c(mu, .ghMuMoments(k, alpha = 1.1, beta = 0.1, delta = 0.9, mu = 0.1)) } names(mu) = 1:K int = NULL for (k in 1:K) { int = c(int, .ghMuMomentsIntegrated(k, alpha = 1.1, beta = 0.1, delta = 0.9, mu = 0.1)) } names(int) = NULL # Return Value: rbind(mu, int) } # ------------------------------------------------------------------------------ .ghRawMoments <- function(k = 4, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Computes mu-moments from formula # FUNCTION: # Settings: binomCoeff = choose(k, 0:k) # Compute Mu Moments: M = 1 for (l in 1:k) M = c(M, .ghMuMoments(l, alpha, beta, delta, mu, lambda)) muPower = mu^(k:0) muM = binomCoeff * muPower * M # Return Value: sum(muM) } # ------------------------------------------------------------------------------ .ghRawMomentsIntegrated <- function(k = 4, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Computes mu-moments by integration # FUNCTION: # Check parameters: if (lambda >= 0) stopifnot(abs(beta) < alpha) if (lambda < 0) stopifnot(abs(beta) <= alpha) if (lambda > 0) stopifnot(delta >= 0) if (lambda <= 0) stopifnot(delta > 0) # Compute Mu Moments by Integration: mgh <- function(x, k, alpha, beta, delta, mu, lambda) { x^k * dgh(x, alpha, beta, delta, mu, lambda) } M = integrate(mgh, -Inf, Inf, k = k, alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda, subdivisions = 1000, rel.tol = .Machine$double.eps^0.5)[[1]] # Return Value: M } # ------------------------------------------------------------------------------ .checkGHRawMoments <- function(K = 10) { # A function implemented by Diethelm Wuertz # Description: # Checks raw-moments # Example: # .checkGHRawMoments() # FUNCTION: raw = NULL for (k in 1:K) { raw = c(raw, .ghRawMoments(k, alpha = 1.1, beta = 0.1, delta = 0.9, mu = 0.1)) } names(raw) = 1:K int = NULL for (k in 1:K) { int = c(int, .ghRawMomentsIntegrated(k, alpha = 1.1, beta = 0.1, delta = 0.9, mu = 0.1)) } names(int) = NULL # Return Value: rbind(raw,int) } ################################################################################ .ghCentralMoments <- function (k = 4, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { zeta = delta * sqrt(alpha*alpha-beta*beta) mean = mu + beta * delta^2 * .kappaGH(zeta, lambda) M = 1 for (i in 1:k) M = c(M, .ghMuMoments(i, alpha, beta, delta, mu, lambda)) binomCoeff <- choose(k, 0:k) centralPower <- (mu - mean)^(k:0) centralM <- binomCoeff * centralPower * M sum(centralM) } ################################################################################ fBasics/R/dist-normFit.R0000644000176200001440000000610513202116741014526 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .normFit Fits parameters of a Normal density ################################################################################ # normFit is now in fBasics # ------------------------------------------------------------------------------ .normFit <- function(x, doplot = TRUE, span = "auto", title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Return Maximum log-likelihood estimated # Paramters for Normal Distribution # Notes: # Function Calls: nlminb(), density() # The function normFit() can be found in the Rmetrics # chapter GarchDistributions. # FUNCTION: # Transform: x.orig = x x = as.vector(x) # Settings: CALL = match.call() # MLE: N = length(x) mean = sum(x)/N sd = sqrt(sum((x-mean)^2)/N) # Optional Plot: if (doplot) { if (span == "auto") { span.min = qnorm(0.001, mean, sd) span.max = qnorm(0.999, mean, sd) span = seq(span.min, span.max, length = 100) } par(err = -1) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dnorm(span, mean, sd) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("NORMAL: Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") if (exists("grid")) grid() } # Add Title and Description: if (is.null(title)) title = "Normal Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list( estimate = c(mean = mean, sd = sd), minimum = sum(log(dnorm(x, mean, sd))), code = NA) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Normal Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ nFit <- .normFit ################################################################################ fBasics/R/gui-HeavisideSlider.R0000644000176200001440000000506313202116741015777 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: HEAVISIDE SLIDER: # .heavisideSlider Displays Heaviside and related functions ################################################################################ .heavisideSlider <- function() { # A function implemented by Diethelm Wuertz # Description # Displays Heaviside and related functions # FUNCTION: # Internal Function: refresh.code = function(...) { # Sliders: a = .sliderMenu(no = 1) by = .sliderMenu(no = 2) # Frame: par(mfrow = c(2, 2), cex = 0.7) # FGN TimeSeries: x = seq(-10, 10, by = by) H = Heaviside(x, a) Sign = Sign(x, a) Delta = Delta(x, a) Boxcar = Boxcar(x, a) Ramp = Ramp(x, a) plot(x, H, type = "b", ylim = c(-1, 1), col = "steelblue", pch = 19) title(main = paste("Heaviside | a =", a)) grid() plot(x, Sign, type = "b", ylim = c(-1, 1), col = "steelblue", pch = 19) title(main = paste("Sign | a =", a)) grid() plot(x, Boxcar, type = "b", ylim = c(-1, 1), col = "steelblue", pch = 19) title(main = paste("Boxcar | a =", a)) grid() plot(x, Ramp, type = "b", col = "steelblue", pch = 19) title(main = paste("Ramp | a =", a)) grid() # Reset Frame: par(mfrow = c(1, 1), cex = 0.7) } # Open Slider Menu: .sliderMenu(refresh.code, names = c( "a", "by"), minima = c( -10, 0.1), maxima = c( 10, 1.0), resolutions = c( 0.1, 0.1), starts = c( 0, 0.2)) } ################################################################################ fBasics/R/dist-sght.R0000644000176200001440000001033613202116742014057 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dsght Standardized generalized hyperbolic Student-t # psght Probability of the Standardized GHT # qsght Quantiles of the Standardized GHT # rsght Random variates of the Standardized GHT ################################################################################ dsght <- function(x, beta = 0.1, delta = 1, mu = 0, nu = 10, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density of the generalized hyperbolic Student-t # Arguments: # Example: # x = (-5):5; dght(x) # FUNCTION: # Parameters: if (length(beta) == 4) { nu = beta[4] mu = beta[3] delta = beta[2] beta = beta[1] } # Density: ans = dgh(x, alpha = abs(beta) + 1e-6, beta, delta, mu, lambda = -nu/2, log = log) # Return Value: ans } # ------------------------------------------------------------------------------ psght <- function(q, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns probabilities of the generalized hyperbolic Student-t # Arguments: # Example: # q = (-5):5; pght(q) # FUNCTION: # Cumulative Probability: ans = NULL for (Q in q) { Integral = integrate(dght, -Inf, Q, stop.on.error = FALSE, beta = beta, delta = delta, mu = mu, nu = nu) ans = c(ans, as.numeric(unlist(Integral)[1]) ) } # Return Value: ans } # ------------------------------------------------------------------------------ qsght <- function(p, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of the generalized hyperbolic Student-t # Arguments: # Example: # p = (1:9)/10; qght(p); round(pght(qght(p)), digits = 4) # FUNCTION: # Internal Functions: .froot <- function(x, beta = beta, delta = delta, mu = mu, nu = nu, p) { pght(q = x, beta = beta, delta = delta, mu = mu, nu = nu) - p } # Loop over all p's: result = NULL for (pp in p) { lower = -1 upper = +1 counter = 0 iteration = NA while (is.na(iteration)) { iteration = .unirootNA(f = .froot, interval = c(lower, upper), beta = beta, delta = delta, mu = mu, nu = nu, p = pp) counter = counter + 1 lower = lower - 2^counter upper = upper + 2^counter } result = c(result, iteration) } # Return Value: ans = result + mu ans } # ------------------------------------------------------------------------------ rsght <- function(n, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns random Variates of generalized hyperbolic Student-t # Arguments: # Example: # r = rght(10) # FUNCTION: # Random Variates: x = rgh(n, alpha = abs(beta) + 1e-6, beta = beta, delta = delta, mu = mu, lambda = -nu/2) # Return Value: x } ################################################################################ fBasics/R/test-ks2Test.R0000644000176200001440000000577713202116741014501 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ks2Test Performs a two sample Kolmogorov-Smirnov test ################################################################################ ks2Test <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Two-sample Kolmogorov-Smirnov test. # Arguments: # x - a numeric vector of data values. # description - a brief description of the project of type # character. # title - a character string which allows for a project title. # Note: # A function partly copied from "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Compute Test: two.sided = ks.test(x = x, y = y, alternative = "two.sided") exact = ks.test(x = x, y = y, exact = TRUE, alternative = "two.sided") less = ks.test(x = x, y = y, alternative = "less") greater = ks.test(x = x, y = y, alternative = "greater") # P Value: PVAL = c( two.sided$p.value, exact$p.value, less$p.value, greater$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Exact Two-Sided", "Alternative Less", "Alternative Greater") test$p.value = PVAL # Statistic: STATISTIC = c( two.sided$statistic, less$statistic, greater$statistic) names(STATISTIC) = c( "D | Two Sided", " D^- | Less", "D^+ | Greater") test$statistic = STATISTIC # Add: if (is.null(title)) title = "Kolmogorov-Smirnov Two Sample Test" if (is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/R/dist-ghMode.R0000644000176200001440000000320713202116742014314 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghMode Computes mode of the generalized hyperbolic DF ################################################################################ ghMode <- function(alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Computes the mode of the Generalized Hyperbolic PDF # FUNCTION: # Find Maximum: min = qgh(0.01, alpha, beta, delta, mu, lambda) max = qgh(0.99, alpha, beta, delta, mu, lambda) ans = optimize(f = dgh, interval = c(min, max), alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda, maximum = TRUE, tol = .Machine$double.eps)$maximum # Return Value: ans } ################################################################################ fBasics/R/utils-interactivePlot.R0000644000176200001440000001100013202116742016450 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: PLOT UTILITIES: # interactivePlot Plots several graphs interactively ################################################################################ interactivePlot <- function(x, choices = paste("Plot", 1:9), plotFUN = paste("plot.", 1:9, sep = ""), which = "all", ...) { # A function implemented by Diethelm Wuertz # Description: # Plot method for an object of class "template". # Arguments: # x - an object to be plotted # choices - the character string for the choice menu # plotFUN - the names of the plot functions # which - plot selection, which graph should be # displayed. If a character string named "ask" the # user is interactively asked which to plot, if # a logical vector of length N, those plots which # are set "TRUE" are displayed, if a character string # named "all" all plots are displayed. # Note: # At maximum 9 plots are supported. # FUNCTION: # Some cecks: if (length(choices) != length(plotFUN)) stop("Arguments choices and plotFUN must be of same length.") if (length(which) > length(choices)) stop("Arguments which has incorrect length.") if (length(which) > length(plotFUN)) stop("Arguments which has incorrect length.") if (length(choices) > 9) stop("Sorry, only 9 plots at max are supported.") # Internal "askPlot" Function: multPlot = function(x, choices, ...) { # Selective Plot: selectivePlot <- function(x, choices, FUN, which){ # Internal Function: askPlot <- function(x, choices, FUN) { # Pick and Plot: pick = 1 setRmetricsOptions(n.plots = length(choices)) while (pick > 0) { pick = menu ( choices = paste("plot:", choices), title = "\nMake a plot selection (or 0 to exit):") if (pick > 0) match.fun(FUN[pick])(x) } } if (as.character(which[1]) == "ask") { askPlot(x, choices = choices, FUN = FUN, ...) } else { for (i in 1:getRmetricsOptions("n.plots")) if (which[i]) match.fun(FUN[i])(x) } invisible() } # match Functions, up to nine ... if (length(plotFUN) < 9) plotFUN = c(plotFUN, rep(plotFUN[1], times = 9 - length(plotFUN))) plot.1 = match.fun(plotFUN[1]); plot.2 = match.fun(plotFUN[2]) plot.3 = match.fun(plotFUN[3]); plot.4 = match.fun(plotFUN[4]) plot.5 = match.fun(plotFUN[5]); plot.6 = match.fun(plotFUN[6]) plot.7 = match.fun(plotFUN[7]); plot.8 = match.fun(plotFUN[8]) plot.9 = match.fun(plotFUN[9]) pick = 1 while (pick > 0) { pick = menu ( ### choices = paste("plot:", choices), choices = paste(" ", choices), title = "\nMake a plot selection (or 0 to exit):") # up to 9 plot functions ... switch (pick, plot.1(x), plot.2(x), plot.3(x), plot.4(x), plot.5(x), plot.6(x), plot.7(x), plot.8(x), plot.9(x) ) } } # Plot: if (is.numeric(which)) { Which = rep(FALSE, times = length(choices)) Which[which] = TRUE which = Which } if (which[1] == "all") { which = rep(TRUE, times = length(choices)) } if (which[1] == "ask") { multPlot(x, choices, ...) } else { for ( i in 1:length(which) ) { FUN = match.fun(plotFUN[i]) if (which[i]) FUN(x) } } # Return Value: invisible(x) } ################################################################################ fBasics/R/builtin-gelGmm.R0000644000176200001440000004574413202116741015037 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # .rho # .get_lamb # .gel # .smooth_g # .bwNeweyWest2 # .summary.gel # .get_dat ################################################################################ # Code borrowed from # R's contributed package "gmm" written by Pierre Chausse. # Rmetrics: # Note that gmm is not available on Debian as of 2009-04-28. # To run these functions under Debian/Rmetrics we have them # implemented here as a builtin. # We also made modifications for tailored usage with Rmetrics. # Note that the dependences in the original package requires zoo # which may create conflicts with Rmetrics timeDate/timeSeries. # Package: gmm # Version: 1.0-4 # Date: 2009-03-10 # Title: Generalized Method of Moments and Generalized Empirical Likelihood # Author: Pierre Chausse # Maintainer: Pierre Chausse # Description: It is a complete suite to estimate models based on moment # conditions. It includes the two step Generalized method of moments # (GMM) of Hansen(1982), the iterated GMM and continuous updated # estimator (CUE) of Hansen-Eaton-Yaron(1996) and several methods that # belong to the Generalized Empirical Likelihood (GEL) family of estimators, # as presented by Smith(1997), Kitamura(1997), Newey-Smith(2004) and # Anatolyev(2005). # Depends: R (>= 2.0.0), sandwich, tseries, mvtnorm # Imports: stats # License: GPL (>= 2) # ------------------------------------------------------------------------------ .rho <- function(x, lamb, derive = 0, type = c("EL", "ET", "CUE"), drop = TRUE) { type <- match.arg(type) lamb <- matrix(lamb,ncol=1) gml <- x%*%lamb ch <- 0 if (derive==0) { if (type == "EL") { ch <- sum(gml>=1) if (drop) { gml <- (gml<1)*gml rhomat <- log(1-gml) } else { if (ch>0) rhomat <- NaN else rhomat <- log(1-gml) } } if (type == "ET") rhomat <- -exp(gml) if (type == "CUE") rhomat <- -gml -0.5*gml^2 } if (derive==1) { if (type == "EL") rhomat <- -1/(1-gml) if (type == "ET") rhomat <- -exp(gml) if (type == "CUE") rhomat <- -1 -gml } if (derive==2) { if (type == "EL") rhomat <- -1/(1-gml)^2 if (type == "ET") rhomat <- -exp(gml) if (type == "CUE") rhomat <- -1 } rhom <-list(ch = ch, rhomat=rhomat) return(rhom) } # ------------------------------------------------------------------------------ .get_lamb <- function(g, tet, x,type = c('EL', 'ET', 'CUE'), tol_lam=1e-12, maxiterlam=1000, tol_obj = 1e-7) { type <- match.arg(type) gt <- g(tet,x) n <- nrow(gt) tol_cond=1e-12 gb <- colMeans(gt) khat <- crossprod(gt)/n lamb0 <- -solve(khat,gb) conv_mes <- "Normal convergence" singular <-0 crit <-1e30 crit0 <- crit dcrit <- 10 dgblam <- -10 gblam0 <- NULL j <- 1 while ((crit > tol_lam*( 1+sqrt( crossprod(lamb0) ) ) ) & (j<=maxiterlam)) { rho2 <- as.numeric(.rho(gt,lamb0,derive=2,type=type)$rhomat) rho1 <- as.numeric(.rho(gt,lamb0,derive=1,type=type)$rhomat) gblam <- colMeans(rho1*gt) klam <- crossprod(rho2*gt,gt)/n chklam <- sum(abs(klam)) if (!is.null(gblam0)) dgblam <- crossprod(gblam)-crossprod(gblam0) if (is.na(chklam) | chklam == 0 | chklam == Inf | dgblam>0 | dgblam == Inf | is.na(dgblam) | dcrit < 0) { lamb1 <- rep(sqrt(1/n),length(lamb0)) crit <- 0 singular=2 conv_mes <- "The algorithm produced singular system, NaN or Inf" } else { if (rcond(klam)>tol_cond) { lamb1 <- lamb0-solve(klam,gblam) crit <- sqrt(crossprod(lamb0-lamb1)) lamb0 <- lamb1 } else { lamb1 <- rep(sqrt(1/n),length(lamb0)) crit <- 0 singular=2 conv_mes <- "The algorithm produced singular system" } } gblam0 <- gblam j <- j+1 dcrit<- crit0-crit crit0 <- crit } z <- list("lambda"=lamb1,singular=singular,conv_mes=conv_mes) if (j>maxiterlam | max(abs(gblam))>tol_obj) { singular <- 1 conv_mes <- "No convergence after 'maxiterlam' iterations" z$singular <- singular } z$obj <- crossprod(gblam) return(z) } # ------------------------------------------------------------------------------ .gel <- function(g,x,tet0,gradv=NULL,smooth=FALSE,type=c("EL","ET","CUE","ETEL"), vcov=c("HAC","iid"), kernel = c("Bartlett", "Parzen", "Truncated", "Tukey-Hanning"), bw = .bwAndrews2, approx = c("AR(1)", "ARMA(1,1)"), prewhite = 1, ar.method = "ols", tol_weights = 1e-7, tol_lam=1e-9, tol_obj = 1e-9, tol_mom = 1e-9,maxiterlam=1000, constraint = FALSE, intercept = TRUE, optfct = c("optim", "optimize"), optlam = c("iter", "numeric"), ...) { vcov=match.arg(vcov) type <- match.arg(type) optfct <- match.arg(optfct) optlam <- match.arg(optlam) weights = .weightsAndrews2 if (type == "ETEL") { typel <- "ET" typet <- "EL" } else { typel <- type typet <- type } approx <- match.arg(approx) kernel <- match.arg(kernel) k <- length(tet0) typeg=0 if (is(g,"formula")) { typeg=1 dat <- .get_dat(g, x, intercept = intercept) x <- dat$x g <- function(tet,x,ny=dat$ny,nh=dat$nh,k=dat$k) { tet <- matrix(tet,ncol=k) if (intercept) { e <- x[,1:ny] - x[,(ny+1):(ny+k)]%*%t(tet) gt <- e for (i in 2:nh) { gt <- cbind(gt,e*x[,(ny+k+i)]) } } if (!intercept) e <- x[,1:ny] - x[,(ny+1):(ny+k)]%*%t(tet) gt <- e*x[,ny+k+1] if (nh > 1) { for (i in 2:nh) { gt <- cbind(gt,e*x[,(ny+k+i)]) } } return(gt) } gradv <- function(tet,x,ny=dat$ny,nh=dat$nh,k=dat$k) { tet <- matrix(tet,ncol=k) dgb <- -(t(x[,(ny+k+1):(ny+k+nh)])%*%x[,(ny+1):(ny+k)]) %x% diag(rep(1,ny))/nrow(x) return(dgb) } } if (typeg) n <- nrow(x) else n = nrow(g(tet0,x)) if (smooth) { g1 <- g rgmm <- .gmm(g,x,tet0,wmatrix="ident") if (is.function(weights)) w <- weights(g(rgmm$par,x), kernel=kernel, bw=bw, prewhite = prewhite,ar.method=ar.method,approx=approx, tol=tol_weights) else w <- weights sg <- function(thet,x) { gf <- g1(thet,x) gt <- .smooth_g(gf, weights=w)$smoothx return(gt) } g <- sg } lll <- 1 thetf <- function(tet) { if (optlam == "iter") { lamblist <- .get_lamb(g,tet,x,type=typel,tol_lam=tol_lam, maxiterlam=maxiterlam,tol_obj=tol_obj) lamb <- lamblist$lambda gt <- g(tet,x) pt <- -.rho(gt,lamb,type=typet,derive=1)$rhomat/nrow(gt) checkmom <- sum(as.numeric(pt)*gt) if (lamblist$singular==0) p <- sum(.rho(gt,lamb,type=typet)$rhomat) + abs(checkmom)/tol_mom if (lamblist$singular==1) p <- sum(.rho(gt,lamb,type=typet)$rhomat) + abs(checkmom)/tol_mom + lamblist$obj/tol_mom if (lamblist$singular==2) p <- 1e50*lll lll <- lll+1 } else { gt <- g(tet,x) rhofct <- function(lamb) { rhof <- -sum(.rho(gt,lamb,type=typet)$rhomat) return(rhof) } if (ncol(gt)>1) rlamb <- optim(rep(0,ncol(gt)),rhofct,...) else { rlamb <- optimize(rhofct,c(-1,1)) rlamb$par <- rlamb$minimum rlamb$value <- rlamb$objective } lamb <- rlamb$par pt <- -.rho(gt,lamb,type=typet,derive=1)$rhomat/nrow(gt) checkmom <- sum(as.numeric(pt)*gt) p <- -rlamb$value + (checkmom)^2/tol_mom + (sum(as.numeric(pt))-1)^2/tol_mom } return(p) } if (!constraint) if (optfct == "optim") res <- optim(tet0,thetf,...) else { res <- optimize(thetf,tet0,...) res$par <- res$minimum res$convergence <- "Pas applicable" } else res <- constrOptim(tet0,thetf,...) rlamb <- .get_lamb(g,res$par,x,type=typel,tol_lam=tol_lam,maxiterlam=maxiterlam,tol_obj=tol_obj) z <- list(par=res$par,lambda=rlamb$lam,conv_lambda=rlamb$conv_mes,conv_par=res$convergence) z$foc_lambda <- rlamb$obj z$type <- type z$gt <- g(z$par,x) rhom <- .rho(z$gt,z$lambda,type=typet) z$pt <- -.rho(z$gt,z$lambda,type=typet,derive=1)$rhomat/n z$conv_moment <- colSums(as.numeric(z$pt)*z$gt) z$conv_pt <- sum(as.numeric(z$pt)) z$objective <- sum(as.numeric(rhom$rhomat)-.rho(1,0,type=typet)$rhomat)/n if (type == "EL") { z$badrho <- rhom$ch names(z$badrho) <- "Number_of_bad_rho" } Gf <- function(thet) { myenv <- new.env() assign('x',x,envir=myenv) assign('thet',thet,envir=myenv) barg <- function(x,thet) { gt <- g(thet,x) gbar <- as.vector(colMeans(gt)) return(gbar) } G <- attr(numericDeriv(quote(barg(x,thet)),"thet",myenv),"gradient") return(G) } if (!is.function(gradv)) G <- Gf(z$par) else G <- gradv(z$par,x) if (vcov == "iid") khat <- crossprod(z$gt) else khat <- .HAC(g(z$par,x), kernel=kernel, bw=bw,prewhite=prewhite, ar.method=ar.method,approx=approx,tol=tol_weights) kg <- solve(khat,G) z$vcov_par <- solve(crossprod(G,kg))/n z$vcov_lambda <- ((solve(khat)-kg%*%z$vcov_par%*%t(kg)))/n if (smooth) z$weights<-w if (typeg ==0) { names(z$par) <- paste("Theta[",1:k,"]",sep="") colnames(z$gt) <- paste("gt[",1:ncol(z$gt),"]",sep="") names(z$lambda) <- paste("Lambda[",1:ncol(z$gt),"]",sep="") } if (typeg == 1) { namex <- colnames(dat$x[,(dat$ny+1):(dat$ny+dat$k)]) nameh <- colnames(dat$x[,(dat$ny+dat$k+1):(dat$ny+dat$k+dat$nh)]) if (dat$ny > 1) { namey <- colnames(dat$x[,1:dat$ny]) names(z$par) <- paste(rep(namey,dat$k),"_",rep(namex,rep(dat$ny,dat$k)),sep="") colnames(z$gt) <- paste(rep(namey,dat$nh),"_",rep(nameh,rep(dat$ny,dat$nh)),sep="") names(z$lambda) <- paste("Lam(",rep(namey,dat$nh),"_",rep(nameh,rep(dat$ny,dat$nh)),")",sep="") } if (dat$ny == 1) { names(z$par) <- namex colnames(z$gt) <- nameh names(z$lambda) <- nameh } } dimnames(z$vcov_par) <- list(names(z$par),names(z$par)) dimnames(z$vcov_lambda) <- list(names(z$lambda),names(z$lambda)) class(z) <- "gel" return(z) } # ------------------------------------------------------------------------------ .smooth_g <- function(x, bw = .bwAndrews2, prewhite = 1, ar.method = "ols", weights=.weightsAndrews2, kernel=c("Bartlett","Parzen","Truncated","Tukey-Hanning"), approx = c("AR(1)","ARMA(1,1)"), tol = 1e-7) { kernel <- match.arg(kernel) approx <- match.arg(approx) n <- nrow(x) if (is.function(weights)) { w <- weights(x, bw = bw, kernel = kernel, prewhite = prewhite, ar.method = ar.method, tol = tol, verbose = FALSE, approx = approx) } else w <- weights rt <- length(w) if (rt >= 2) { w <- c(w[rt:2],w) w <- w / sum(w) rt <- rt-1 sgt <- function(t) crossprod(x[(t-rt):(t+rt),],w) x[(rt+1):(n-rt),] <- t(sapply((rt+1):(n-rt),sgt)) sx <- list("smoothx"=x,"kern_weights"=w) return(sx) } else sx <- list("smoothx"=x,"kern_weights"=1) return(sx) } # ------------------------------------------------------------------------------ .bwNeweyWest2 <- function(x, kernel = c("Bartlett", "Parzen", "Quadratic Spectral", "Truncated", "Tukey-Hanning"), prewhite = 1, ar.method = "ols",...) { kernel <- match.arg(kernel) if (kernel %in% c("Truncated", "Tukey-Hanning")) stop(paste("Automatic bandwidth selection only available for ", dQuote("Bartlett"), ", ", dQuote("Parzen"), " and ", dQuote("Quadratic Spectral"), " kernel. Use ", sQuote(".bwAndrews2"), " instead.", sep = "")) prewhite <- as.integer(prewhite) n <- nrow(x) k <- ncol(x) weights <- rep(1, k) if (length(weights) < 2) weights <- 1 mrate <- switch(kernel, Bartlett = 2/9, Parzen = 4/25, "Quadratic Spectral" = 2/25) m <- floor(ifelse(prewhite > 0, 3, 4) * (n/100)^mrate) if (prewhite > 0) { x <- as.matrix(na.omit(ar(x, order.max = prewhite, demean = FALSE, aic = FALSE, method = ar.method)$resid)) n <- n - prewhite } hw <- x %*% weights sigmaj <- function(j) sum(hw[1:(n - j)] * hw[(j + 1):n])/n sigma <- sapply(0:m, sigmaj) s0 <- sigma[1] + 2 * sum(sigma[-1]) s1 <- 2 * sum(1:m * sigma[-1]) s2 <- 2 * sum((1:m)^2 * sigma[-1]) qrate <- 1/(2 * ifelse(kernel == "Bartlett", 1, 2) + 1) rval <- switch(kernel, Bartlett = { 1.1447 * ((s1/s0)^2)^qrate }, Parzen = { 2.6614 * ((s2/s0)^2)^qrate }, "Quadratic Spectral" = { 1.3221 * ((s2/s0)^2)^qrate }) rval <- rval * (n + prewhite)^qrate return(rval) } # ------------------------------------------------------------------------------ .summary.gel <- function(object,interval=FALSE, ...) { z <- object n <- nrow(z$gt) khat <- crossprod(z$gt)/n gbar <- colMeans(z$gt) se_par <- sqrt(diag(z$vcov_par)) par <- z$par tval <- par/se_par se_parl <- sqrt(diag(z$vcov_lambda)) lamb <- z$lambda tvall <- lamb/se_parl LR_test <- 2*z$objective*n LM_test <- n*crossprod(z$lambda,crossprod(khat,z$lambda)) J_test <- n*crossprod(gbar,solve(khat,gbar)) test <- c(LR_test,LM_test,J_test) vptest <- pchisq(test,(ncol(z$gt)-length(z$par)),lower.tail=FALSE) ans <- list(type=z$type) names(ans$type) <-"Type of GEL" ans$par <- round(cbind(par,se_par, tval, 2 * pnorm(abs(tval), lower.tail = FALSE)),5) ans$lambda <- round(cbind(lamb,se_parl, tvall, 2 * pnorm(abs(tvall), lower.tail = FALSE)),5) dimnames(ans$par) <- list(names(z$par), c("Estimate", "Std. Error", "t value", "Pr(>|t|)")) dimnames(ans$lambda) <- list(names(z$lambda), c("Estimate", "Std. Error", "t value", "Pr(>|t|)")) ans$test <- cbind(test,vptest) dimnames(ans$test) <- list(c("LR test","LM test","J test"),c("statistics","p-value")) if (interval != FALSE) { zs <- qnorm((1-interval)/2,lower.tail=FALSE) ch <- zs*se_par ans$interval_par <- cbind(par-ch,par+ch) dimnames(ans$interval_par) <- list(names(par),c("Theta_lower","Theta_upper")) chl <- zs*se_parl ans$interval_lam <- cbind(lamb-chl,lamb+chl) dimnames(ans$interval_lam) <- list(names(lamb),c("Lambda_lower","Lambda_upper")) } if (z$type == "EL") ans$badrho <- z$badrho if (!is.null(z$weights)) { ans$weights <- z$weights } ans$conv_par <- z$conv_par ans$conv_pt <- z$conv_pt ans$conv_moment <- cbind(z$conv_moment) ans$conv_lambda <- z$conv_lambda names(ans$conv_par) <- "Convergence_code_theta" names(ans$conv_pt) <- "Sum_of_pt" names(ans$conv_lambda) <- "Convergence_code_for_lambda" dimnames(ans$conv_moment) <- list(names(z$gt),"Sample_moment_with_pt") class(ans) <- "summary.gel" ans } # ------------------------------------------------------------------------------ .get_dat <- function(formula,h,intercept=TRUE) { cl <- match.call() mf <- match.call(expand.dots = FALSE) m <- match(c("formula", "data"), names(mf), 0L) mf <- mf[c(1L, m)] mf$drop.unused.levels <- TRUE mf[[1L]] <- as.name("model.frame") mf <- eval(mf, parent.frame()) mt <- attr(mf, "terms") h <- cbind(rep(1,nrow(h)),h) colnames(h) <- c("Intercept",paste("h",1:(ncol(h)-1),sep="")) y <- as.matrix(model.response(mf, "numeric")) x <- as.matrix(model.matrix(mt, mf, NULL)) if (!intercept) { x <- as.matrix(x[,2:ncol(x)]) h <- as.matrix(h[,2:ncol(h)]) } ny <- ncol(y) k <- ncol(x) nh <- ncol(h) if (nrow(y) != nrow(x) | nrow(x) != nrow(h) | nrow(y)!=nrow(h)) stop("The number of observations of X, Y and H must be the same") if (nh1) colnames(y) <- paste("y",1:ncol(y),sep="") if (ny == 1) colnames(y) <- "y" } x <- cbind(y,x,h) return(list(x=x,nh=nh,ny=ny,k=k)) } ################################################################################ fBasics/R/matrix-tr.R0000644000176200001440000000252513202116741014100 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # tr Returns the trace of a matrix ################################################################################ tr <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns the trace of a matrix # FUNCTION: # Trace: if (dim(x)[1] != dim(x)[2] ) { return(NA) } else { return(sum(diag(x))) } # Return Value: invisible() } ################################################################################ fBasics/R/test-fHTEST.R0000644000176200001440000001040613202116742014161 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # 'fHTEST' S4 Class Representation # show.fHTEST S4 Print Method ################################################################################ setClass("fHTEST", representation( call = "call", data = "list", test = "list", title = "character", description = "character") ) # ------------------------------------------------------------------------------ setMethod("show", "fHTEST", function(object) { # A function implemented by Diethelm Wuertz # Source: # This function copies code from base:print.htest # FUNCTION: # Unlike print the argument for show is 'object'. x = object # Title: cat("\nTitle:\n ", x@title, "\n", sep = "") # Call: # cat("\nCall:\n", deparse(x@call), "\n", sep = "") # Data Name: # cat("\nData Name:\n", ans@data.name, "\n", sep = "") # Test Results: test = x@test cat("\nTest Results:\n", sep = "") # Tests from tseries package: # Parameter: if (!is.null(test$parameter)) { parameter = test$parameter Names = names(parameter) cat(" PARAMETER:\n") for ( i in 1: length(Names) ) cat(paste(" ", names(parameter[i]), ": ", format(round(parameter[i], 3)), "\n", sep = "") ) } # Sample Estimates: if (!is.null(test$estimate)) { estimate = test$estimate Names = names(estimate) cat(" SAMPLE ESTIMATES:\n") for (i in 1:length(Names)) { cat(paste(" ", Names[i], ": ", round(estimate[i], digits = 4), "\n", sep = "" ) ) } } # Statistic: if (!is.null(test$statistic)) { statistic = test$statistic Names = names(statistic) cat(" STATISTIC:\n") for (i in 1:length(Names)) { if (!is.na(statistic[i])) { cat(paste(" ", Names[i], ": ", round(statistic[i], digits = 4), "\n", sep = "" ) ) } } } # P-Value: if (!is.null(test$p.value)) { pval = test$p.value Names = names(pval) if (Names[1] == "") space = "" else space = ": " cat(" P VALUE:\n") for (i in 1:length(Names)) { if (!is.na(pval[i])) { if (class(version) != "Sversion") { cat(paste(" ", Names[i], space, format.pval(pval[i], digits = 4), " \n", sep = "" ) ) } else { cat(paste(" ", Names[i], space, round(pval[i], digits = 4), " \n", sep = "" ) ) } } } } # Confidence Interval: if (!is.null(test$conf.int)) { conf = test$conf.int # For SPlus compatibility use dimnames istead of colnames! colNames = dimnames(conf)[[2]] cat(" CONFIDENCE INTERVAL:\n") for (i in 1:length(colNames)) { cat(paste(" ", colNames[i], ": ", round(conf[1, i], digits = 4), ", ", round(conf[2, i], digits = 4), "\n", sep = "" ) ) } } # More Specific Output Results: if (!is.null(test$output)) { cat(test$output, fill = FALSE, sep = "\n") } # Description: cat("\nDescription:\n ", x@description, sep = "") cat("\n\n") # Return Value: # invisible() # made visible by DW }) ################################################################################ fBasics/R/gui-sliderMenu.R0000644000176200001440000002175213202116742015046 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ############################################################################### # FUNCTION: SLIDER MENU: # .sliderMenu Opens a teching demo slider menu # .tdSliderMenu Opens a teching demo slider and button menu ############################################################################### .slider.env = new.env() # ------------------------------------------------------------------------------ .sliderMenu <- function(refresh.code, names, minima, maxima, resolutions, starts, title = "Slider", no = 0, set.no.value = 0) { # A function implemented by Diethelm Wuertz # Description: # Starts a slider menu # Source: # Built on code written by Peter Wolf # FUNCTION: # Requirement: if (!requireNamespace("tcltk", quietly = TRUE)) stop("Package 'tcltk' not available (should *not* happen, please report!)\n") # Environment: if (!exists(".slider.env")) { .slider.env <<- new.env() } if (no != 0) { options(show.error.messages = FALSE) ans <- as.numeric(tcltk::tclvalue(get(paste("slider", no, sep = ""), envir = .slider.env))) options(show.error.messages = TRUE) return(ans) } if (set.no.value[1] != 0) { try(eval(parse(text = paste("tclvalue(slider", set.no.value[1], ")<-", set.no.value[2], sep = "")), envir = .slider.env), silent = TRUE) return(set.no.value[2]) } # Toplevel: nt = tcltk::tktoplevel() tcltk::tkwm.title(nt, title) # Slider: for (i in seq(names)) { eval(parse(text = paste("assign(\"slider", i, "\", tclVar(starts[i]), envir = .slider.env)", sep = ""))) tcltk::tkpack(fr<-tcltk::tkframe(nt), anchor = "sw") lab = tcltk::tklabel(fr, text = names[i], anchor = "sw") sc = tcltk::tkscale(fr, command = refresh.code, from = minima[i], to = maxima[i], showvalue = TRUE, resolution = resolutions[i], orient = "horiz") assign("sc", sc, envir = .slider.env) tcltk::tkgrid(sc, lab) eval(parse(text = paste("tkconfigure(sc, variable = slider", i, ")", sep = "")), envir = .slider.env) } tcltk::tkpack(fr<-tcltk::tkframe(nt), anchor = "sw") # Quit: quitButton = tcltk::tkbutton(fr, text = " Quit ", command = function() { tcltk::tkdestroy(nt) } ) # Reset: resetButton = tcltk::tkbutton(fr, text = " Start | Reset ", command = function() { for (i in seq(starts)) eval(parse(text = paste("tclvalue(slider", i, ")<-", starts[i], sep="")), envir = .slider.env) refresh.code() } ) # Compose: tcltk::tkgrid(resetButton, quitButton, sticky = "sew") } # ------------------------------------------------------------------------------ .tdSliderMenu <- function(sl.functions, names, minima, maxima, resolutions, starts, but.functions, but.names, no, set.no.value, obj.name, obj.value, reset.function, title) { # A function implemented by Diethelm Wuertz # Description # Opens a teching demo slider menu # Notes: # Build on ideas and code from: # R Package: TeachingDemos # Title: Demonstrations for teaching and learning # Version: 1.5 # Author: Greg Snow # Description: This package is a set of demonstration functions # that can be used in a classroom to demonstrate statistical # concepts, or on your own to better understand the concepts # or the programming. # Maintainer: Greg Snow # License: Artistic # FUNCTION: # Requirement: if (!requireNamespace("tcltk", quietly = TRUE)) stop("Package 'tcltk' not available (should *not* happen, please report!)\n") # Setup: if(!missing(no)) { return(as.numeric(tcltk::tclvalue(get(paste(".tdSlider", no, sep=""), envir = .slider.env)))) } if(!missing(set.no.value)){ try(eval(parse(text=paste("tclvalue(.tdSlider", set.no.value[1],")<-", set.no.value[2], sep = "")), envir = .slider.env)) return(set.no.value[2]) } if(!exists(".slider.env")) { .slider.env <<- new.env() } if(!missing(obj.name)){ if(!missing(obj.value)) { assign(obj.name, obj.value, envir = .slider.env) } else { obj.value <- get(obj.name, envir = .slider.env) } return(obj.value) } if(missing(title)) { title = "Control Widget" } # GUI Settings: nt <- tcltk::tktoplevel() tcltk::tkwm.title(nt, title) tcltk::tkwm.geometry(nt, "+0+0") # Buttons: tcltk::tkpack( f.but <- tcltk::tkframe(nt), fill = "x") # Quit Button: quitCMD = function() { tcltk::tkdestroy(nt) } tcltk::tkpack( tcltk::tkbutton(f.but, text = "Quit", command = quitCMD, anchor = "sw"), side = "right", fill = "y") # Reset Button: if(missing(reset.function)) { reset.function <- function(...) print("relax") } if(!is.function(reset.function)) { reset.function<-eval(parse(text = paste("function(...){",reset.function,"}"))) } resetCMD = function() { for(i in seq(names)) eval(parse(text = paste("tclvalue(.tdSlider",i,")<-", starts[i], sep = "")), envir = .slider.env) reset.function() } tcltk::tkpack( tcltk::tkbutton(f.but, text = "Reset", command = resetCMD, anchor = "sw"), side = "right", fill = "y") if (missing(but.names)) { but.names <- NULL } for (i in seq(but.names)) { but.fun <- if (length(but.functions) > 1) but.functions[[i]] else but.functions if (!is.function(but.fun)) { but.fun <- eval(parse(text = paste("function(...){", but.fun, "}"))) } tcltk::tkpack( tcltk::tkbutton(f.but, text = but.names[i], command = but.fun, anchor = "nw"), # side = "right", fill = "x" ) } # Sliders: if(missing(names)) { names <- NULL } if(missing(sl.functions)) { sl.functions <- function(...){} } for(i in seq(names)){ eval(parse(text = paste("assign('.tdSlider",i,"', tclVar(starts[i]), env = .slider.env)", sep = ""))) tcltk::tkpack(fr <- tcltk::tkframe(nt)) lab <- tcltk::tklabel(fr, text = names[i], anchor = "sw", width = "35") sc <- tcltk::tkscale(fr, from = minima[i], to = maxima[i], showvalue = TRUE, resolution = resolutions[i], orient = "horiz") tcltk::tkpack(lab, sc, anchor = "sw", side = "right"); assign("sc", sc, envir = .slider.env) eval(parse(text=paste("tkconfigure(sc,variable=.tdSlider",i,")", sep="")), envir = .slider.env) sl.fun <- if(length(sl.functions)>1) sl.functions[[i]] else sl.functions if(!is.function(sl.fun)) sl.fun<-eval(parse(text=paste("function(...){", sl.fun,"}"))) tcltk::tkconfigure(sc, command = sl.fun) } assign("slider.values.old", starts, envir = .slider.env) # Return Value: invisible(nt) } ################################################################################ fBasics/R/test-varianceTest.R0000644000176200001440000001713313202116741015557 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # varianceTest Performs variance tests on two samples # .varfTest F test for differences in variances # .bartlett2Test Bartlett's test for differences in variances # .fligner2Test Fligner-Killeen test for differences in variances ################################################################################ varianceTest <- function(x, y, method = c("varf", "bartlett", "fligner"), title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs Variance Tests # FUNCTION: # Test: method = match.arg(method) if (method == "varf") { ans = .varfTest(x, y, title = title, description = description) } if (method == "bartlett") { ans = .bartlett2Test(x, y, title = title, description = description) } if (method == "fligner") { ans = .fligner2Test(x, y, title = title, description = description) } # Return Value: ans } # ------------------------------------------------------------------------------ .varfTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs an F test to compare the variances of two samples # from normal populations. # Arguments: # x, y - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Notes: # A modified copy originally from R's ctest package Version 1.8.1 # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Estimate - Hypothesized Equal Variance: ratio = 1 DF.x = length(x) - 1 DF.y = length(y) - 1 VAR.x = var(x) VAR.y = var(y) ESTIMATE = VAR.x / VAR.y / ratio names(ESTIMATE) = "Ratio of Variances" test$estimate = ESTIMATE # Parameter: PARAMETER = c(ratio, DF.x, DF.y) names(PARAMETER) = c( "Hypothesized Ratio", "Numerator df", "Denumerator df") test$parameter = PARAMETER # Statistic: STATISTIC = ESTIMATE / ratio names(STATISTIC) = "F" test$statistic = STATISTIC # P Value: p = pf(STATISTIC, DF.x, DF.y) PVAL = c( two.sided = 2 * min(p, 1 - p), less = p, greater = 1 - p) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater") test$p.value = PVAL # Confidence Interval: conf.level = 0.95 B = (1 - conf.level) / 2 two.sided = c(ESTIMATE/qf(1-B, DF.x, DF.y), ESTIMATE/qf(B, DF.x, DF.y)) less = c(0, ESTIMATE/qf(1-conf.level, DF.x, DF.y)) greater = c(ESTIMATE/qf(conf.level, DF.x, DF.y), Inf) CONF.INT = cbind( a = two.sided, b = less, c = greater) dimnames(CONF.INT)[[2]] = c( "Two-Sided", " Less", " Greater") test$conf.int = CONF.INT # Add: if(is.null(title)) title = "F Test of Variances" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ .bartlett2Test <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Bartlett's test for differences in variances # Arguments: # x - a numeric vector of data values. # Note: # # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Settings: x = list(x = x, y = y) k = length(x) n = sapply(x, "length") - 1 v = sapply(x, "var") n.total = sum(n) v.total = sum(n * v) / n.total # Statistic: STATISTIC = ((n.total * log(v.total) - sum(n * log(v))) / (1 + (sum(1 / n) - 1 / n.total) / (3 * (k - 1)))) names(STATISTIC) = "Bartlett's Chi-squared" test$statistic = STATISTIC # P Value: PVAL = 1 - pchisq(STATISTIC, 1) names(PVAL) = "" test$p.value = PVAL # Add: if(is.null(title)) title = "Bartlett Test for Homogeneity of Variances" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ .fligner2Test <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Fligner-Killeen's rank based test for homogeneity of variances # Arguments: # x - a numeric vector of data values. # Note: # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Settings: x = list(x = x, y = y) k = length(x) l = sapply(x, "length") g = factor(rep(1 : k, l)) x = unlist(x) # Statistic: n = length(x) x = unlist(tapply(x, g, function(u) u - median(u))) a = qnorm((1 + rank(abs(x)) / (n + 1)) / 2) STATISTIC = sum(tapply(a, g, "sum")^2 / tapply(a, g, "length")) STATISTIC = (STATISTIC - n * mean(a)^2) / var(a) names(STATISTIC) = "FK:med chi-squared" test$statistic = STATISTIC # P Value: PVAL = 1 - pchisq(STATISTIC, 1) names(PVAL) = "" test$p.value = PVAL # Add: if(is.null(title)) title = "Fligner-Killeen Test for Homogeneity of Variances" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/R/builtin-posdefCorpcor.R0000644000176200001440000000165313202116742016427 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # posdef ################################################################################ fBasics/R/stats-sampleRobMoments.R0000644000176200001440000000552513202116742016600 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # sampleMED Returns sample median # sampleIQR Returns sample inter quartal range # sampleSKEW Returns robust sample skewness # sampleKURT Returns robust sample kurtosis ################################################################################ sampleMED <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns sample median # FUNCTION: # Sample Median: x = as.vector(x) med = c(MED = quantile(x, 0.50)[[1]]) # Return Value: med } # ------------------------------------------------------------------------------ sampleIQR = function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns sample inter quartal range # FUNCTION: # Sample Inter Quartile Range x = as.vector(x) iqr = c(IQR = diff(quantile(x, c(0.25, 0.75)))[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ sampleSKEW = function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns robust sample skewness # FUNCTION: # Robust Sample Skew x = as.vector(x) q = quantile(x, c(0.25, 0.5, 0.75)) skew = c(SKEW = q[[3]] + q[[1]] - 2*q[[2]]) / (q[[3]]-q[[1]]) # Return Value: skew } # ------------------------------------------------------------------------------ sampleKURT = function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns robust sample kurtosis # FUNCTION: # Robust Sample Kurtosis x = as.vector(x) q = quantile(x, (1:7)/8) kurt = c(KURT = (q[[7]] - q[[5]] + q[[3]] - q[[1]]) / (q[[6]] - q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/utils-listDescription.R0000644000176200001440000000340113202116742016461 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # listDescription Extracts R package description ################################################################################ listDescription <- function(package, character.only = FALSE) { # A function implemented by Diethelm Wuertz & Yohan Chalabi # Description: # Extracts package description ## MM: I would ### .Deprecated("packageDescription") # FUNCTION: # Extract Description: if (!character.only && !missing(package)) package <- as.character(substitute(package)) if(missing(package) || length(package) == 0) stop("Must specify a package by name") ans <- library(help = package, character.only=TRUE) ## DW: gsub(): for proper insertion added description <- gsub("\n", "\n ", ans$info[[1]]) cat("\n", package, "Description:\n\n") cat(paste(" ", description), sep = "\n") } ################################################################################ fBasics/R/plot-counts.R0000644000176200001440000000604013202116741014434 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .counts1Plot Creates a plot of counts # .counts2Plot Creates an alternative plot of counts ################################################################################ .counts1Plot= function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # Creates a plot of counts # Arguments: # x - a vector of counts # Note: # From R-help, ref. Gabor Grothendiek # Example: # x <- c(26,26,27,27,27,27,28,28,28,28,28,28,28,28,28,28,28,28, # 28,29,29,29,29,29,29,29,29,29,29,29,30,30,30,30,30,30,30, # 30,31,31,31,31,32,33,33,33,34,34,35,43); .counts1Plot(x) # FUNCTION: # Plot Range: xmin = min(x) xmax = max(x) xlim = c(xmin - 0.1*(xmax-xmin), xmax + 0.1*(xmax-xmin)) # Plot plot(seq(y) - match(y, y) ~ y, list(y = sort(x)), xlim = xlim, ylab = "", yaxt = "n", pch = 19, frame.plot = FALSE, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ .counts2Plot <- function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # Creates a plot of counts # Arguments: # x - a vector of counts # Note: # From R-help, ref. Jinsong Zhao # Example: # x <- c(26,26,27,27,27,27,28,28,28,28,28,28,28,28,28,28,28,28, # 28,29,29,29,29,29,29,29,29,29,29,29,30,30,30,30,30,30,30, # 30,31,31,31,31,32,33,33,33,34,34,35,43); .counts2Plot(x) # FUNCTION: # Tabulate: x.table <- table(x) x.x <- as.numeric(names(x.table)) x.y <- as.numeric(x.table) n <- length(x.x) x.final <- NULL for (i in 1:n) { tmp <- data.frame(x = rep(x.x[i], x.y[i]), y = 1:x.y[i]) x.final <- rbind(x.final, tmp) } # Plot Range: xmin = min(x) xmax = max(x) xlim = c(xmin - 0.1*(xmax-xmin), xmax + 0.1*(xmax-xmin)) # Plot: plot(x.final, yaxt = "n", ylab = "", xlim = xlim, pch = 19, frame.plot = FALSE, ...) # Return Value: invisible(x) } ################################################################################ fBasics/R/builtin-kweightsSandwhich.R0000644000176200001440000000674213202116742017301 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # .kweigths ################################################################################ # Code borrowed from # R's contributed package "sandwich" written by Thomas Lumley # and Achim Zeileis. # Rmetrics: # To run these functions under Rmetrics we have them implemented # here as a builtin. # The reason is that the dependences in the original package requires # zoo which may create conflicts with Rmetrics timeDate/timeSeries. # Package: sandwich # Version: 2.2-1 # Date: 2009-02-05 # Title: Robust Covariance Matrix Estimators # Author: Thomas Lumley, Achim Zeileis # Maintainer: Achim Zeileis # Description: Model-robust standard error estimators for cross-sectional, # time series and longitudinal data. # LazyLoad: yes # LazyData: yes # Depends: R (>= 2.0.0), stats, zoo # Suggests: car, lmtest, strucchange, AER, survival, MASS # Imports: stats # License: GPL-2 # Copyright: (C) 2004 Thomas Lumley and Achim Zeileis # ------------------------------------------------------------------------------ .kweights <- function(x, kernel = c("Truncated", "Bartlett", "Parzen", "Tukey-Hanning", "Quadratic Spectral"), normalize = FALSE) { kernel <- match.arg(kernel) if(normalize) { ca <- switch(kernel, "Truncated" = 2, "Bartlett" = 2/3, "Parzen" = .539285, "Tukey-Hanning" = 3/4, "Quadratic Spectral" = 1) } else ca <- 1 switch(kernel, "Truncated" = { ifelse(ca * x > 1, 0, 1) }, "Bartlett" = { ifelse(ca * x > 1, 0, 1 - abs(ca * x)) }, "Parzen" = { ifelse(ca * x > 1, 0, ifelse(ca * x < 0.5, 1 - 6 * (ca * x)^2 + 6 * abs(ca * x)^3, 2 * (1 - abs(ca * x))^3)) }, "Tukey-Hanning" = { ifelse(ca * x > 1, 0, (1 + cos(pi * ca * x))/2) }, "Quadratic Spectral" = { y <- 6 * pi * x/5 ifelse(x < 1e-4, 1, 3 * (1/y)^2 * (sin(y)/y - cos(y))) }) } ################################################################################ fBasics/R/dist-fDISTFIT.R0000644000176200001440000000415713202116742014372 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # 'fDISTFIT' S4 Class representation # show.fDISTFIT Prints Results from a Fitted Distribution ################################################################################ setClass("fDISTFIT", representation( call = "call", model = "character", data = "data.frame", fit = "list", title = "character", description = "character" ) ) # ------------------------------------------------------------------------------ setMethod("show", "fDISTFIT", function(object) { # A function implemented by Diethelm Wuertz # Description: # Prints Results from a Fitted Distribution # FUNCTION: # Title: cat("\nTitle:\n ") cat(object@title, "\n") # Call: cat("\nCall:\n ") cat(paste(deparse(object@call), sep = "\n", collapse = "\n"), "\n", sep = "") # Model: cat("\nModel:\n ", object@model, "\n", sep = "") # Estimate: cat("\nEstimated Parameter(s):\n") print(object@fit$estimate) # Description: cat("\nDescription:\n ") cat(object@description, "\n\n") # Return Value: invisible() }) # ------------------------------------------------------------------------------ ################################################################################ fBasics/R/dist-gh.R0000644000176200001440000001245313202116742013512 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dgh Returns density for generalized hyperbolic DF # pgh Returns probability for generalized hyperbolic DF # qgh Returns quantiles for generalized hyperbolic DF # rgh Returns random variates for generalized hyperbolic DF ################################################################################ dgh <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density for the generalized hyperbolic distribution # FUNCTION: # Parameters: if (length(alpha) == 4) { mu = alpha[4] delta = alpha[3] beta = alpha[2] alpha = alpha[1] } # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Density: arg = delta*sqrt(alpha^2-beta^2) a = (lambda/2)*log(alpha^2-beta^2) - ( log(sqrt(2*pi)) + (lambda-0.5)*log(alpha) + lambda*log(delta) + log(besselK(arg, lambda, expon.scaled = TRUE)) - arg ) f = ((lambda-0.5)/2)*log(delta^2+(x - mu)^2) # Use exponential scaled form to prevent from overflows: arg = alpha * sqrt(delta^2+(x-mu)^2) k = log(besselK(arg, lambda-0.5, expon.scaled = TRUE)) - arg e = beta*(x-mu) # Put all together: ans = a + f + k + e if(!log) ans = exp(ans) # Return Value: ans } # ------------------------------------------------------------------------------ pgh <- function(q, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns probability for the generalized hyperbolic distribution # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Probability: ans = NULL for (Q in q) { Integral = integrate(dgh, -Inf, Q, stop.on.error = FALSE, alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda) ans = c(ans, as.numeric(unlist(Integral)[1])) } # Return Value: ans } # ------------------------------------------------------------------------------ qgh <- function(p, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles for the generalized hyperbolic distribution # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Internal Function: .froot <- function(x, alpha, beta, delta, mu, lambda, p) { pgh(q = x, alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda) - p } # Quantiles: result = NULL for (pp in p) { lower = -1 upper = +1 counter = 0 iteration = NA while (is.na(iteration)) { iteration = .unirootNA(f = .froot, interval = c(lower, upper), alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda, p = pp) counter = counter + 1 lower = lower - 2^counter upper = upper + 2^counter } result = c(result, iteration) } # Return Value: result } # ------------------------------------------------------------------------------ rgh <- function(n, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns random variates for the generalized hyperbolic distribution # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Settings: theta = c(lambda, alpha, beta, delta, mu) # Random Numbers: ans = .rghyp(n, theta) # Attributes: attr(ans, "control") = c(dist = "gh", alpha = alpha, beta = beta, delta = delta, mu = mu, lambda = lambda) # Return Value: ans } ################################################################################ fBasics/R/test-jbLM.R0000644000176200001440000174264113202116741013765 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # DATA: DESCRIPTION: # .jbLM Jarque-Bera Lagrange Multiplier Data ################################################################################ .jbLM <- function() { structure(list("5" = c(0.052470165, 0.052479988, 0.052481227, 0.052482714, 0.052484752, 0.0524849, 0.052487004, 0.052487547, 0.052492897, 0.052493878, 0.052493879, 0.052494842, 0.052496092, 0.052497834, 0.052499018, 0.052505397, 0.052509442, 0.052511664, 0.052515321, 0.052517838, 0.052529162, 0.05253247, 0.052537375, 0.05254833, 0.052553431, 0.052558648, 0.052559815, 0.052561665, 0.052570098, 0.052574164, 0.05258048, 0.05258408, 0.052586498, 0.052588564, 0.052593144, 0.052598993, 0.052600907, 0.052607888, 0.05260833, 0.05261147, 0.052611702, 0.052613837, 0.052620487, 0.052628488, 0.052631379, 0.052633052, 0.05263496, 0.052635328, 0.052641592, 0.052645432, 0.052651572, 0.052656332, 0.052660683, 0.052665999, 0.052673242, 0.052676104, 0.052688929, 0.052694803, 0.052699646, 0.052701458, 0.052709881, 0.052712268, 0.05272215, 0.052727874, 0.052730256, 0.052735346, 0.052743604, 0.05274666, 0.052760922, 0.052767973, 0.052775119, 0.052778247, 0.052781513, 0.052786578, 0.052791093, 0.052803672, 0.052807291, 0.052821458, 0.052823871, 0.052828785, 0.052833725, 0.052840874, 0.052843109, 0.052847147, 0.052853554, 0.052854431, 0.052861028, 0.052868051, 0.052877535, 0.052886001, 0.052888722, 0.052898288, 0.052898694, 0.052908141, 0.052910534, 0.052914546, 0.052923779, 0.052927527, 0.052935115, 0.052937428, 0.052942354, 0.052949011, 0.052953643, 0.052955157, 0.052959405, 0.052966149, 0.052973704, 0.052979684, 0.052991848, 0.053004827, 0.053010343, 0.053013686, 0.053025845, 0.053033555, 0.053044444, 0.053058405, 0.053066997, 0.053073765, 0.053081806, 0.053088497, 0.053090763, 0.053108566, 0.053114103, 0.053122934, 0.053128147, 0.053146206, 0.053152252, 0.053164623, 0.05316833, 0.053177206, 0.053182248, 0.05319418, 0.053199323, 0.053207293, 0.053213266, 0.053217012, 0.053225175, 0.053229997, 0.053235579, 0.053242451, 0.05324788, 0.05326003, 0.053268582, 0.053276668, 0.053286, 0.053297456, 0.053302415, 0.053308875, 0.053318566, 0.053325458, 0.053328303, 0.053336053, 0.053344035, 0.053358689, 0.053366123, 0.053379, 0.053385515, 0.053401057, 0.053409904, 0.053419693, 0.05342981, 0.053439077, 0.053447854, 0.053455487, 0.053471333, 0.053484097, 0.053494267, 0.053504441, 0.053516544, 0.053536177, 0.053548321, 0.05356068, 0.053567346, 0.053579452, 0.053587055, 0.053599905, 0.053615242, 0.053631305, 0.053642128, 0.053656104, 0.053669132, 0.053682175, 0.053698071, 0.053707687, 0.053716235, 0.053726155, 0.053745809, 0.053755976, 0.05377043, 0.053780103, 0.053789211, 0.053806224, 0.053817766, 0.053824376, 0.053845433, 0.053863096, 0.053870538, 0.053879744, 0.053890909, 0.053903248, 0.053919547, 0.05394363, 0.053957, 0.053965009, 0.053980621, 0.05400366, 0.054029899, 0.054039456, 0.054054511, 0.054071398, 0.054083595, 0.054101628, 0.054121831, 0.054135171, 0.054155278, 0.054169236, 0.054182059, 0.054193931, 0.054209747, 0.054225624, 0.054241778, 0.054263774, 0.054284711, 0.05430284, 0.054317464, 0.054336061, 0.054357414, 0.054374382, 0.054387071, 0.054405249, 0.054427059, 0.054446871, 0.054475202, 0.05450106, 0.054513578, 0.054526546, 0.054554829, 0.054572751, 0.054595561, 0.054614961, 0.054635283, 0.054657007, 0.054673574, 0.054692394, 0.054710538, 0.054731138, 0.05474872, 0.054763391, 0.054777874, 0.054792343, 0.054810068, 0.054829141, 0.054855706, 0.05487446, 0.054891618, 0.054910297, 0.054929487, 0.054947177, 0.054964138, 0.054984542, 0.055006999, 0.055028477, 0.055049614, 0.055073464, 0.055094798, 0.055114758, 0.055143275, 0.055167051, 0.05518981, 0.055216064, 0.055251392, 0.055276685, 0.055296083, 0.05532189, 0.055343876, 0.05536461, 0.055396205, 0.055426364, 0.055451719, 0.055475523, 0.055500743, 0.055533456, 0.055552921, 0.055575591, 0.05560366, 0.055628538, 0.055655587, 0.055674449, 0.05570588, 0.055734456, 0.055761618, 0.055791158, 0.055826565, 0.055857829, 0.055881359, 0.055912539, 0.055936362, 0.055970103, 0.056011042, 0.056037279, 0.056063243, 0.056083742, 0.056108859, 0.056139325, 0.056170292, 0.056204059, 0.05623625, 0.056263069, 0.056298258, 0.056333661, 0.056369701, 0.056405303, 0.056436116, 0.056475045, 0.05651771, 0.056546871, 0.056584349, 0.056632716, 0.056671386, 0.05670932, 0.056743841, 0.056782046, 0.056825988, 0.056864467, 0.056903272, 0.056941127, 0.056967605, 0.057003367, 0.057054254, 0.057095308, 0.057140073, 0.057180561, 0.057219623, 0.0572585, 0.057292375, 0.057333975, 0.057366877, 0.05740834, 0.057449003, 0.057494547, 0.057516542, 0.057521952, 0.057572976, 0.057610281, 0.057657893, 0.057708535, 0.057746393, 0.057793558, 0.057837331, 0.057876209, 0.057929694, 0.057973803, 0.058019725, 0.058068957, 0.058121873, 0.058174747, 0.058221805, 0.058286619, 0.058334838, 0.058380104, 0.058415891, 0.058465996, 0.058515601, 0.05855796, 0.058600887, 0.058655536, 0.058701084, 0.058760333, 0.058816393, 0.058862081, 0.058905556, 0.058971496, 0.059019469, 0.059063764, 0.059114972, 0.059171751, 0.059227574, 0.059274917, 0.05933176, 0.059390527, 0.059452501, 0.059511612, 0.059564306, 0.059636492, 0.059698885, 0.059766115, 0.059837585, 0.059887524, 0.059945926, 0.059999074, 0.060056947, 0.060122083, 0.060186488, 0.060244722, 0.060300044, 0.060352215, 0.060408161, 0.060470544, 0.060526999, 0.060598813, 0.060660754, 0.060724341, 0.060792375, 0.060847753, 0.060926621, 0.060992407, 0.061057209, 0.061120324, 0.0611963, 0.061270521, 0.061337538, 0.061417506, 0.061484316, 0.061562481, 0.061627421, 0.061694074, 0.06177382, 0.061851749, 0.061922786, 0.061995792, 0.062076488, 0.062159312, 0.062245855, 0.062315056, 0.062395949, 0.06247632, 0.062562632, 0.062644737, 0.062727552, 0.062815836, 0.062903098, 0.062989177, 0.063061467, 0.063144867, 0.063223598, 0.063317891, 0.063416288, 0.063510871, 0.063616702, 0.06370956, 0.06380296, 0.063900372, 0.063993006, 0.064080463, 0.064175429, 0.064261166, 0.064361682, 0.064460143, 0.064558649, 0.064658988, 0.06476212, 0.064871314, 0.064967746, 0.065064769, 0.065171274, 0.065262971, 0.065371605, 0.065479934, 0.065578652, 0.065700293, 0.065815076, 0.065912834, 0.066029784, 0.066140289, 0.066245342, 0.066359611, 0.066476329, 0.066584444, 0.066709781, 0.066818655, 0.066930523, 0.067050569, 0.067169022, 0.067288403, 0.067409223, 0.067525058, 0.06766065, 0.067778712, 0.067895012, 0.068018552, 0.068145529, 0.068267553, 0.068388902, 0.068519719, 0.068643022, 0.068766217, 0.068896974, 0.069016038, 0.069168397, 0.069299157, 0.069431158, 0.069560116, 0.069704215, 0.069843644, 0.069971697, 0.070103338, 0.07023748, 0.070377416, 0.070509735, 0.070653509, 0.070796704, 0.07094601, 0.071099757, 0.071238576, 0.071390633, 0.071552146, 0.071694361, 0.071836762, 0.071999384, 0.072158808, 0.072321327, 0.072486926, 0.072628402, 0.072795116, 0.07295204, 0.073125097, 0.073303727, 0.073474171, 0.073640301, 0.073817196, 0.073983465, 0.074142403, 0.074328202, 0.07451504, 0.074692498, 0.074867747, 0.075036873, 0.075213045, 0.075371473, 0.075552608, 0.075730952, 0.075924551, 0.076122715, 0.076311216, 0.076498756, 0.076695559, 0.076889651, 0.077069414, 0.077259419, 0.077457981, 0.077668035, 0.077829236, 0.077867934, 0.078073287, 0.07828708, 0.078488742, 0.078700243, 0.078918095, 0.07914362, 0.079349483, 0.07956642, 0.079789373, 0.080002642, 0.080214866, 0.080442838, 0.080649163, 0.080873901, 0.081107177, 0.081319937, 0.081567753, 0.081798954, 0.08203257, 0.082263671, 0.082501223, 0.082743095, 0.082966431, 0.083231188, 0.083480618, 0.083737812, 0.083986848, 0.084233095, 0.084484699, 0.084736427, 0.084995372, 0.08526503, 0.085529239, 0.085794454, 0.086063969, 0.086334599, 0.086603822, 0.08687205, 0.087151717, 0.087427125, 0.087721383, 0.088010904, 0.088313013, 0.088598517, 0.088880033, 0.089159514, 0.089450913, 0.089747583, 0.090045973, 0.090344842, 0.090647854, 0.090950884, 0.091240849, 0.091558786, 0.091875483, 0.092189983, 0.092493542, 0.092815099, 0.093121572, 0.093436734, 0.093764099, 0.094085097, 0.094423547, 0.09475989, 0.095098175, 0.095452041, 0.095791969, 0.096143076, 0.096496183, 0.096840964, 0.097184454, 0.097533137, 0.097873883, 0.09823798, 0.09859292, 0.098970052, 0.099347618, 0.099714553, 0.100080883, 0.100464315, 0.100855699, 0.101254573, 0.101657438, 0.102046963, 0.102431681, 0.102840317, 0.103244488, 0.103652006, 0.104065986, 0.104481629, 0.104906083, 0.105329388, 0.105753564, 0.106161729, 0.106582303, 0.106998509, 0.10742242, 0.107859271, 0.108306856, 0.108735774, 0.109187974, 0.109652307, 0.110120194, 0.110561495, 0.111027163, 0.11150901, 0.111977946, 0.112446572, 0.112932691, 0.11340247, 0.113878572, 0.11437796, 0.114882729, 0.115384302, 0.115870617, 0.116395596, 0.116912297, 0.11740143, 0.117901353, 0.118432072, 0.118969208, 0.119493672, 0.120021085, 0.120562712, 0.12109451, 0.121637082, 0.122187055, 0.122741896, 0.123296, 0.123864289, 0.124421527, 0.124998962, 0.125573542, 0.126174533, 0.126761174, 0.127350097, 0.127942086, 0.128531919, 0.12912565, 0.129744698, 0.130359095, 0.130966486, 0.131583949, 0.132213425, 0.132834131, 0.133471537, 0.13409182, 0.13473705, 0.135397919, 0.136050088, 0.136696613, 0.137355445, 0.138032578, 0.138709971, 0.139381378, 0.140052163, 0.14073491, 0.141428932, 0.142139672, 0.14284619, 0.143559704, 0.14426246, 0.14500191, 0.145712792, 0.14644532, 0.147200793, 0.14795636, 0.148706951, 0.149459648, 0.150227274, 0.150975582, 0.151752903, 0.152528495, 0.153330724, 0.154120583, 0.154920559, 0.155753484, 0.156563183, 0.157383151, 0.158215658, 0.159059398, 0.159886712, 0.160706772, 0.161563484, 0.162446575, 0.163307498, 0.164204058, 0.165094404, 0.165977168, 0.166867592, 0.16777023, 0.168688464, 0.169593089, 0.17051402, 0.17143549, 0.172362603, 0.173311887, 0.174254926, 0.175226169, 0.175972583, 0.176168081, 0.177113701, 0.178084983, 0.179057617, 0.180045234, 0.18102604, 0.182012732, 0.18303215, 0.184055821, 0.185083747, 0.186118818, 0.187166773, 0.18819944, 0.189208336, 0.190272574, 0.191346587, 0.192428787, 0.193492384, 0.19455919, 0.195636192, 0.196750706, 0.197866169, 0.19900669, 0.200130779, 0.201262417, 0.202423677, 0.203554436, 0.204708139, 0.205875288, 0.207036724, 0.208231326, 0.209442365, 0.210646426, 0.211847114, 0.21303464, 0.214250037, 0.21547567, 0.216741754, 0.21795791, 0.219225036, 0.220482653, 0.221772911, 0.223075154, 0.224364736, 0.225665912, 0.226972712, 0.228278037, 0.22960312, 0.230920243, 0.232234678, 0.233590175, 0.234943395, 0.236278433, 0.237675867, 0.239051915, 0.240419746, 0.241803662, 0.243195274, 0.24460318, 0.245986843, 0.247425103, 0.248847378, 0.250283034, 0.251755465, 0.253218577, 0.25468959, 0.256153165, 0.257608361, 0.259090004, 0.260591779, 0.262083691, 0.263593738, 0.265130052, 0.266662429, 0.268192743, 0.269732639, 0.271280597, 0.272840155, 0.27442519, 0.275971454, 0.277565429, 0.279151186, 0.280762347, 0.282365688, 0.283989397, 0.285596891, 0.287247189, 0.288899473, 0.290560509, 0.292225292, 0.293884349, 0.29556405, 0.297250202, 0.298924789, 0.300618801, 0.302317632, 0.302695636, 0.304035272, 0.305719545, 0.307444189, 0.309162685, 0.310877532, 0.312591498, 0.314346338, 0.316098633, 0.317840403, 0.319601215, 0.321376956, 0.32314503, 0.324896012, 0.326693289, 0.328497252, 0.330259791, 0.332062853, 0.333863106, 0.335674652, 0.337452884, 0.33925661, 0.341073618, 0.342869113, 0.344688059, 0.346502678, 0.346888283, 0.348327328, 0.350142652, 0.351950523, 0.353758149, 0.355564352, 0.357367144, 0.359166854, 0.360958041, 0.362749586, 0.364538941, 0.366298432, 0.368057348, 0.369799654, 0.371516272, 0.37321268, 0.3748495, 0.376431562, 0.378045922, 0.379663389, 0.381329847, 0.383006892, 0.384707289, 0.386411444, 0.388148858, 0.389912329, 0.391697412, 0.39349919, 0.395330177, 0.397180829, 0.399057667, 0.400953184, 0.402868023, 0.40480865, 0.406770746, 0.408736494, 0.409578047, 0.410736575, 0.412783862, 0.414853289, 0.416947189, 0.419061486, 0.421208875, 0.423352835, 0.425540946, 0.427762632, 0.430018276, 0.432310224, 0.434605949, 0.436943267, 0.439297493, 0.441709135, 0.44412421, 0.446579722, 0.449085514, 0.451591774, 0.454140122, 0.45671929, 0.459338165, 0.461985225, 0.464685287, 0.467411955, 0.468533586, 0.470142548, 0.472910039, 0.475741369, 0.47858597, 0.481446745, 0.484357093, 0.487307759, 0.490300277, 0.493325135, 0.496395494, 0.499499412, 0.502639164, 0.505792834, 0.509003801, 0.512252376, 0.515555907, 0.518906326, 0.522271745, 0.525689047, 0.528444967, 0.534633649, 0.538030903, 0.541425374, 0.544742542, 0.547994522, 0.551230963, 0.55444231, 0.557620928, 0.560762984, 0.563869092, 0.566922797, 0.569963126, 0.572977541, 0.575959158, 0.578910849, 0.581816713, 0.584683281, 0.587514046, 0.589172402, 0.590322203, 0.593088366, 0.595823957, 0.598534117, 0.601230269, 0.603904432, 0.60655138, 0.609166509, 0.61172416, 0.614251829, 0.61674597, 0.619213411, 0.621636174, 0.6240707, 0.626480892, 0.628822996, 0.631154318, 0.633481696, 0.635762469, 0.638024088, 0.640332879, 0.642675666, 0.64502398, 0.647392421, 0.649779028, 0.651144862, 0.6521659, 0.654557354, 0.656927015, 0.659282372, 0.661648238, 0.664007821, 0.666341212, 0.668687581, 0.671001732, 0.67330795, 0.675606659, 0.677876671, 0.680155267, 0.682420933, 0.684664482, 0.686898709, 0.689125837, 0.691330266, 0.69351974, 0.69570916, 0.697883097, 0.70005366, 0.702198771, 0.704333371, 0.706445037, 0.708566537, 0.710648863, 0.712716367, 0.714809464, 0.716965887, 0.719197024, 0.721465423, 0.72374083, 0.726047658, 0.728377098, 0.730223255, 0.730715257, 0.733079708, 0.735447269, 0.737861727, 0.740331757, 0.742751188, 0.745218075, 0.747685786, 0.750178554, 0.75268831, 0.755245642, 0.7577865, 0.760337191, 0.762904442, 0.765455832, 0.768060375, 0.770666115, 0.773268635, 0.775950199, 0.7786213, 0.781332048, 0.784057699, 0.78680819, 0.789585035, 0.792358048, 0.794555921, 0.795177757, 0.798051692, 0.800951015, 0.803905241, 0.806899751, 0.809929405, 0.812997153, 0.816098273, 0.819341174, 0.822601257, 0.826015744, 0.829559167, 0.833279682, 0.837282807, 0.841914723, 0.84674626, 0.851587127, 0.856433908, 0.861327173, 0.866186649, 0.871109095, 0.875986936, 0.880969371, 0.885820729, 0.890738489, 0.895645316, 0.900513619, 0.905332823, 0.910226659, 0.915074619, 0.919963454, 0.924840449, 0.929672851, 0.934584338, 0.939508185, 0.944426338, 0.94933579, 0.954166032, 0.959001596, 0.963822252, 0.968677394, 0.973533928, 0.978377081, 0.983171388, 0.988001833, 0.99285831, 0.99759517, 1.002475441, 1.00725245, 1.011992798, 1.01674803, 1.021484106, 1.026193148, 1.030974716, 1.035693934, 1.040433424, 1.045128756, 1.049749642, 1.054421002, 1.059096756, 1.063842849, 1.068419699, 1.073022058, 1.077680383, 1.082315675, 1.086856747, 1.091457231, 1.095973199, 1.100467839, 1.105031829, 1.109486153, 1.114012469, 1.118619328, 1.12307946, 1.12752654, 1.131872479, 1.136335799, 1.140764496, 1.145169214, 1.149517995, 1.153975562, 1.158320423, 1.162641185, 1.166972381, 1.171296555, 1.175514416, 1.179798295, 1.184038043, 1.188249018, 1.192486353, 1.196664813, 1.200837266, 1.204987952, 1.209187885, 1.21332695, 1.217359653, 1.218145707, 1.221371411, 1.225522459, 1.229548193, 1.233521145, 1.237613847, 1.241599977, 1.245553855, 1.24952797, 1.253454219, 1.257341712, 1.261197535, 1.26513069, 1.269013644, 1.272841752, 1.276657628, 1.280516189, 1.284321853, 1.288029272, 1.291804121, 1.295514278, 1.299229939, 1.302952046, 1.306687319, 1.310381746, 1.314072354, 1.317636773, 1.321364676, 1.325031896, 1.328619429, 1.332137817, 1.335666305, 1.339240732, 1.342779338, 1.346354466, 1.349828347, 1.353275753, 1.356768092, 1.360203447, 1.36356166, 1.366984289, 1.370356898, 1.373716524, 1.377087111, 1.3804117, 1.383715019, 1.38702761, 1.390404111, 1.393702374, 1.396852704, 1.400025155, 1.403231952, 1.406414295, 1.409536302, 1.412635759, 1.415813696, 1.418880849, 1.421969898, 1.425111722, 1.428174437, 1.431131855, 1.434120121, 1.437109742, 1.44011235, 1.443069887, 1.44615211, 1.449021331, 1.452074821, 1.455000796, 1.457931514, 1.460826278, 1.463787342, 1.466704236, 1.46958388, 1.472539203, 1.475279133, 1.478108787, 1.480982838, 1.483854417, 1.486700358, 1.489337911, 1.492063556, 1.49472949, 1.497400713, 1.500069737, 1.502772871, 1.505367226, 1.507990246, 1.510455589, 1.512998731, 1.515567372, 1.518049197, 1.520627632, 1.523143672, 1.525667936, 1.52826972, 1.530774309, 1.533231354, 1.535714651, 1.538212884, 1.540659081, 1.543078219, 1.545542939, 1.547955108, 1.550347116, 1.552728264, 1.555092705, 1.5574214, 1.559646744, 1.561889717, 1.564303206, 1.566537901, 1.568788321, 1.571030953, 1.573258377, 1.575469253, 1.577703323, 1.579884961, 1.582055073, 1.584102538, 1.586174757, 1.588293553, 1.590416812, 1.592479878, 1.594488975, 1.596607603, 1.598670903, 1.600792281, 1.602861174, 1.604916642, 1.60705445, 1.60902079, 1.611054488, 1.613044376, 1.615021114, 1.616983777, 1.61885745, 1.620842869, 1.622746926, 1.624632209, 1.626535176, 1.628458275, 1.630328774, 1.632184565, 1.634021005, 1.635899739, 1.637695706, 1.639480424, 1.641395616, 1.643147993, 1.644863353, 1.64649654, 1.648374607, 1.650237849, 1.651981305, 1.653735311, 1.655326522, 1.656993011, 1.658736868, 1.66044481, 1.662136961, 1.663750028, 1.665387567, 1.667006042, 1.668519569, 1.670106197, 1.671709125, 1.673312147, 1.674856827, 1.676359202, 1.677903361, 1.679465155, 1.681062879, 1.68255922, 1.68406578, 1.68555801, 1.687069553, 1.688611195, 1.69002579, 1.691372768, 1.692743386, 1.694191476, 1.695505006, 1.696914902, 1.69827621, 1.699591583, 1.701013037, 1.702293608, 1.70359653, 1.704927775, 1.706364857, 1.707714747, 1.709031837, 1.710255286, 1.711508017, 1.712761777, 1.714018815, 1.715400621, 1.716637781, 1.717922262, 1.719298997, 1.719540922, 1.720576895, 1.721715304, 1.722942953, 1.724106776, 1.725237907, 1.726496596, 1.727698521, 1.7288747, 1.730075855, 1.731171954, 1.732359913, 1.733595504, 1.734692913, 1.735845163, 1.736913904, 1.738047183, 1.739280165, 1.740354408, 1.741367023, 1.742436047, 1.743509804, 1.744551185, 1.745543187, 1.746595631, 1.747594421, 1.748609468, 1.749681791, 1.750618255, 1.751629102, 1.752544695, 1.753524936, 1.75451767, 1.755500097, 1.756464255, 1.757366121, 1.758293096, 1.759257851, 1.760265946, 1.761264926, 1.762150343, 1.763008311, 1.763958952, 1.764840492, 1.765795303, 1.766726363, 1.767707596, 1.768633906, 1.76955339, 1.770419974, 1.771292242, 1.772228925, 1.773247856, 1.77415568, 1.77497642, 1.775774977, 1.776604165, 1.777379731, 1.778195687, 1.77902606, 1.779871595, 1.780648021, 1.781429814, 1.782215087, 1.782983082, 1.783681728, 1.784416379, 1.785175287, 1.785817713, 1.786599071, 1.787338466, 1.788117574, 1.788881694, 1.789626285, 1.79039386, 1.791120547, 1.791912498, 1.792708587, 1.793450535, 1.794162874, 1.794810601, 1.795450085, 1.796118656, 1.796954172, 1.797653686, 1.798436176, 1.799059856, 1.799697037, 1.800351596, 1.801085189, 1.801718853, 1.802356178, 1.802963895, 1.803603575, 1.804261684, 1.804799889, 1.80540394, 1.806016296, 1.806600155, 1.807200711, 1.807726208, 1.808372043, 1.808985552, 1.809499636, 1.810038502, 1.810704917, 1.811254886, 1.81178381, 1.812364518, 1.812933526, 1.813499606, 1.814024561, 1.814648184, 1.81520018, 1.815749464, 1.816282284, 1.816801201, 1.817312871, 1.817805165, 1.818287774, 1.818795034, 1.819342973, 1.819859471, 1.820434232, 1.820933134, 1.821395982, 1.821947628, 1.822486132, 1.822964239, 1.823454109, 1.823889531, 1.824388057, 1.8248785, 1.825411436, 1.825835011, 1.826317349, 1.826835641, 1.827241546, 1.827696329, 1.828194134, 1.828679032, 1.829127806, 1.829609048, 1.83006277, 1.830491514, 1.830896874, 1.831341953, 1.831775368, 1.832163007, 1.832642787, 1.833097872, 1.833427218, 1.833873117, 1.834292945, 1.834701003, 1.835151056, 1.835520508, 1.835907731, 1.836305702, 1.836681135, 1.837084873, 1.837470822, 1.837802979, 1.838160314, 1.838519637, 1.838885759, 1.839275651, 1.839628391, 1.839939142, 1.840259407, 1.840581044, 1.841035419, 1.841399516, 1.841733161, 1.842051307, 1.842375513, 1.842768404, 1.843123262, 1.843509211, 1.843877602, 1.8442045, 1.844480364, 1.844788941, 1.845091169, 1.845446918, 1.845693089, 1.845970848, 1.846313861, 1.846599039, 1.846856231, 1.847175874, 1.847463673, 1.847762408, 1.848050504, 1.84828595, 1.848644539, 1.848936831, 1.849200492, 1.849494978, 1.849801546, 1.85006636, 1.850141123, 1.8504614, 1.850731155, 1.851015975, 1.851243705, 1.85148061, 1.851774971, 1.852044565, 1.852327826, 1.852607042, 1.852885351, 1.853091856, 1.853289609, 1.853527104, 1.8538286, 1.854103439, 1.854371464, 1.854616062, 1.85488047, 1.855143988, 1.855432533, 1.855681711, 1.855884277, 1.856143843, 1.8563751, 1.856574352, 1.85681122, 1.857013164, 1.857250581, 1.8574574, 1.85767943, 1.857897539, 1.858167231, 1.858352382, 1.858545867, 1.858754233, 1.858982871, 1.859166649, 1.859429853, 1.859679396, 1.859837348, 1.860120667, 1.860266732, 1.860431598, 1.860627322, 1.860805303, 1.861035974, 1.861239267, 1.861449155, 1.861670078, 1.861938628, 1.862092439, 1.862326917, 1.862571992, 1.862769436, 1.86296568, 1.863144599, 1.863340437, 1.86347717, 1.86363293, 1.86381832, 1.863957687, 1.86410605, 1.864302838, 1.86443252, 1.864543882, 1.86475927, 1.864973623, 1.865091999, 1.865240057, 1.86540875, 1.865599695, 1.865767607, 1.865912093, 1.866049718, 1.866245935, 1.866385573, 1.866519383, 1.866718011, 1.866837397, 1.86703303, 1.867186472, 1.867337111, 1.867512958, 1.867640259, 1.86778192, 1.867927188, 1.868034825, 1.868196141, 1.868331905, 1.868463971, 1.868617631, 1.868781817, 1.868975355, 1.869049271, 1.869224557, 1.869316851, 1.869498397, 1.869616048, 1.869789491, 1.869896711, 1.869994548, 1.870132837, 1.870264283, 1.87034501, 1.87051314, 1.870622215, 1.870708325, 1.870843078, 1.870994734, 1.871081677, 1.871237356, 1.871340748, 1.871443339, 1.8715665, 1.871685192, 1.871798715, 1.871899217, 1.872015052, 1.872096478, 1.872196367, 1.872276176, 1.872417925, 1.872483945, 1.87263454, 1.872749331, 1.872868863, 1.873008899, 1.873130967, 1.873246328, 1.873323064, 1.873453349, 1.873554812, 1.873639397, 1.87372022, 1.873871651, 1.873984101, 1.874079113, 1.874123861, 1.87415654, 1.874275554, 1.874352119, 1.874494968, 1.874585956, 1.874711972, 1.874855628, 1.874904579, 1.875027304, 1.875132526, 1.875194438, 1.875283952, 1.875380336, 1.875480899, 1.875601754, 1.875714944, 1.875827478, 1.875931762, 1.876020099, 1.876047824, 1.876151131, 1.876244849, 1.876330681, 1.876443389, 1.876527957, 1.876580913, 1.876656891, 1.876765498, 1.876881883, 1.876948365, 1.877014579, 1.877125125, 1.877161888, 1.877262602, 1.87734253, 1.877381585, 1.877442293, 1.877512929, 1.877615649, 1.877650794, 1.877724951, 1.877798229, 1.87784967, 1.877975502, 1.878020202, 1.878151172, 1.878221485, 1.878325806, 1.878389224, 1.87845106, 1.878493342, 1.878573721, 1.878629432, 1.878676416, 1.878811944, 1.878892178, 1.878925322, 1.878951753, 1.879045237, 1.879130989, 1.879211442, 1.87926171, 1.8793691, 1.879414956, 1.879462633, 1.879509959, 1.879569367, 1.879688823, 1.879824506, 1.879881912, 1.879946303, 1.880016967, 1.880071337, 1.880138786, 1.880175357, 1.880244357, 1.880306951, 1.880384977, 1.880528931, 1.880558149, 1.880572605, 1.880623114, 1.880662681, 1.880709789, 1.880753822, 1.880804606, 1.880840322, 1.880861816, 1.880913014, 1.880955307, 1.880964439, 1.881046539, 1.881095536, 1.881148717, 1.881205435, 1.881288228, 1.881348345, 1.881400325, 1.881430329, 1.881435006, 1.881476653, 1.881504869, 1.881513387, 1.881565983, 1.881663099, 1.881694868, 1.881736657, 1.881760925, 1.881773007, 1.881819437, 1.88185065, 1.881896147, 1.882025293, 1.882165714, 1.882198667, 1.882237335, 1.882265887, 1.882291944, 1.882321357, 1.882417017, 1.882433398, 1.882467213, 1.882512449, 1.882532624, 1.882552098, 1.882564904, 1.882596359, 1.88273094, 1.882752161, 1.88277869, 1.88281518, 1.882837527, 1.882889281, 1.882899245, 1.88296568, 1.882985475, 1.88302669, 1.883037421, 1.883059205, 1.883122296, 1.883169417, 1.883204626, 1.883272784, 1.883290337, 1.883302512, 1.883333876, 1.88335051, 1.883396561, 1.883426206, 1.883437231, 1.883476368, 1.883537702, 1.883565608, 1.883598869, 1.883671817, 1.88370509, 1.883718256, 1.883772535, 1.883795134, 1.883825164, 1.883862825, 1.883895913, 1.883945456, 1.883955054, 1.883969863, 1.88400399, 1.884007114, 1.884134975, 1.884145097, 1.884177685, 1.884203401, 1.884209634, 1.884225962, 1.884319578, 1.884325646, 1.884345072, 1.884358175, 1.884362145, 1.884382522, 1.884397617, 1.884416804, 1.884428978, 1.884434913, 1.884501154, 1.884548858, 1.884592467, 1.884634491, 1.88465272, 1.884671154, 1.884679435, 1.884717243, 1.884736992, 1.884741987, 1.884762476, 1.884795721, 1.884804257, 1.884813479, 1.884813724, 1.884833916, 1.884877054, 1.884879985, 1.884881567), "6" = c(0.000246485, 0.000246618, 0.000253587, 0.000259073, 0.000259532, 0.000267167, 0.000271747, 0.000271942, 0.000273371, 0.00027391, 0.000285898, 0.00028839, 0.00028888, 0.000289079, 0.00029089, 0.000291376, 0.000294129, 0.000300596, 0.000304032, 0.000305857, 0.00031113, 0.000312364, 0.000321426, 0.000321969, 0.000330719, 0.000331002, 0.000332664, 0.000332988, 0.000333587, 0.00033565, 0.000335927, 0.000340326, 0.000345593, 0.000345869, 0.000352482, 0.000354359, 0.000355907, 0.000363214, 0.000365998, 0.000367313, 0.000368867, 0.000372669, 0.000377003, 0.000382859, 0.00039174, 0.000394547, 0.000396383, 0.000399869, 0.000401283, 0.000404655, 0.000408318, 0.000414827, 0.000425427, 0.000431453, 0.000433697, 0.000437964, 0.000447794, 0.000449523, 0.000450879, 0.000454065, 0.000463426, 0.000468844, 0.000472636, 0.000478415, 0.000483601, 0.000489217, 0.00049154, 0.000493497, 0.000499022, 0.000500826, 0.000504023, 0.000505537, 0.000515972, 0.000518856, 0.000520827, 0.000526402, 0.000532287, 0.000533156, 0.000533812, 0.000537985, 0.000542936, 0.000545089, 0.000548143, 0.000560101, 0.000565961, 0.000573601, 0.000576895, 0.000580853, 0.000587662, 0.000590061, 0.000592558, 0.000596921, 0.000605138, 0.000611325, 0.000617308, 0.000619754, 0.000625917, 0.000636822, 0.00064243, 0.000648457, 0.000657901, 0.000668478, 0.000675889, 0.000680888, 0.000684118, 0.000686691, 0.000694101, 0.000704787, 0.000707929, 0.000716475, 0.000718466, 0.000721052, 0.000724169, 0.00072778, 0.0007332, 0.000734941, 0.00073764, 0.000741973, 0.000748402, 0.00076457, 0.000769571, 0.000782568, 0.000785651, 0.000791682, 0.000801812, 0.000808042, 0.000815136, 0.00082432, 0.000829941, 0.000836325, 0.00084193, 0.000852842, 0.000859333, 0.000864819, 0.000872527, 0.000877605, 0.000887824, 0.000895656, 0.000902313, 0.00091541, 0.000926477, 0.000940668, 0.000945049, 0.000954974, 0.000966432, 0.000972355, 0.000982462, 0.000996018, 0.001007897, 0.001013048, 0.00101758, 0.001024735, 0.001035965, 0.001046897, 0.001052992, 0.001066313, 0.001079129, 0.00108506, 0.001097272, 0.001108179, 0.001113339, 0.001124504, 0.001135263, 0.001141056, 0.001151709, 0.001161492, 0.001167748, 0.001177794, 0.001186519, 0.001189595, 0.00120074, 0.001212528, 0.001223066, 0.00123308, 0.001240056, 0.001251959, 0.001270731, 0.001277845, 0.001287622, 0.001296158, 0.001304658, 0.001321427, 0.001336762, 0.001343543, 0.001358865, 0.001370926, 0.001385303, 0.001400572, 0.001411287, 0.001433104, 0.001439686, 0.001455915, 0.001465133, 0.001482511, 0.001497064, 0.001507568, 0.001531063, 0.001537828, 0.001547516, 0.0015687, 0.001574207, 0.001584822, 0.001598446, 0.001613703, 0.001626805, 0.001643932, 0.001654442, 0.001669392, 0.001683267, 0.001698127, 0.001703123, 0.001715036, 0.00173058, 0.001749374, 0.001764104, 0.001787637, 0.001797907, 0.001817566, 0.001833269, 0.001847406, 0.001860595, 0.001874604, 0.001889999, 0.001904342, 0.001916885, 0.001939481, 0.001959775, 0.001976596, 0.001994139, 0.00200939, 0.002025805, 0.002041327, 0.002067451, 0.002089387, 0.002118721, 0.002140637, 0.002165125, 0.002182357, 0.00219909, 0.0022208, 0.002236674, 0.002253478, 0.002276949, 0.00230146, 0.002321761, 0.002339422, 0.002361516, 0.002393204, 0.002415941, 0.00244053, 0.002471367, 0.002489967, 0.002513338, 0.002546287, 0.002575781, 0.002597431, 0.002614888, 0.002634147, 0.002657245, 0.002677071, 0.002699378, 0.002723024, 0.002743961, 0.002770983, 0.002796584, 0.002818539, 0.002844162, 0.002868809, 0.002894069, 0.00292066, 0.00295473, 0.002987339, 0.003008433, 0.003028393, 0.003062206, 0.003088751, 0.003120064, 0.00314564, 0.003178599, 0.003218367, 0.003250871, 0.003282724, 0.003317722, 0.003346774, 0.003376342, 0.003407405, 0.003436065, 0.003466058, 0.003497027, 0.003524973, 0.003553681, 0.003590081, 0.003622855, 0.003655904, 0.003687171, 0.003718105, 0.003751636, 0.003780937, 0.003810347, 0.00384306, 0.003885464, 0.003925998, 0.003955115, 0.004001707, 0.004042745, 0.004075462, 0.0041286, 0.004161455, 0.004193849, 0.004224241, 0.004257358, 0.004290674, 0.004324179, 0.004368192, 0.004400867, 0.004435479, 0.00446958, 0.004510619, 0.004546774, 0.004577248, 0.004631653, 0.00466743, 0.004706942, 0.004764024, 0.004806533, 0.004835349, 0.004878557, 0.004916243, 0.004961585, 0.005007497, 0.005049152, 0.005094455, 0.00514834, 0.005199773, 0.005246314, 0.00528905, 0.005323536, 0.005374779, 0.005417338, 0.005476337, 0.005529093, 0.005541984, 0.005598167, 0.005642871, 0.005685682, 0.005724807, 0.005773339, 0.005824333, 0.005870692, 0.005910565, 0.005960266, 0.006019937, 0.006065174, 0.006113726, 0.006163506, 0.006206382, 0.006259026, 0.006316541, 0.006366299, 0.006420061, 0.006485454, 0.006559526, 0.006622545, 0.006682983, 0.006738329, 0.006814324, 0.006872915, 0.006933679, 0.006993052, 0.007058763, 0.007117375, 0.007187377, 0.007249843, 0.007321346, 0.007388371, 0.007453495, 0.00752541, 0.007589976, 0.007649719, 0.007729566, 0.007798538, 0.007874343, 0.00796197, 0.008033242, 0.008112115, 0.00817697, 0.008245501, 0.008316481, 0.008388391, 0.008456237, 0.008531967, 0.00859712, 0.008670801, 0.008751363, 0.008826103, 0.008909743, 0.008978521, 0.00905267, 0.009132298, 0.009210731, 0.009294423, 0.00937523, 0.00946327, 0.009548717, 0.00962587, 0.009708898, 0.009795012, 0.009870488, 0.009962751, 0.010050878, 0.010138563, 0.01021749, 0.010319616, 0.010411236, 0.010504919, 0.010600444, 0.010704447, 0.010791676, 0.010887163, 0.010980673, 0.011056466, 0.011149319, 0.01124667, 0.011351443, 0.011465882, 0.011577222, 0.011678878, 0.011772277, 0.011865739, 0.011986301, 0.012099775, 0.012202841, 0.01231285, 0.012429286, 0.012526831, 0.012639657, 0.012767042, 0.012885083, 0.013004042, 0.013121889, 0.013239984, 0.013348669, 0.013477585, 0.013598518, 0.013705249, 0.013824098, 0.013930125, 0.014048253, 0.014172707, 0.014304233, 0.014437267, 0.014568881, 0.014696099, 0.014822167, 0.014949302, 0.015095329, 0.015252369, 0.015386025, 0.015514958, 0.015652726, 0.015785441, 0.015934635, 0.016078068, 0.016211018, 0.016357346, 0.016510227, 0.016644534, 0.016798233, 0.016941769, 0.017101279, 0.017242105, 0.017397199, 0.01754059, 0.017714358, 0.017862421, 0.018034207, 0.018190656, 0.018354121, 0.018504397, 0.018662404, 0.018824565, 0.018977986, 0.019145639, 0.01932605, 0.019495535, 0.019666716, 0.019847258, 0.020031081, 0.020213571, 0.02039529, 0.020594578, 0.020773302, 0.020955742, 0.021124368, 0.021298347, 0.0214905, 0.021669721, 0.021862811, 0.022057032, 0.02226587, 0.022452273, 0.022656425, 0.022853017, 0.02306349, 0.023272089, 0.023483389, 0.023687817, 0.023894904, 0.024104811, 0.024281779, 0.024503637, 0.024721041, 0.024940641, 0.025167977, 0.02539707, 0.025637431, 0.025839939, 0.026066328, 0.026297204, 0.026534596, 0.026753468, 0.026969672, 0.027202202, 0.027442615, 0.027671905, 0.02790549, 0.028144237, 0.028399588, 0.028635174, 0.028879818, 0.029115736, 0.029362533, 0.029604482, 0.02985825, 0.030119744, 0.030371937, 0.030637129, 0.030900775, 0.031161184, 0.031425086, 0.031719194, 0.031930839, 0.031990283, 0.032288296, 0.032576889, 0.032846779, 0.03313892, 0.03341411, 0.033702927, 0.033978971, 0.0342843, 0.034574429, 0.034879193, 0.035161223, 0.035459844, 0.035747683, 0.036051533, 0.036359287, 0.036673165, 0.037002904, 0.03732728, 0.037656751, 0.038000172, 0.038321459, 0.038657221, 0.038975558, 0.039310193, 0.039643901, 0.040008388, 0.040347021, 0.040694385, 0.041034026, 0.041368597, 0.041718161, 0.042065413, 0.042422495, 0.042780302, 0.043144025, 0.04351107, 0.043899034, 0.044286008, 0.04468936, 0.045046493, 0.045429625, 0.04580407, 0.046196428, 0.046607983, 0.047009877, 0.047389878, 0.047780151, 0.048173407, 0.048596042, 0.048992478, 0.049445153, 0.049835888, 0.050235357, 0.050654457, 0.051093823, 0.051513066, 0.051954032, 0.05236864, 0.052795948, 0.053244296, 0.053700017, 0.054145201, 0.054589731, 0.055056418, 0.055514079, 0.055960662, 0.056424808, 0.056893481, 0.057365678, 0.057852164, 0.058325685, 0.058807887, 0.059261155, 0.059735377, 0.060240082, 0.060736415, 0.061224427, 0.061716891, 0.062227152, 0.062731164, 0.06324479, 0.063775158, 0.064305797, 0.064831251, 0.065371129, 0.065898878, 0.066423806, 0.066980024, 0.0675527, 0.068106688, 0.068712559, 0.069263362, 0.069804002, 0.070390413, 0.070986865, 0.071566338, 0.07216585, 0.072753836, 0.073364248, 0.073942902, 0.074562589, 0.075163804, 0.075770337, 0.076397274, 0.077017575, 0.077632396, 0.078235232, 0.078878657, 0.079497706, 0.080129892, 0.080769897, 0.081443266, 0.082098723, 0.082760907, 0.083419272, 0.084083935, 0.084779539, 0.085462831, 0.08618669, 0.086877244, 0.087568921, 0.088282426, 0.088999638, 0.089735005, 0.090473847, 0.091172681, 0.091931985, 0.092686606, 0.09342377, 0.09418967, 0.094952056, 0.095702426, 0.096472329, 0.097228548, 0.097982703, 0.098784307, 0.099562915, 0.100373278, 0.101162267, 0.101969366, 0.102765034, 0.103576577, 0.104399439, 0.105220722, 0.106026751, 0.1068887, 0.107735984, 0.108570582, 0.109447477, 0.110321891, 0.111194531, 0.112076163, 0.112966118, 0.113903338, 0.114813885, 0.115704952, 0.11659069, 0.117487094, 0.118405129, 0.11934409, 0.120283018, 0.121232628, 0.122177352, 0.123134424, 0.124078798, 0.125021484, 0.125970493, 0.126945053, 0.127899122, 0.128862533, 0.129858012, 0.130845589, 0.131820512, 0.132829465, 0.133848851, 0.134858075, 0.135893496, 0.136936106, 0.137978716, 0.139036256, 0.140088614, 0.1411303, 0.142185485, 0.143253991, 0.14433436, 0.145408738, 0.146480772, 0.147550095, 0.148661487, 0.149754632, 0.150854653, 0.151941654, 0.153083608, 0.154235075, 0.155368298, 0.156513889, 0.157663611, 0.158824578, 0.160001827, 0.160939311, 0.161181332, 0.162371293, 0.163551019, 0.164740708, 0.165949784, 0.167184126, 0.168363469, 0.169578991, 0.170809656, 0.172066527, 0.173300365, 0.174565509, 0.175816484, 0.177092902, 0.178388876, 0.179667137, 0.180938157, 0.182237872, 0.183528609, 0.184824968, 0.18609945, 0.187426281, 0.188766067, 0.19009978, 0.191433625, 0.192757563, 0.194089233, 0.195441687, 0.196775728, 0.198174218, 0.199556166, 0.200954458, 0.202342584, 0.203757183, 0.205149424, 0.206569262, 0.20796733, 0.20942396, 0.210862975, 0.212294992, 0.213724176, 0.2151523, 0.216617542, 0.2180836, 0.219558011, 0.221031132, 0.222500939, 0.223970653, 0.225472997, 0.226960793, 0.228434924, 0.229932951, 0.231410403, 0.232937581, 0.23441535, 0.23590675, 0.237442128, 0.238980361, 0.240501406, 0.242023056, 0.243573647, 0.245120579, 0.246656201, 0.248189204, 0.249736215, 0.251244117, 0.252768325, 0.254304515, 0.255824225, 0.257335218, 0.258880753, 0.260394098, 0.261938109, 0.263472, 0.265011515, 0.266551645, 0.268090393, 0.269655008, 0.271231912, 0.272806906, 0.274386916, 0.275961174, 0.277534874, 0.279138279, 0.280744703, 0.282344631, 0.283981926, 0.285637223, 0.287272342, 0.288940711, 0.290610709, 0.292292405, 0.293978784, 0.295682927, 0.297403313, 0.29911688, 0.299495273, 0.300840673, 0.302596905, 0.304339326, 0.306116666, 0.307897305, 0.309691984, 0.311518602, 0.313345364, 0.315185143, 0.317037183, 0.318889338, 0.320762703, 0.322651974, 0.324554982, 0.326463497, 0.328411381, 0.330344571, 0.332291897, 0.334250722, 0.33624776, 0.338241949, 0.340267382, 0.342313487, 0.344364995, 0.346405896, 0.346830594, 0.348495625, 0.350597168, 0.35270044, 0.354808546, 0.356927537, 0.359064983, 0.361248812, 0.363424827, 0.365609751, 0.367847791, 0.370065543, 0.372325169, 0.374598783, 0.376854706, 0.379157423, 0.381484855, 0.383811505, 0.386167815, 0.388525397, 0.390897001, 0.393309073, 0.395764055, 0.398228015, 0.400692694, 0.403164806, 0.405659139, 0.408185324, 0.410719813, 0.413277327, 0.415840449, 0.418455012, 0.421054878, 0.423685454, 0.426318738, 0.42898903, 0.430128892, 0.431689271, 0.434426187, 0.437163748, 0.439936488, 0.442731371, 0.445533371, 0.448354203, 0.451202122, 0.454069666, 0.456963785, 0.459906643, 0.462857778, 0.465824457, 0.468788869, 0.471785069, 0.474824375, 0.477858796, 0.480939197, 0.484039522, 0.487169492, 0.490313769, 0.493512722, 0.496721116, 0.499955775, 0.503225591, 0.504572431, 0.506501575, 0.509790148, 0.513113252, 0.516464448, 0.519844262, 0.523227971, 0.526629395, 0.530071305, 0.533558465, 0.537067353, 0.54058614, 0.544136728, 0.547728347, 0.551332541, 0.554979224, 0.558662864, 0.562357685, 0.566061298, 0.569846543, 0.572901344, 0.579727446, 0.583486893, 0.587157053, 0.590859926, 0.594491372, 0.598098154, 0.601637009, 0.605194222, 0.608718536, 0.612260202, 0.615784417, 0.619271219, 0.62272512, 0.62617206, 0.629628725, 0.63306172, 0.636475966, 0.639873819, 0.64187507, 0.643253385, 0.646598697, 0.649940787, 0.653263525, 0.656594778, 0.659915513, 0.663179766, 0.666502633, 0.669776396, 0.673032578, 0.676287381, 0.679513645, 0.682747923, 0.685955345, 0.689171514, 0.692374964, 0.695543528, 0.698732069, 0.701869318, 0.70501445, 0.708162965, 0.711274515, 0.71441099, 0.717506195, 0.720597108, 0.722362952, 0.723671084, 0.726737049, 0.729819492, 0.732860956, 0.735908533, 0.738963627, 0.741971446, 0.74498608, 0.748035879, 0.751073996, 0.754070386, 0.757059661, 0.760062072, 0.763046523, 0.766045306, 0.769055103, 0.771998857, 0.774989638, 0.777984287, 0.780971076, 0.783933592, 0.78693287, 0.789936518, 0.792921594, 0.795929339, 0.798951753, 0.801984288, 0.805019304, 0.808060388, 0.811180883, 0.814322933, 0.817497395, 0.820739316, 0.82397795, 0.827250215, 0.829877239, 0.830541885, 0.833867052, 0.837212534, 0.840617011, 0.843981949, 0.84737906, 0.850771122, 0.854219202, 0.857686177, 0.861166241, 0.864645635, 0.868211535, 0.87175644, 0.875326931, 0.878916281, 0.882509251, 0.886158877, 0.889830564, 0.893524845, 0.897218447, 0.900988798, 0.904728778, 0.908559583, 0.912378762, 0.91619454, 0.919182072, 0.92002264, 0.923945844, 0.927830849, 0.931752202, 0.935733904, 0.939722034, 0.943785832, 0.947925582, 0.952032871, 0.956235337, 0.960440997, 0.964713269, 0.969013021, 0.973372937, 0.977886421, 0.982436118, 0.987050311, 0.99171158, 0.996460095, 1.001241347, 1.006138131, 1.011226555, 1.016379611, 1.02163531, 1.027154645, 1.032884829, 1.038777747, 1.044907548, 1.051157528, 1.057747208, 1.064560746, 1.071435195, 1.078422169, 1.085496628, 1.092511796, 1.099597052, 1.106674673, 1.113892821, 1.121172612, 1.128420911, 1.135661698, 1.142898981, 1.150194156, 1.157451578, 1.164861607, 1.172116263, 1.179441966, 1.186936202, 1.194361503, 1.201789969, 1.209227704, 1.216656207, 1.224215683, 1.231667682, 1.239221396, 1.246698425, 1.254298421, 1.261787296, 1.269314132, 1.27671841, 1.284313532, 1.291864721, 1.299502675, 1.307025262, 1.314687112, 1.322201909, 1.329786664, 1.337394558, 1.345093327, 1.352841619, 1.360741237, 1.36853041, 1.376261873, 1.38389413, 1.391496689, 1.399129572, 1.40696014, 1.414708006, 1.42236544, 1.430096232, 1.437805462, 1.445545173, 1.453116092, 1.460674564, 1.468351205, 1.475946873, 1.483746698, 1.491522797, 1.499275547, 1.506944937, 1.514608044, 1.522205958, 1.529816998, 1.537503361, 1.545358609, 1.553031667, 1.554590054, 1.560639709, 1.568319972, 1.57603782, 1.583602347, 1.591142001, 1.598660037, 1.606199805, 1.613660901, 1.621251576, 1.628818948, 1.636258713, 1.643852732, 1.651544065, 1.65913225, 1.666680614, 1.674266415, 1.681905687, 1.689311328, 1.696902145, 1.704479291, 1.711836351, 1.719214615, 1.726586109, 1.734180428, 1.74162336, 1.749095306, 1.756620811, 1.763960035, 1.771329877, 1.778677365, 1.786159575, 1.793696649, 1.800858235, 1.808355585, 1.815676972, 1.822865331, 1.830123448, 1.837445185, 1.844769515, 1.851910714, 1.858921824, 1.86633693, 1.873476699, 1.880688952, 1.887678009, 1.894961537, 1.902155416, 1.9094204, 1.916554675, 1.923744931, 1.930842003, 1.937617243, 1.9445652, 1.951359257, 1.958427503, 1.965511132, 1.972386327, 1.979503795, 1.986653102, 1.993334431, 2.000354034, 2.007217762, 2.014133349, 2.021037813, 2.028029138, 2.034910074, 2.041658594, 2.0484236, 2.0551091, 2.061836865, 2.068453079, 2.075119735, 2.081713153, 2.088263612, 2.094843644, 2.101459576, 2.108202105, 2.114518074, 2.12111356, 2.127582795, 2.134053836, 2.140606807, 2.147061437, 2.1533559, 2.159650676, 2.166170118, 2.172547049, 2.179008197, 2.185475138, 2.191929842, 2.197896921, 2.204302226, 2.210336528, 2.216807173, 2.222892122, 2.229053624, 2.235151812, 2.241497319, 2.247539279, 2.253867524, 2.259937656, 2.265966753, 2.272032391, 2.278119029, 2.284177605, 2.290227785, 2.296125507, 2.302158162, 2.308120163, 2.314221456, 2.319994993, 2.325652575, 2.331750361, 2.337618067, 2.343299919, 2.348982322, 2.354754909, 2.360601636, 2.366506015, 2.372135085, 2.377476136, 2.383167142, 2.388781449, 2.394506849, 2.399963456, 2.405599009, 2.411201981, 2.416516667, 2.421969218, 2.427343379, 2.432828062, 2.438372167, 2.443839297, 2.449433857, 2.454737441, 2.459890993, 2.465284905, 2.470859237, 2.476282717, 2.48161123, 2.486910363, 2.492327341, 2.497513024, 2.502799682, 2.508219197, 2.513747793, 2.518902561, 2.523972199, 2.528853273, 2.533974288, 2.539146839, 2.544183082, 2.54908999, 2.553847318, 2.558811725, 2.563747331, 2.568768069, 2.573991901, 2.579176103, 2.584048872, 2.588897609, 2.593554903, 2.598150689, 2.602987673, 2.607902031, 2.612455565, 2.617399437, 2.622265412, 2.626914673, 2.631269002, 2.636060569, 2.640563209, 2.64523817, 2.649670012, 2.654292163, 2.659141407, 2.66378771, 2.668396452, 2.672997922, 2.677561738, 2.681897376, 2.686170403, 2.690472585, 2.694873192, 2.699595784, 2.704011652, 2.708409227, 2.712615778, 2.717278386, 2.721581397, 2.72568767, 2.729910178, 2.734005913, 2.738317653, 2.742313622, 2.746740379, 2.75090508, 2.755012955, 2.759030681, 2.762889471, 2.763609037, 2.766722182, 2.770774736, 2.775128288, 2.779053571, 2.783003082, 2.787079994, 2.791288762, 2.795367673, 2.799162897, 2.803125686, 2.80716279, 2.810994888, 2.815227341, 2.819181767, 2.823154699, 2.826984812, 2.830815091, 2.834446644, 2.838333687, 2.842103289, 2.845778073, 2.849611452, 2.853168252, 2.856664422, 2.860409848, 2.864213555, 2.867827334, 2.871710009, 2.875517019, 2.878983543, 2.882634443, 2.886202359, 2.88979874, 2.893306939, 2.896661592, 2.900175004, 2.903675467, 2.907130098, 2.910665622, 2.913966097, 2.917545904, 2.920967245, 2.924227493, 2.927530933, 2.931169898, 2.934187053, 2.93741082, 2.940751557, 2.943925809, 2.947074024, 2.95042207, 2.953453575, 2.956869782, 2.960188365, 2.963416107, 2.966788105, 2.96972458, 2.972558069, 2.975783309, 2.978722078, 2.981465692, 2.984528872, 2.987487628, 2.990569723, 2.993597245, 2.996472879, 2.999412667, 3.002256589, 3.005253483, 3.008234406, 3.010652024, 3.013534932, 3.016407552, 3.019664747, 3.022618291, 3.025532499, 3.028486643, 3.03135115, 3.034081558, 3.036699048, 3.040037365, 3.042814282, 3.045520809, 3.048102556, 3.051069039, 3.053658286, 3.05639731, 3.059264896, 3.0627063, 3.065402949, 3.067952821, 3.070682825, 3.07318895, 3.075859704, 3.078058032, 3.080774016, 3.083298099, 3.085922299, 3.08846848, 3.091268365, 3.094047362, 3.096467642, 3.099029936, 3.101614549, 3.104050342, 3.10663343, 3.108804939, 3.110981557, 3.113043106, 3.115304448, 3.117703984, 3.120096435, 3.122581149, 3.12486342, 3.127429403, 3.130191939, 3.13250667, 3.134927137, 3.13769589, 3.140457595, 3.14256888, 3.144529296, 3.147033607, 3.149106084, 3.151477651, 3.153581604, 3.155711547, 3.157738574, 3.160027442, 3.162232799, 3.164372806, 3.166488448, 3.169063894, 3.171632415, 3.173568211, 3.175830889, 3.177797057, 3.179614591, 3.181716734, 3.183769393, 3.185603172, 3.187435721, 3.189668843, 3.191488977, 3.193343536, 3.195379499, 3.197291571, 3.199692728, 3.201645009, 3.203295055, 3.205024714, 3.206706842, 3.208372779, 3.210354644, 3.212115627, 3.213923556, 3.21574783, 3.217808955, 3.219691555, 3.221465124, 3.22325564, 3.225067188, 3.226682332, 3.228764392, 3.230599919, 3.232752167, 3.23435939, 3.236300792, 3.238293365, 3.239945527, 3.241866887, 3.243595024, 3.245161882, 3.246549235, 3.248129485, 3.249845686, 3.251707384, 3.253623619, 3.254869415, 3.256417497, 3.258290733, 3.260065926, 3.261846396, 3.263556213, 3.265351052, 3.267140614, 3.268811983, 3.27018966, 3.271773684, 3.273233559, 3.275093701, 3.276767089, 3.278460949, 3.279697671, 3.281341028, 3.282803181, 3.284492289, 3.286402964, 3.287837053, 3.289580551, 3.289824571, 3.291201421, 3.292516019, 3.293780773, 3.295183207, 3.296904513, 3.298198254, 3.299511511, 3.300903705, 3.302711919, 3.30371588, 3.305039158, 3.306524243, 3.307604644, 3.309023536, 3.310608474, 3.312084522, 3.313488349, 3.314747143, 3.316026124, 3.317446162, 3.318616462, 3.319968387, 3.321177722, 3.322608603, 3.324018223, 3.325271473, 3.326268641, 3.327758158, 3.329134318, 3.330363987, 3.331345298, 3.332784851, 3.333767478, 3.335265304, 3.336440292, 3.337631353, 3.338998084, 3.339792137, 3.340999285, 3.342161667, 3.343396601, 3.344376789, 3.345736506, 3.346918231, 3.348272899, 3.34942441, 3.350526647, 3.352277932, 3.353791224, 3.354661003, 3.355697253, 3.356941477, 3.358455636, 3.359657659, 3.361050197, 3.36209321, 3.362775282, 3.364127548, 3.365261329, 3.366184889, 3.367079031, 3.368621855, 3.369770279, 3.370643724, 3.371801885, 3.373104775, 3.374590683, 3.375607452, 3.37661392, 3.377668368, 3.378597515, 3.379728412, 3.381074915, 3.382147753, 3.38329536, 3.384127007, 3.385112345, 3.38597737, 3.387107612, 3.388139154, 3.389064678, 3.390012423, 3.391041267, 3.391761332, 3.392562652, 3.393380495, 3.393977783, 3.395182948, 3.396020965, 3.397473156, 3.39804453, 3.399056571, 3.400117117, 3.401262851, 3.402035062, 3.402870994, 3.403325662, 3.404020163, 3.405031916, 3.405965376, 3.40657156, 3.407435804, 3.408228997, 3.409488735, 3.410454034, 3.411358508, 3.411896521, 3.412390726, 3.413530614, 3.414302395, 3.415106648, 3.415956404, 3.416787351, 3.417458693, 3.418094132, 3.418771128, 3.419465213, 3.420400613, 3.421076607, 3.421893229, 3.422176933, 3.423367252, 3.423917197, 3.424977414, 3.426180083, 3.426863582, 3.42768839, 3.428442145, 3.42913618, 3.429960334, 3.430382753, 3.431084074, 3.431441572, 3.432008014, 3.432757914, 3.433289567, 3.43400751, 3.434698921, 3.435231257, 3.435950702, 3.436378817, 3.436852587, 3.437544923, 3.43806602, 3.438744096, 3.439499486, 3.440248073, 3.440699826, 3.441084483, 3.441374402, 3.441870704, 3.442519813, 3.443035425, 3.443489049, 3.444229413, 3.444978974, 3.445578867, 3.446427517, 3.447063638, 3.44765875, 3.448206501, 3.448648217, 3.449121877, 3.44969943, 3.450325629, 3.450870557, 3.451423046, 3.451924058, 3.452466301, 3.452947579, 3.453437109, 3.453726011, 3.454320969, 3.454873386, 3.455807072, 3.456519443, 3.457032548, 3.457550901, 3.458241934, 3.458781487, 3.459170562, 3.459690588, 3.460096318, 3.460443907, 3.461028863, 3.461262514, 3.461945358, 3.462591816, 3.463313849, 3.463633193, 3.464111897, 3.464698768, 3.464985326, 3.465667621, 3.466114259, 3.466463464, 3.466679304, 3.467168858, 3.467531219, 3.467944251, 3.468160623, 3.468787091, 3.469554673, 3.470055153, 3.470463612, 3.471065236, 3.471700489, 3.472177884, 3.472420049, 3.472912304, 3.473377561, 3.47404502, 3.474726554, 3.475280201, 3.475592138, 3.476171267, 3.476565039, 3.477189822, 3.477821988, 3.478350414, 3.478805709, 3.479433079, 3.479852743, 3.480231196, 3.480698787, 3.481437487, 3.481880847, 3.481987965, 3.482588669, 3.482921349, 3.483829706, 3.484563277, 3.484645735, 3.485186279, 3.485734328, 3.486039558, 3.486283273, 3.48657518, 3.487129953, 3.487712441, 3.487944258, 3.488297078, 3.48884142, 3.489262719, 3.489451232, 3.490634491, 3.491493559, 3.491660782, 3.492020947, 3.492284671, 3.492851636, 3.493694634, 3.493783841, 3.493956654, 3.494435777, 3.494805779, 3.494899121, 3.495066503, 3.495936109, 3.496310048, 3.496796429, 3.497333088, 3.497809248, 3.49808808, 3.498180502, 3.49894318, 3.49898516, 3.499512312, 3.500047084, 3.500400626, 3.500634298, 3.500698624, 3.500986985, 3.501120749, 3.501364002, 3.50155378, 3.501789961, 3.501940435, 3.502169827, 3.502205169, 3.502765235, 3.502884532, 3.503065053, 3.503250681, 3.503625377, 3.50402256, 3.504606819, 3.504896275, 3.504918342, 3.505050988, 3.505416526, 3.505578757, 3.505780192, 3.506665255, 3.507205941, 3.507541167, 3.507623545, 3.507826336, 3.50831775, 3.508401156, 3.50840205, 3.50869149, 3.508965164, 3.509482273, 3.509650182, 3.510016516, 3.510273843, 3.510625921, 3.511109543, 3.511303434, 3.511347563, 3.511541381, 3.511785082, 3.512052225, 3.512246229, 3.512307335, 3.512888341, 3.513080935, 3.513148602, 3.513216063, 3.513582066, 3.51361344, 3.513674071, 3.514281942, 3.514525287, 3.514759158, 3.514857549, 3.514862308, 3.515173569, 3.515452764, 3.515565793, 3.515932833, 3.516320975, 3.516342971, 3.516560009, 3.516700529, 3.516720592, 3.517565526, 3.517832935, 3.518028782), "8" = c(4.0113e-05, 4.0127e-05, 4.033e-05, 4.0845e-05, 4.0984e-05, 4.1605e-05, 4.1992e-05, 4.2031e-05, 4.295e-05, 4.2979e-05, 4.3371e-05, 4.3794e-05, 4.4847e-05, 4.4915e-05, 4.499e-05, 4.5466e-05, 4.5666e-05, 4.6604e-05, 4.6707e-05, 4.7212e-05, 4.7535e-05, 4.7783e-05, 4.832e-05, 4.9849e-05, 5.0728e-05, 5.1081e-05, 5.2244e-05, 5.2324e-05, 5.3228e-05, 5.5268e-05, 5.5944e-05, 5.7022e-05, 5.8298e-05, 5.8345e-05, 5.9821e-05, 6.0144e-05, 6.0195e-05, 6.2007e-05, 6.2588e-05, 6.3681e-05, 6.3934e-05, 6.4839e-05, 6.5427e-05, 6.6905e-05, 6.788e-05, 6.9098e-05, 7.0569e-05, 7.0994e-05, 7.1343e-05, 7.268e-05, 7.3113e-05, 7.4354e-05, 7.5255e-05, 7.703e-05, 7.8031e-05, 7.9592e-05, 8.0085e-05, 8.0323e-05, 8.0975e-05, 8.3584e-05, 8.6302e-05, 8.8593e-05, 8.9164e-05, 9.0297e-05, 9.0748e-05, 9.173e-05, 9.3127e-05, 9.3561e-05, 9.4417e-05, 9.4905e-05, 9.6603e-05, 9.6805e-05, 9.7281e-05, 9.867e-05, 9.9086e-05, 9.9919e-05, 0.000100669, 0.000103024, 0.000103407, 0.000106, 0.000106667, 0.00010875, 0.00011117, 0.00011181, 0.000113051, 0.000114299, 0.000116402, 0.000118703, 0.000119564, 0.000122153, 0.000123566, 0.000126762, 0.000127571, 0.000129913, 0.000130302, 0.000131606, 0.000134256, 0.000135652, 0.000138673, 0.000140027, 0.000140244, 0.000141649, 0.000143069, 0.000144494, 0.000145066, 0.000145933, 0.000149336, 0.000151204, 0.000152106, 0.000154245, 0.000155987, 0.00015845, 0.000160081, 0.000162205, 0.000164821, 0.000165375, 0.000168886, 0.000171231, 0.000171808, 0.000172904, 0.000174872, 0.000177601, 0.000177952, 0.000180157, 0.000183334, 0.000185051, 0.000186748, 0.00018923, 0.000191922, 0.000192458, 0.000193666, 0.000194983, 0.00019702, 0.000200122, 0.000201385, 0.000203045, 0.000205098, 0.000207155, 0.000207953, 0.000210664, 0.000212518, 0.00021531, 0.000220107, 0.000222621, 0.000224265, 0.000225471, 0.000228673, 0.000229816, 0.000231477, 0.000234395, 0.000236399, 0.000238493, 0.000240272, 0.000243626, 0.000245832, 0.000248392, 0.000250731, 0.000253111, 0.000258134, 0.000261501, 0.000265408, 0.00026785, 0.000268816, 0.000271244, 0.000274927, 0.000277261, 0.000281004, 0.000283287, 0.000285963, 0.000288796, 0.000290863, 0.000295051, 0.000298186, 0.000301069, 0.000303248, 0.000306571, 0.000311192, 0.000314516, 0.000319015, 0.000321616, 0.000326769, 0.000329484, 0.000334272, 0.000337311, 0.000340297, 0.000343193, 0.000346429, 0.000351409, 0.0003564, 0.000363766, 0.000369437, 0.000376177, 0.000378448, 0.000381659, 0.000387327, 0.000391594, 0.000397114, 0.000400063, 0.000404807, 0.000410513, 0.000415242, 0.000422893, 0.000426624, 0.000430182, 0.000433672, 0.000439068, 0.000444206, 0.000447612, 0.00045102, 0.000456954, 0.000464583, 0.000471205, 0.000475862, 0.000481245, 0.000487205, 0.000494627, 0.000498919, 0.000503656, 0.000509194, 0.000515272, 0.000518081, 0.000523371, 0.000529576, 0.00053519, 0.000540811, 0.000545492, 0.000549632, 0.000555306, 0.000559738, 0.000565244, 0.000571749, 0.0005807, 0.000588242, 0.000599217, 0.000604127, 0.000611372, 0.00061804, 0.000628337, 0.00063307, 0.000639875, 0.000646157, 0.000655355, 0.000662592, 0.000668499, 0.000677019, 0.000681711, 0.00068956, 0.000695076, 0.000701492, 0.000710776, 0.000719169, 0.000723976, 0.000737912, 0.000749451, 0.000756599, 0.000765768, 0.000774647, 0.000784868, 0.000795009, 0.000804585, 0.000808807, 0.000819503, 0.000831773, 0.000839706, 0.000849455, 0.000861986, 0.000874413, 0.000884933, 0.000896151, 0.000906718, 0.000918016, 0.000928765, 0.000937372, 0.000944815, 0.000958586, 0.000969842, 0.000978446, 0.000991095, 0.001000563, 0.001009215, 0.001021071, 0.001035306, 0.001049018, 0.001061916, 0.001071104, 0.001084741, 0.001096268, 0.001111301, 0.001126362, 0.001137305, 0.001154894, 0.00116982, 0.001183228, 0.001198235, 0.001211047, 0.001225496, 0.001236371, 0.001251156, 0.001267817, 0.001285788, 0.001297004, 0.001313018, 0.001324379, 0.001338485, 0.001354135, 0.00136864, 0.0013848, 0.001399952, 0.001416367, 0.001435662, 0.001455764, 0.001473214, 0.001491908, 0.001510663, 0.001527533, 0.00154732, 0.001566909, 0.001586582, 0.001602017, 0.001616482, 0.001632141, 0.00164848, 0.00166434, 0.001689284, 0.001705477, 0.001718268, 0.001740629, 0.001755747, 0.001774348, 0.001790627, 0.00181156, 0.001829344, 0.001847576, 0.001868897, 0.001888759, 0.001910985, 0.001931256, 0.001952463, 0.001975452, 0.002001879, 0.002015152, 0.002019863, 0.002041689, 0.002065844, 0.002084108, 0.002103858, 0.002126843, 0.002147346, 0.002176134, 0.002207653, 0.002232437, 0.002262483, 0.002289486, 0.00231186, 0.002337795, 0.002362483, 0.002389332, 0.002426042, 0.002454606, 0.002482257, 0.002516172, 0.002547913, 0.002579081, 0.002604944, 0.0026356, 0.002670415, 0.002705408, 0.002734808, 0.002769112, 0.002802222, 0.00283155, 0.002858912, 0.002892193, 0.002918508, 0.00295696, 0.002991961, 0.003027919, 0.003057803, 0.003090697, 0.003127972, 0.003168696, 0.00320393, 0.003241954, 0.003279321, 0.003318442, 0.003356433, 0.003397385, 0.003437414, 0.003475622, 0.00351304, 0.003554539, 0.00359865, 0.003637147, 0.003676329, 0.003715017, 0.00375661, 0.003796236, 0.003844229, 0.003887101, 0.003928171, 0.00397561, 0.004023404, 0.004077748, 0.00413487, 0.004188968, 0.004246231, 0.004295759, 0.004342226, 0.004399193, 0.004448081, 0.004500881, 0.004549889, 0.004602567, 0.004662654, 0.004711663, 0.00476624, 0.004821099, 0.004876194, 0.004936241, 0.004996037, 0.005044459, 0.005106161, 0.005162731, 0.005217654, 0.005277418, 0.005334629, 0.005401948, 0.005463128, 0.005528598, 0.005596427, 0.005656876, 0.005729842, 0.005799221, 0.005863886, 0.005926529, 0.005983039, 0.006060199, 0.00613807, 0.006198629, 0.006262984, 0.006332134, 0.006405018, 0.006476121, 0.006552929, 0.006623015, 0.006705432, 0.006773875, 0.006845519, 0.006931178, 0.007013247, 0.007093266, 0.007179192, 0.00725718, 0.007351154, 0.007433705, 0.00751669, 0.007601691, 0.007688976, 0.007768893, 0.007860816, 0.007948041, 0.008038364, 0.008136249, 0.008231872, 0.008321528, 0.008411825, 0.008504824, 0.008593997, 0.008692825, 0.008797846, 0.008903259, 0.008996366, 0.009088201, 0.009200598, 0.009297868, 0.00940178, 0.009501122, 0.00961138, 0.00971612, 0.009827313, 0.009934467, 0.010021319, 0.010137622, 0.01024426, 0.01036051, 0.010476943, 0.010597068, 0.010717908, 0.010837417, 0.010958584, 0.011069569, 0.01119599, 0.01132146, 0.011448654, 0.011563187, 0.011689834, 0.011825385, 0.011952204, 0.012085688, 0.012226031, 0.012365944, 0.012514472, 0.012643689, 0.012791256, 0.012928558, 0.013081602, 0.013218705, 0.013378792, 0.013525152, 0.01368147, 0.013831806, 0.013991312, 0.014151555, 0.014311768, 0.014472783, 0.014631493, 0.014784498, 0.014958869, 0.015125887, 0.015286735, 0.015458222, 0.015637594, 0.015814127, 0.016010783, 0.016191586, 0.016382128, 0.01656162, 0.016743036, 0.016919233, 0.01710031, 0.017282261, 0.01747637, 0.017668133, 0.01787021, 0.018066962, 0.018264813, 0.018470668, 0.018680172, 0.018888479, 0.019092944, 0.019301574, 0.019465302, 0.019513077, 0.019731886, 0.019951208, 0.020164639, 0.020381497, 0.020590124, 0.020805183, 0.021041981, 0.02127306, 0.021501974, 0.021730666, 0.021965947, 0.022207238, 0.022446249, 0.02269493, 0.022948805, 0.023200088, 0.023434263, 0.023686974, 0.023932222, 0.02420679, 0.024490934, 0.02476461, 0.025038855, 0.02531164, 0.025572715, 0.025837127, 0.026111702, 0.026381474, 0.026662279, 0.026937006, 0.027245549, 0.027543716, 0.027828717, 0.028140012, 0.028432922, 0.028731019, 0.029045922, 0.029352994, 0.029665791, 0.029976169, 0.030274112, 0.030581931, 0.030909055, 0.031251467, 0.031583734, 0.031910215, 0.032263456, 0.032607759, 0.032960186, 0.033308706, 0.033671465, 0.034008894, 0.034362784, 0.034748078, 0.035117657, 0.035481814, 0.035849448, 0.036204865, 0.036576278, 0.036972513, 0.037354248, 0.037766069, 0.038147006, 0.038540329, 0.038952025, 0.039338998, 0.039730929, 0.04015352, 0.04057376, 0.040982485, 0.041411844, 0.041825225, 0.042267959, 0.042685428, 0.043133188, 0.043578345, 0.04403485, 0.044497823, 0.044936573, 0.045399494, 0.045876537, 0.046341113, 0.046823228, 0.047280776, 0.047787891, 0.04828274, 0.048774597, 0.049269698, 0.049764183, 0.0502466, 0.050735216, 0.051240896, 0.051743481, 0.052263773, 0.052802417, 0.053332289, 0.053875804, 0.054420092, 0.054952326, 0.05551223, 0.0560581, 0.056624377, 0.057207595, 0.057781968, 0.058349377, 0.058932672, 0.059507004, 0.060102617, 0.060675102, 0.061263766, 0.061875403, 0.062474742, 0.063080816, 0.063710522, 0.064337298, 0.06496146, 0.065591322, 0.066229881, 0.066873624, 0.067511479, 0.068164916, 0.068834802, 0.069473001, 0.070130056, 0.070802875, 0.071463387, 0.072150478, 0.072852004, 0.073549705, 0.074234518, 0.074928651, 0.075662102, 0.07637149, 0.077094314, 0.07780666, 0.078533026, 0.079258877, 0.079996209, 0.08071819, 0.081457169, 0.082223678, 0.082964093, 0.083740788, 0.084525266, 0.085309877, 0.086091976, 0.086876189, 0.087681038, 0.088466692, 0.089272387, 0.090091698, 0.090943661, 0.091773931, 0.092628442, 0.093496382, 0.094342775, 0.09518846, 0.096041448, 0.096890524, 0.097763712, 0.098652486, 0.099552709, 0.100460729, 0.101360769, 0.102277899, 0.103168297, 0.104091322, 0.105021345, 0.105969769, 0.106910274, 0.107884211, 0.108816771, 0.109761082, 0.110747068, 0.111717668, 0.11274081, 0.113733308, 0.114736182, 0.115772782, 0.116769565, 0.117802504, 0.118823783, 0.119861842, 0.120908887, 0.121970079, 0.123045008, 0.124139025, 0.125227387, 0.126321505, 0.127416415, 0.12852183, 0.129647312, 0.130771163, 0.131917621, 0.13305821, 0.134221177, 0.135393993, 0.1365608, 0.13771795, 0.138632941, 0.138867026, 0.140064908, 0.141254494, 0.142482426, 0.143715877, 0.144953375, 0.146189778, 0.147444786, 0.148678774, 0.1499224, 0.151166127, 0.152441136, 0.153696015, 0.154953696, 0.156269575, 0.15760261, 0.158898707, 0.160211327, 0.1615151, 0.16286521, 0.164227299, 0.16558438, 0.166939235, 0.168333542, 0.169725707, 0.171104256, 0.172524661, 0.173928857, 0.175370388, 0.176786885, 0.17824894, 0.179736659, 0.181195894, 0.182669972, 0.184149777, 0.1856612, 0.187147813, 0.188672571, 0.190181439, 0.191706098, 0.193263521, 0.194838288, 0.196405381, 0.19799745, 0.199565738, 0.201165687, 0.202780184, 0.204379329, 0.206015561, 0.207657017, 0.209311653, 0.210977284, 0.212648504, 0.214326304, 0.216023306, 0.217717944, 0.21943923, 0.221167162, 0.222907864, 0.224659926, 0.226409146, 0.228204159, 0.229986083, 0.231775477, 0.233583389, 0.235408882, 0.237254546, 0.239106291, 0.240983301, 0.242872591, 0.244756405, 0.246649027, 0.248540583, 0.250452688, 0.252382579, 0.254311892, 0.256270862, 0.258248494, 0.260222555, 0.262239797, 0.264239994, 0.266235641, 0.268301944, 0.270353653, 0.272404243, 0.274456814, 0.276553241, 0.278682664, 0.280800243, 0.282917078, 0.285068201, 0.287234898, 0.289397674, 0.291592579, 0.293756672, 0.295930047, 0.296412661, 0.29816527, 0.300401457, 0.302663645, 0.304924623, 0.307209611, 0.309497928, 0.311818338, 0.314129942, 0.31650366, 0.318830714, 0.321177586, 0.323534653, 0.325904396, 0.328311518, 0.33073116, 0.33314564, 0.33559132, 0.338058167, 0.340490468, 0.34299361, 0.345470026, 0.347992263, 0.350527983, 0.353069017, 0.35561004, 0.356142542, 0.358157364, 0.360764336, 0.363374824, 0.365998166, 0.36864503, 0.371308855, 0.373989063, 0.376707524, 0.379424497, 0.382145781, 0.384914548, 0.38768099, 0.390475338, 0.393297067, 0.39612223, 0.39897136, 0.401836321, 0.404728844, 0.407637732, 0.410556011, 0.413499551, 0.416447835, 0.419472934, 0.422488094, 0.425541065, 0.428602855, 0.431706659, 0.434806957, 0.437951622, 0.441124349, 0.444280475, 0.447486249, 0.450738395, 0.454001336, 0.457291456, 0.458696882, 0.460621015, 0.463987459, 0.467352659, 0.470783042, 0.474216303, 0.477690652, 0.481212393, 0.484735324, 0.488275983, 0.491861971, 0.495477958, 0.499168285, 0.502888294, 0.506620788, 0.510360589, 0.514112908, 0.517934311, 0.521806637, 0.525679282, 0.529642197, 0.533618728, 0.537622826, 0.541669816, 0.545756189, 0.549893325, 0.551612343, 0.554049027, 0.558268399, 0.562512231, 0.56677467, 0.571055001, 0.575440527, 0.579869196, 0.584367993, 0.58892245, 0.593519558, 0.598109914, 0.60279167, 0.607544237, 0.612307459, 0.617164866, 0.622102629, 0.627014756, 0.632074308, 0.637172244, 0.64124088, 0.65044007, 0.655513745, 0.660553185, 0.665584327, 0.670533717, 0.67543102, 0.680337977, 0.685199376, 0.689999408, 0.69478363, 0.699535807, 0.704211856, 0.708841676, 0.713476271, 0.718085856, 0.722689865, 0.727265561, 0.731791919, 0.734439117, 0.736270772, 0.740736732, 0.745181634, 0.749655777, 0.754101038, 0.758510722, 0.762872965, 0.767269427, 0.771611628, 0.775960883, 0.780269907, 0.784568454, 0.788896373, 0.793159983, 0.797471196, 0.801692075, 0.805923848, 0.810154453, 0.814386962, 0.818580093, 0.822762658, 0.826949325, 0.831135914, 0.835262279, 0.8394329, 0.841809132, 0.84357495, 0.847754738, 0.85190491, 0.856034225, 0.860151945, 0.864289837, 0.868374839, 0.872497364, 0.876611168, 0.880747097, 0.884864279, 0.889015623, 0.893189785, 0.897366509, 0.901495714, 0.905598463, 0.909755329, 0.913981309, 0.918155711, 0.922319175, 0.926511225, 0.93068738, 0.934965999, 0.939168053, 0.943419976, 0.947709798, 0.952065826, 0.956368213, 0.960730314, 0.965063399, 0.969475191, 0.973929476, 0.97832891, 0.982762271, 0.987228635, 0.990821102, 0.991756187, 0.996280877, 1.000822436, 1.005462788, 1.010115852, 1.014760169, 1.019503604, 1.024268488, 1.029024299, 1.033798623, 1.03860537, 1.043496949, 1.048546089, 1.053596065, 1.058658246, 1.063743447, 1.068961857, 1.074130336, 1.079492576, 1.084804685, 1.090149187, 1.095621179, 1.101182198, 1.106765951, 1.112413004, 1.116942833, 1.118220485, 1.124129381, 1.130059958, 1.136140212, 1.142228477, 1.14845495, 1.154856348, 1.161303828, 1.167905483, 1.174705768, 1.181569268, 1.188557071, 1.195525153, 1.202744857, 1.210075333, 1.217517918, 1.22517237, 1.23293905, 1.240723033, 1.248786428, 1.256936228, 1.265112808, 1.273469496, 1.281945433, 1.290599957, 1.299334386, 1.307988622, 1.316774133, 1.325689579, 1.334854, 1.343997395, 1.353256088, 1.36241604, 1.371806833, 1.381195167, 1.390730444, 1.400287204, 1.410009879, 1.419668214, 1.429419495, 1.439209833, 1.449124503, 1.459029191, 1.469024563, 1.478914513, 1.488922679, 1.499100736, 1.509448988, 1.519660179, 1.529905325, 1.540462117, 1.55109404, 1.561603618, 1.572344794, 1.583013743, 1.593858653, 1.604627538, 1.61562163, 1.626568161, 1.637558823, 1.648701076, 1.65984687, 1.671236244, 1.682544944, 1.69387451, 1.705402096, 1.716862842, 1.72869096, 1.740434885, 1.752099575, 1.764137688, 1.776299519, 1.788448865, 1.80051542, 1.812660791, 1.824973505, 1.837493252, 1.849723108, 1.862482445, 1.875012086, 1.887656881, 1.900247413, 1.913080164, 1.925983064, 1.939256027, 1.952250883, 1.965357638, 1.978595102, 1.99188788, 2.005494618, 2.01884326, 2.032286903, 2.046043776, 2.059318548, 2.072976369, 2.086933308, 2.089720898, 2.100351795, 2.113989607, 2.127861225, 2.141865623, 2.15586404, 2.169854302, 2.183961245, 2.198073637, 2.212194225, 2.226345669, 2.240675195, 2.254538606, 2.269078504, 2.283263033, 2.297547037, 2.311724278, 2.326381922, 2.340671499, 2.355249616, 2.36981316, 2.384504606, 2.398803297, 2.41323192, 2.427790812, 2.442808532, 2.457955711, 2.472738693, 2.487838046, 2.502865943, 2.517373964, 2.532197306, 2.547066402, 2.562177019, 2.577405329, 2.592081987, 2.606801812, 2.622080367, 2.636664356, 2.651898029, 2.667279364, 2.682565258, 2.697479523, 2.712686141, 2.728211348, 2.743647355, 2.759240763, 2.774512632, 2.78977269, 2.804772692, 2.820484578, 2.835991227, 2.851564983, 2.866455592, 2.882210053, 2.897641599, 2.913234422, 2.928843981, 2.944208251, 2.959783309, 2.974936169, 2.990259312, 3.005337859, 3.02105701, 3.036519485, 3.051989693, 3.068202553, 3.083810715, 3.098874967, 3.114368543, 3.130470135, 3.146529804, 3.162319098, 3.17783682, 3.193317715, 3.209070519, 3.224761864, 3.240299997, 3.256324084, 3.271653503, 3.287404134, 3.303094373, 3.318411013, 3.334341409, 3.349552387, 3.3653001, 3.380781845, 3.397059766, 3.412759509, 3.428204025, 3.443763699, 3.45946203, 3.475191939, 3.491205206, 3.50699097, 3.5226477, 3.537770938, 3.553298563, 3.568699813, 3.584610359, 3.600328468, 3.616416203, 3.632143424, 3.647792018, 3.664199627, 3.680472687, 3.696219579, 3.711330091, 3.726606105, 3.742696105, 3.758789654, 3.774038801, 3.789289924, 3.804964497, 3.820689724, 3.835753089, 3.851178938, 3.867159212, 3.883560141, 3.89887823, 3.914737319, 3.930404192, 3.946220222, 3.961827317, 3.977306201, 3.993304614, 4.009619112, 4.025312175, 4.041037247, 4.056813878, 4.072710448, 4.087816615, 4.1033018, 4.118381627, 4.134771235, 4.149629611, 4.164950609, 4.180167932, 4.195351712, 4.211302794, 4.226383775, 4.241631617, 4.256500285, 4.271245641, 4.287319197, 4.302373676, 4.317606995, 4.333048804, 4.348550002, 4.364914431, 4.38104059, 4.396763173, 4.412112513, 4.428092719, 4.44287666, 4.458588335, 4.473427664, 4.48887355, 4.50414533, 4.519793848, 4.535216758, 4.550587951, 4.566090749, 4.581441505, 4.59756706, 4.61290163, 4.628130657, 4.642783388, 4.657403349, 4.672373175, 4.687238046, 4.701789, 4.716382416, 4.731204434, 4.745455437, 4.760572009, 4.77650928, 4.792030454, 4.807425718, 4.821321921, 4.836661047, 4.85170574, 4.86709184, 4.881789457, 4.89647461, 4.910782461, 4.925868186, 4.94060752, 4.95619869, 4.971487264, 4.986211576, 5.001164347, 5.016375676, 5.030621216, 5.044201663, 5.058663282, 5.073680388, 5.088841994, 5.103053638, 5.117197321, 5.131273544, 5.134380963, 5.145855032, 5.159138686, 5.173477488, 5.186644592, 5.201280853, 5.214805696, 5.227330622, 5.241745887, 5.254894673, 5.268459318, 5.283004841, 5.296786297, 5.310845712, 5.325876701, 5.340519423, 5.353525665, 5.367478622, 5.381728018, 5.395559371, 5.410379192, 5.424678699, 5.438911802, 5.452265534, 5.466643231, 5.48075255, 5.49460159, 5.508978931, 5.52240022, 5.535653007, 5.549839573, 5.562474114, 5.57563891, 5.589995629, 5.60465439, 5.618024231, 5.630403598, 5.643269818, 5.657263236, 5.670827364, 5.683838562, 5.697062728, 5.711083223, 5.724531201, 5.737750867, 5.751756267, 5.765161971, 5.779504897, 5.791719373, 5.803462799, 5.815908504, 5.828651104, 5.841687592, 5.855539104, 5.868593607, 5.882023736, 5.895140755, 5.908940995, 5.922263803, 5.935454611, 5.946761525, 5.959872967, 5.973624177, 5.985209569, 5.998263632, 6.012458149, 6.026913239, 6.040136941, 6.052319518, 6.064561191, 6.077927028, 6.090845096, 6.104124622, 6.11619511, 6.12980548, 6.141068068, 6.153266557, 6.164402055, 6.177759267, 6.190131232, 6.202131302, 6.214626138, 6.227125308, 6.238958215, 6.250975415, 6.2640096, 6.275915508, 6.288314315, 6.300902514, 6.313010591, 6.324209744, 6.337699018, 6.349800828, 6.362390066, 6.374205935, 6.387470945, 6.399312886, 6.412990704, 6.425872985, 6.436548957, 6.447509657, 6.458792993, 6.469615379, 6.482024319, 6.494345431, 6.505249756, 6.516917822, 6.528070273, 6.539753146, 6.552745298, 6.565256616, 6.576020138, 6.586238014, 6.598313517, 6.611227764, 6.62165779, 6.631691928, 6.643143856, 6.654405712, 6.665349304, 6.675161128, 6.687524812, 6.700412571, 6.710947813, 6.72271854, 6.73404781, 6.743802513, 6.754745556, 6.764358264, 6.77599299, 6.78800906, 6.798329909, 6.808271806, 6.818809405, 6.827887977, 6.839550184, 6.850700139, 6.861178602, 6.870207805, 6.879254066, 6.890743559, 6.900743059, 6.912159782, 6.924031835, 6.934408526, 6.944290521, 6.954371085, 6.963929524, 6.972887765, 6.983690153, 6.994214959, 7.003506163, 7.014364115, 7.023548136, 7.032233185, 7.043480433, 7.053077519, 7.06209644, 7.072671111, 7.082895701, 7.092380057, 7.102958298, 7.112888324, 7.123329122, 7.135016676, 7.143210616, 7.15438583, 7.165528913, 7.174783264, 7.183183783, 7.194378458, 7.202487533, 7.212975632, 7.223547425, 7.233740913, 7.244496879, 7.252784999, 7.261741735, 7.271371778, 7.283980264, 7.294971948, 7.304183774, 7.314345756, 7.322620132, 7.332983189, 7.341071673, 7.351030053, 7.359314809, 7.368316796, 7.376044227, 7.385205998, 7.393639765, 7.402429304, 7.412172382, 7.421971208, 7.433279824, 7.441869409, 7.449495301, 7.458620858, 7.468116586, 7.476877057, 7.480549627, 7.48829792, 7.495888002, 7.504933055, 7.511813721, 7.520122526, 7.528313143, 7.537917085, 7.546768669, 7.55681745, 7.564926784, 7.574101101, 7.58196773, 7.591255125, 7.599334087, 7.605996181, 7.614358577, 7.623043273, 7.631761387, 7.640747402, 7.650165878, 7.661178115, 7.671126689, 7.678230842, 7.687413825, 7.696310665, 7.703719781, 7.71220506, 7.721774749, 7.730394139, 7.739837568, 7.749663857, 7.757353965, 7.765264454, 7.772941956, 7.78113766, 7.790470497, 7.796695259, 7.805076801, 7.813931739, 7.820670148, 7.829352207, 7.836973496, 7.843469695, 7.851640666, 7.859192298, 7.867418875, 7.874238322, 7.883461107, 7.893049003, 7.899517574, 7.90758053, 7.915469044, 7.922010337, 7.928475753, 7.938826418, 7.946700757, 7.953415341, 7.962181244, 7.969872187, 7.977714815, 7.985429219, 7.995471983, 8.002487092, 8.010970536, 8.017256447, 8.023576352, 8.030475646, 8.038546738, 8.048435928, 8.054407974, 8.059598579, 8.065803028, 8.071614966, 8.0767194, 8.083113198, 8.093146509, 8.10134046, 8.107499643, 8.114322677, 8.121199885, 8.126831527, 8.134036068, 8.1400024, 8.150661859, 8.157926265, 8.166849432, 8.173681591, 8.181803244, 8.187037133, 8.193053552, 8.199631792, 8.205287184, 8.209824025, 8.218350937, 8.224247712, 8.230609686, 8.237523214, 8.245977421, 8.250353049, 8.258655522, 8.263787204, 8.270447777, 8.278533936, 8.284318241, 8.292988023, 8.298839001, 8.304094188, 8.31097468, 8.317949728, 8.323279152, 8.329806942, 8.337938547, 8.346021825, 8.353586248, 8.359024652, 8.365610415, 8.371761657, 8.383609303, 8.392730448, 8.397994731, 8.405278849, 8.415566607, 8.420709105, 8.425982837, 8.432707987, 8.439875515, 8.444428389, 8.454760519, 8.461131021, 8.465772122, 8.471475692, 8.479378843, 8.483191067, 8.489319794, 8.49315754, 8.501660553, 8.507809466, 8.514683959, 8.523723324, 8.530037795, 8.537180004, 8.547095916, 8.553643464, 8.559813958, 8.563961619, 8.56952123, 8.574988793, 8.579247689, 8.586347924, 8.592757166, 8.598690054, 8.601964875, 8.609964172, 8.620012544, 8.625723297, 8.635510279, 8.641136148, 8.646636229, 8.650794204, 8.657791452, 8.661520245, 8.668001587, 8.67611085, 8.681212845, 8.685650576, 8.689391442, 8.693096236, 8.701203022, 8.704794271, 8.707449519, 8.715624964, 8.719105487, 8.726159921, 8.731491096, 8.735058318, 8.746802608, 8.752106717, 8.755956387, 8.764821969, 8.773056201, 8.777112255, 8.78298729, 8.789064623, 8.792356054, 8.795936376, 8.803520706, 8.806722627, 8.81172151, 8.816230606, 8.822873249, 8.825653293, 8.82875214, 8.837532973, 8.840020576, 8.84305092, 8.846240429, 8.849132796, 8.855021892, 8.857627283, 8.860117669, 8.866169433, 8.868367558, 8.872943973, 8.874248665, 8.87905568, 8.884684866, 8.89083719, 8.892363103, 8.899291747, 8.90159134, 8.90864608, 8.912877338, 8.918594727, 8.924331846, 8.925113111, 8.930173904, 8.933144335, 8.936133161, 8.940276194, 8.943236333, 8.944618537, 8.949125223, 8.95163792, 8.955305565, 8.958311633, 8.960902935, 8.968155841, 8.972275786, 8.977683076, 8.980357364, 8.981575201, 8.989526346, 8.992767427, 8.995902201, 9.001300482, 9.006438803, 9.010384489, 9.011012605, 9.016733574, 9.018605379, 9.019301735, 9.030618481, 9.036999639, 9.04124411, 9.044334493, 9.048868301, 9.050663182, 9.054258122, 9.056763471, 9.059305926, 9.060700291, 9.063163167, 9.066261546, 9.071557978, 9.076480182, 9.080526665, 9.084508751, 9.08765888, 9.091543029, 9.09520246, 9.097340909, 9.100876858, 9.103463676, 9.105668787, 9.114550928, 9.117121668, 9.11752028, 9.121378756, 9.125626245, 9.126540609, 9.135057066, 9.13532412, 9.138660689, 9.140089218, 9.14236083, 9.144000756, 9.14735692, 9.152942636, 9.154960493, 9.155201261, 9.156446515, 9.158331155, 9.16012823, 9.160722218, 9.167844299, 9.174298161, 9.177378716, 9.183358178, 9.185090345, 9.194145653, 9.196579267, 9.198709083, 9.201639817, 9.210227736, 9.218146401, 9.218869533, 9.220147215, 9.221308737, 9.226103226, 9.236823316, 9.23794137, 9.242590292, 9.246861434, 9.250164564, 9.250941408, 9.253412807, 9.254188225, 9.254346187, 9.263446662, 9.264235715, 9.26601677, 9.268338032, 9.269398789, 9.269722889, 9.270896451, 9.274161522, 9.27929605, 9.281179052, 9.285930354, 9.293614598, 9.296712663, 9.296860098, 9.299870167, 9.303183367, 9.304049533, 9.308433534, 9.313361664, 9.31821701, 9.323647023, 9.329855649, 9.333251634, 9.333660136, 9.337334946, 9.338164483, 9.343075012, 9.345022262, 9.34513263, 9.351094272, 9.359358664, 9.364297906), "10" = c(3.4839e-05, 3.4861e-05, 3.5187e-05, 3.5706e-05, 3.5908e-05, 3.6189e-05, 3.6279e-05, 3.6584e-05, 3.7652e-05, 3.7887e-05, 3.791e-05, 3.8996e-05, 3.9228e-05, 3.9351e-05, 3.9398e-05, 4.007e-05, 4.0214e-05, 4.1066e-05, 4.1071e-05, 4.1374e-05, 4.2437e-05, 4.2445e-05, 4.2833e-05, 4.2868e-05, 4.3323e-05, 4.3878e-05, 4.5029e-05, 4.5215e-05, 4.544e-05, 4.5776e-05, 4.5941e-05, 4.6807e-05, 4.8418e-05, 4.917e-05, 4.9578e-05, 4.9841e-05, 5.0441e-05, 5.0966e-05, 5.1757e-05, 5.2206e-05, 5.2273e-05, 5.2757e-05, 5.3657e-05, 5.3978e-05, 5.4158e-05, 5.4341e-05, 5.6117e-05, 5.6598e-05, 5.7374e-05, 5.7396e-05, 5.7937e-05, 5.8308e-05, 5.8468e-05, 5.915e-05, 5.9279e-05, 6.0185e-05, 6.2356e-05, 6.3296e-05, 6.3605e-05, 6.3768e-05, 6.4935e-05, 6.5981e-05, 6.6074e-05, 6.7255e-05, 6.7918e-05, 6.8445e-05, 6.8623e-05, 6.8902e-05, 7.0206e-05, 7.0799e-05, 7.2006e-05, 7.3314e-05, 7.419e-05, 7.4896e-05, 7.5702e-05, 7.661e-05, 7.6805e-05, 7.7895e-05, 7.9939e-05, 8.1323e-05, 8.1863e-05, 8.297e-05, 8.4342e-05, 8.5379e-05, 8.8252e-05, 8.9425e-05, 9.0363e-05, 9.0898e-05, 9.1771e-05, 9.2181e-05, 9.343e-05, 9.3687e-05, 9.4502e-05, 9.5749e-05, 9.7246e-05, 9.8175e-05, 9.8753e-05, 0.000101259, 0.000102234, 0.000102966, 0.00010349, 0.000105328, 0.00010693, 0.000108356, 0.000109865, 0.00011081, 0.000111366, 0.000116471, 0.00011784, 0.000118671, 0.000119241, 0.000120167, 0.000121351, 0.000124237, 0.000125997, 0.000127023, 0.00012967, 0.000131343, 0.000132312, 0.000134431, 0.000136157, 0.000138441, 0.000139388, 0.00014027, 0.00014115, 0.000142429, 0.000143962, 0.000145547, 0.000147546, 0.000149846, 0.000152037, 0.0001542, 0.000156212, 0.000158338, 0.000159753, 0.000161286, 0.000162434, 0.00016362, 0.000165485, 0.000166515, 0.000168482, 0.000169519, 0.000171676, 0.000173217, 0.000175773, 0.000178142, 0.000180885, 0.000182259, 0.000183484, 0.000184602, 0.000187106, 0.000189166, 0.000190503, 0.000193555, 0.000197096, 0.000200017, 0.000203144, 0.000204564, 0.00020695, 0.000208893, 0.000210594, 0.000211679, 0.000215336, 0.000217863, 0.000220213, 0.000223855, 0.000227646, 0.000228983, 0.00023183, 0.000234674, 0.000236659, 0.000240319, 0.000243862, 0.000248154, 0.000250293, 0.000253085, 0.00025528, 0.000258496, 0.000261117, 0.000265965, 0.00026952, 0.000271453, 0.000274236, 0.000276084, 0.000278344, 0.000282217, 0.000285789, 0.000286619, 0.000290032, 0.000293454, 0.000296564, 0.000299762, 0.000300583, 0.000303507, 0.000306053, 0.000310191, 0.00031309, 0.000317617, 0.000321662, 0.000324798, 0.000329566, 0.000333078, 0.000336457, 0.000342842, 0.000345676, 0.000348926, 0.000354222, 0.000357842, 0.000360589, 0.000363584, 0.000366949, 0.000370518, 0.000375225, 0.000380047, 0.000383565, 0.000387371, 0.000390888, 0.000394317, 0.000399223, 0.000403493, 0.00040783, 0.000411488, 0.00041471, 0.000418813, 0.000423098, 0.000427955, 0.000430956, 0.000435827, 0.000439639, 0.000443581, 0.00044939, 0.000456562, 0.000461501, 0.000465356, 0.000471579, 0.000475269, 0.000485071, 0.000489617, 0.000493112, 0.000500781, 0.000507449, 0.000511348, 0.000517195, 0.000521701, 0.00052824, 0.000533225, 0.000539569, 0.000545146, 0.000550646, 0.00055587, 0.0005604, 0.000567067, 0.000573596, 0.000582613, 0.000589624, 0.000594563, 0.000600728, 0.000609489, 0.000615844, 0.000624084, 0.000632156, 0.000642027, 0.000648117, 0.000658191, 0.000665218, 0.000675011, 0.000681309, 0.000689922, 0.000697727, 0.000705924, 0.000712431, 0.000720916, 0.000728143, 0.00073657, 0.000745649, 0.00075118, 0.000761206, 0.000769235, 0.000776708, 0.00078522, 0.000794522, 0.000807486, 0.000819041, 0.000828768, 0.000839762, 0.000850906, 0.000860377, 0.000871366, 0.000880981, 0.000892664, 0.000900773, 0.000911388, 0.000923239, 0.000932162, 0.000941754, 0.000950341, 0.000958985, 0.000969302, 0.000979129, 0.000987891, 0.000999306, 0.001011805, 0.001022876, 0.001038482, 0.001049271, 0.001066379, 0.001078467, 0.001090907, 0.001104433, 0.001117099, 0.001125667, 0.001137058, 0.001150195, 0.001165551, 0.001177292, 0.001193822, 0.001206389, 0.0012212, 0.001237652, 0.001248771, 0.001261159, 0.001278213, 0.001289666, 0.00130692, 0.001323798, 0.001338517, 0.001355981, 0.001371791, 0.001387156, 0.001403516, 0.001415292, 0.001432367, 0.001449261, 0.001471644, 0.001489693, 0.001503879, 0.001519771, 0.001537645, 0.001553678, 0.00157135, 0.001584364, 0.001588781, 0.001606021, 0.001624494, 0.001642344, 0.001662425, 0.001684175, 0.001699939, 0.001717802, 0.001737493, 0.001756536, 0.001778457, 0.001800134, 0.001821873, 0.001843665, 0.001867114, 0.001886742, 0.001912585, 0.001933293, 0.001958419, 0.001984986, 0.002011824, 0.002033592, 0.002058411, 0.002077427, 0.002106228, 0.002131332, 0.002156875, 0.002181862, 0.002212415, 0.002240264, 0.002268874, 0.002298982, 0.002322101, 0.002353018, 0.00237912, 0.002409121, 0.002435956, 0.002464936, 0.002493549, 0.002527661, 0.002559579, 0.002588474, 0.002618961, 0.002646067, 0.002682171, 0.002711641, 0.002744609, 0.002777509, 0.002809972, 0.002832035, 0.002861589, 0.002892272, 0.002919589, 0.002951047, 0.002979239, 0.003011641, 0.003046923, 0.003081247, 0.003118122, 0.003155955, 0.003190725, 0.003224746, 0.003257636, 0.003288451, 0.003327008, 0.003363772, 0.003402366, 0.003450126, 0.003488245, 0.003530667, 0.003576678, 0.003621338, 0.003665334, 0.003706738, 0.003749721, 0.003790898, 0.003831492, 0.003885118, 0.003926854, 0.003971993, 0.004016871, 0.004064893, 0.004110847, 0.004154862, 0.004196057, 0.00424633, 0.004289902, 0.004343434, 0.004391027, 0.004438262, 0.004488907, 0.00453876, 0.004585855, 0.004638955, 0.004690963, 0.004747075, 0.004796597, 0.004861256, 0.004912422, 0.004972589, 0.005037359, 0.005095556, 0.005155292, 0.005208575, 0.005270249, 0.005327455, 0.005386945, 0.005456113, 0.005522771, 0.005588694, 0.005653106, 0.0057249, 0.005784695, 0.005853493, 0.00592704, 0.00599627, 0.006064931, 0.006126662, 0.006196706, 0.006268111, 0.006346342, 0.006418132, 0.006493265, 0.006557153, 0.00663941, 0.006717969, 0.00679663, 0.006882484, 0.006963572, 0.007051409, 0.007132902, 0.007207094, 0.007291515, 0.007373353, 0.00745308, 0.007532234, 0.007618827, 0.007705484, 0.007795192, 0.007874946, 0.007966579, 0.008045207, 0.008148116, 0.008240174, 0.008342574, 0.008435475, 0.008544276, 0.008633119, 0.008738254, 0.008847872, 0.008943761, 0.009044631, 0.009152752, 0.009260627, 0.009364398, 0.009474209, 0.009580007, 0.009689336, 0.0098059, 0.009912301, 0.010026318, 0.010135789, 0.010252774, 0.01037755, 0.010494451, 0.010614601, 0.010728231, 0.010846762, 0.010966973, 0.01109405, 0.011231126, 0.011355152, 0.011488004, 0.011613384, 0.011745986, 0.011884016, 0.012020287, 0.012145758, 0.012283328, 0.012418749, 0.01256306, 0.012700897, 0.012845506, 0.012984035, 0.013141684, 0.013285889, 0.01344427, 0.013585014, 0.013725883, 0.013869291, 0.014021866, 0.014181313, 0.014340244, 0.014510828, 0.014671465, 0.014839474, 0.014997512, 0.015175273, 0.015345846, 0.015513889, 0.015641653, 0.015678518, 0.015855597, 0.016031518, 0.016213799, 0.016407443, 0.016582196, 0.016765322, 0.016953426, 0.017137043, 0.01731395, 0.01749392, 0.017685243, 0.01787874, 0.018081856, 0.018280393, 0.018493235, 0.018713949, 0.018929016, 0.019140656, 0.019338039, 0.01956398, 0.019766664, 0.019991905, 0.020215741, 0.020454612, 0.02067541, 0.020907709, 0.021125822, 0.021356905, 0.021595969, 0.021835443, 0.022093215, 0.022340206, 0.022585612, 0.022832572, 0.023078704, 0.023338873, 0.023591316, 0.023843808, 0.024109622, 0.024369936, 0.024649521, 0.02491085, 0.025199315, 0.025466027, 0.025759912, 0.026048458, 0.026341376, 0.026630651, 0.026923018, 0.02722684, 0.027532455, 0.02783278, 0.028146233, 0.028465643, 0.028779231, 0.02908904, 0.02940398, 0.029719986, 0.030031263, 0.030362293, 0.030693206, 0.031026584, 0.03136724, 0.031698462, 0.032067576, 0.032403974, 0.032756247, 0.033122079, 0.033474874, 0.033834055, 0.034215996, 0.034578242, 0.034956683, 0.035338467, 0.035705051, 0.036101017, 0.0364912, 0.036878644, 0.037272313, 0.037693437, 0.038105967, 0.03851715, 0.038923487, 0.039357676, 0.039785015, 0.040194802, 0.040631074, 0.041070081, 0.041497311, 0.041949593, 0.042387738, 0.042813993, 0.04328089, 0.043754079, 0.044212617, 0.044684699, 0.045175455, 0.045637771, 0.046158297, 0.04665672, 0.047165448, 0.047677942, 0.048187951, 0.048702154, 0.049212765, 0.049713911, 0.050259192, 0.050781946, 0.051294858, 0.051839854, 0.052364884, 0.052897394, 0.053449892, 0.054031423, 0.054586227, 0.055145805, 0.055716648, 0.056316645, 0.056921364, 0.057508719, 0.058081902, 0.058683707, 0.059290161, 0.059915692, 0.060558943, 0.061184939, 0.061810896, 0.062448509, 0.063094476, 0.063766002, 0.064442841, 0.06509929, 0.0657918, 0.066484331, 0.067162292, 0.067856165, 0.068548698, 0.069245337, 0.069956855, 0.070665378, 0.07139818, 0.072141631, 0.072869167, 0.073605191, 0.074381434, 0.075131682, 0.075885208, 0.076676274, 0.077451857, 0.078253819, 0.079023925, 0.079806628, 0.080609778, 0.081405364, 0.082218387, 0.08303654, 0.083877133, 0.084713607, 0.0855378, 0.086392884, 0.087255587, 0.088123692, 0.089006903, 0.08990238, 0.090804374, 0.091704515, 0.092614331, 0.093531637, 0.094459181, 0.095391986, 0.09634383, 0.097278836, 0.098241824, 0.099215899, 0.100190399, 0.101192284, 0.1021886, 0.103202898, 0.104196978, 0.105215656, 0.106246892, 0.107287354, 0.108302849, 0.109352749, 0.110416977, 0.111491333, 0.112566996, 0.113646424, 0.114736468, 0.115823121, 0.116946575, 0.118085967, 0.119207159, 0.120362494, 0.121529478, 0.122689837, 0.123850499, 0.125048358, 0.126276251, 0.127237547, 0.127477404, 0.128680814, 0.129890074, 0.131109078, 0.132354303, 0.133609219, 0.134863618, 0.136115512, 0.137404671, 0.138710429, 0.139988108, 0.141308462, 0.142598947, 0.143942517, 0.145264566, 0.146613574, 0.147953018, 0.149335655, 0.150722186, 0.152119039, 0.153508075, 0.15491008, 0.156330414, 0.157737093, 0.159187254, 0.160623968, 0.162090828, 0.163590666, 0.165095043, 0.166583755, 0.168083927, 0.169595874, 0.171147704, 0.172709969, 0.174262342, 0.17582164, 0.177414109, 0.178995934, 0.180622988, 0.182245919, 0.183883583, 0.185515529, 0.187184331, 0.188849526, 0.19053127, 0.19222642, 0.193940352, 0.195670465, 0.197419107, 0.199222182, 0.200978809, 0.202705572, 0.204504171, 0.206288955, 0.208080756, 0.209895899, 0.211747632, 0.213612338, 0.215450788, 0.217333474, 0.219218354, 0.221125106, 0.223022843, 0.224952302, 0.226863012, 0.228803645, 0.230814709, 0.23278008, 0.234787476, 0.236815192, 0.238785876, 0.24083577, 0.242875132, 0.244955746, 0.247043083, 0.249165084, 0.251311365, 0.253433753, 0.255579093, 0.25771999, 0.259911819, 0.262098837, 0.264300397, 0.266468691, 0.268695293, 0.270955965, 0.273226798, 0.27550936, 0.277813907, 0.280128908, 0.282482859, 0.284882654, 0.287261381, 0.289647453, 0.292056211, 0.294464514, 0.294985009, 0.29691527, 0.299363838, 0.301848854, 0.30435393, 0.306854384, 0.309393812, 0.311943509, 0.314501687, 0.317068956, 0.319666557, 0.322306256, 0.32496731, 0.327639532, 0.33032713, 0.33305561, 0.335804705, 0.338550408, 0.341330622, 0.344107233, 0.346912017, 0.349741794, 0.352570835, 0.355417051, 0.358303322, 0.361233221, 0.361819519, 0.364169762, 0.367111185, 0.370079483, 0.373082151, 0.376069153, 0.379092477, 0.382167704, 0.385250696, 0.388358276, 0.391482509, 0.394661838, 0.397875245, 0.401071094, 0.404289896, 0.407555887, 0.410832146, 0.414115468, 0.417428228, 0.420773062, 0.424162798, 0.427557863, 0.431010869, 0.434490086, 0.438020159, 0.441532644, 0.445098539, 0.448716627, 0.452314852, 0.455988944, 0.459602873, 0.463285176, 0.46703839, 0.470805093, 0.474601453, 0.478471566, 0.480107955, 0.48234221, 0.486204278, 0.490145679, 0.494109184, 0.498124023, 0.502162162, 0.506251654, 0.510334411, 0.514504378, 0.518676828, 0.522891639, 0.527117133, 0.531457624, 0.535774338, 0.540154209, 0.544576218, 0.549065169, 0.55357389, 0.558106326, 0.56271784, 0.567389922, 0.572100629, 0.576820782, 0.581606038, 0.586453308, 0.588467896, 0.591353361, 0.596308828, 0.601299823, 0.60633738, 0.611487368, 0.616663262, 0.621902903, 0.627195403, 0.632564256, 0.637997182, 0.643481519, 0.64906781, 0.654730473, 0.660443676, 0.666198138, 0.671994449, 0.677931635, 0.683961646, 0.690067991, 0.694981786, 0.706065211, 0.712204024, 0.718296612, 0.724285321, 0.730280787, 0.736182611, 0.742023032, 0.747866583, 0.753746892, 0.759515561, 0.765271058, 0.771000147, 0.776593371, 0.782204011, 0.787850288, 0.793420912, 0.798946527, 0.804475977, 0.807748303, 0.809980096, 0.815459908, 0.820854565, 0.826242793, 0.831650223, 0.837045, 0.84236412, 0.84771046, 0.853048129, 0.858360611, 0.86360293, 0.868807343, 0.874060167, 0.87931219, 0.884505107, 0.889670347, 0.894867557, 0.900015896, 0.905160656, 0.91031162, 0.915423168, 0.92055077, 0.925669078, 0.930830333, 0.935953819, 0.938902166, 0.941062292, 0.946140714, 0.951222822, 0.956358795, 0.96140277, 0.966535885, 0.971626935, 0.976782229, 0.981886052, 0.987004946, 0.992149453, 0.997270559, 1.002434505, 1.007510698, 1.012602291, 1.017771454, 1.022981379, 1.028171627, 1.033384842, 1.03859328, 1.043814733, 1.049004518, 1.054221192, 1.059499524, 1.064819805, 1.070118959, 1.075444076, 1.080800249, 1.086172687, 1.091587453, 1.097076761, 1.102522932, 1.108002798, 1.113603106, 1.119154324, 1.123604597, 1.124758891, 1.130471154, 1.136121409, 1.14192596, 1.147763363, 1.153646682, 1.159510105, 1.16549223, 1.171462212, 1.177553505, 1.1836856, 1.189837273, 1.196025897, 1.202344992, 1.20867178, 1.215108252, 1.221688561, 1.228312782, 1.234964929, 1.2417437, 1.24861593, 1.255572286, 1.262593216, 1.269773796, 1.276951715, 1.282634433, 1.284240673, 1.291666901, 1.29929172, 1.306899652, 1.314689571, 1.322484402, 1.330594626, 1.338670716, 1.346935887, 1.355301179, 1.363856899, 1.372651171, 1.381305266, 1.390212478, 1.399407152, 1.408579892, 1.418098234, 1.427765884, 1.43748996, 1.44729623, 1.457333001, 1.467506121, 1.47772342, 1.488191957, 1.498854693, 1.509577426, 1.520178964, 1.531207464, 1.542109745, 1.55325788, 1.564603887, 1.575976057, 1.587634094, 1.599394969, 1.61135625, 1.623183349, 1.635086157, 1.647373795, 1.659655455, 1.672234049, 1.684616356, 1.697260225, 1.709901044, 1.722692046, 1.735694219, 1.748418531, 1.761636173, 1.774636172, 1.787744977, 1.801187399, 1.814618032, 1.828323284, 1.841946911, 1.855616468, 1.869661223, 1.883706013, 1.897820389, 1.911847391, 1.926314469, 1.940660684, 1.955274629, 1.969858841, 1.98471957, 1.999233088, 2.013945116, 2.028822011, 2.043770247, 2.058811559, 2.07430097, 2.089793637, 2.105125588, 2.120945969, 2.136626563, 2.152305769, 2.168058387, 2.184083751, 2.200269368, 2.216093807, 2.231866961, 2.247997085, 2.264466089, 2.281025074, 2.297987337, 2.314831781, 2.331403502, 2.34852362, 2.365111578, 2.381888967, 2.399056067, 2.416373032, 2.433721275, 2.450940114, 2.46811018, 2.485782382, 2.503186023, 2.521057398, 2.524673517, 2.538288917, 2.555556038, 2.573395133, 2.591828054, 2.609962342, 2.628005009, 2.645725648, 2.664067835, 2.68216003, 2.70072058, 2.719313995, 2.737963386, 2.756510075, 2.7753762, 2.79462828, 2.81361609, 2.832914399, 2.8520055, 2.871109449, 2.890451253, 2.909918388, 2.929364094, 2.948970607, 2.969018161, 2.989366682, 3.009328338, 3.029478665, 3.050116871, 3.07036429, 3.090447669, 3.110311134, 3.130933778, 3.152006948, 3.172929199, 3.193626846, 3.214310165, 3.234981403, 3.255864356, 3.276977478, 3.298323082, 3.319133627, 3.340877054, 3.361852347, 3.38340846, 3.40473727, 3.425753869, 3.446711132, 3.468682444, 3.490317443, 3.511543177, 3.533809209, 3.555748128, 3.578176448, 3.600560012, 3.622876, 3.6453408, 3.6677256, 3.690252118, 3.712934183, 3.735816276, 3.758717115, 3.781520142, 3.804138792, 3.827218798, 3.849521563, 3.873545726, 3.896805064, 3.91942987, 3.943042032, 3.966268116, 3.989628329, 4.012959292, 4.035729249, 4.059595202, 4.082452724, 4.106266915, 4.129211396, 4.153264413, 4.176405381, 4.200006828, 4.223933497, 4.248385261, 4.272488294, 4.296258269, 4.319590537, 4.344223536, 4.368258411, 4.393009323, 4.417473224, 4.441210019, 4.465214529, 4.489722815, 4.51397265, 4.5387963, 4.562720216, 4.588092739, 4.612055772, 4.636285783, 4.66082539, 4.684934321, 4.709854471, 4.734326775, 4.758688128, 4.782575657, 4.807935253, 4.832181589, 4.856526611, 4.881329965, 4.905561835, 4.931743519, 4.956401189, 4.981208122, 5.006458711, 5.032528842, 5.058500808, 5.084928763, 5.111385563, 5.137515767, 5.162222655, 5.188318126, 5.213084091, 5.239645087, 5.266046793, 5.290539915, 5.316250764, 5.342768073, 5.368217715, 5.394190176, 5.419851123, 5.444319855, 5.469348116, 5.494274932, 5.519850335, 5.546205191, 5.571664359, 5.598419592, 5.624706859, 5.651075504, 5.677632607, 5.702901183, 5.727807112, 5.753717997, 5.779969887, 5.806463559, 5.833298168, 5.859627972, 5.886685629, 5.912316162, 5.938069904, 5.963404341, 5.990577388, 6.019705492, 6.047043923, 6.073733224, 6.098985766, 6.125251271, 6.15234576, 6.180336809, 6.206533887, 6.233071958, 6.260348112, 6.286616462, 6.31256301, 6.339235628, 6.367652926, 6.395661781, 6.422475677, 6.448846298, 6.474867242, 6.501826078, 6.528936695, 6.554704658, 6.580416578, 6.607299371, 6.635678507, 6.661365549, 6.686839545, 6.712426827, 6.738845633, 6.766577469, 6.793733778, 6.820943, 6.84717925, 6.87388465, 6.900189331, 6.926937272, 6.953351794, 6.978585571, 7.003119365, 7.028923336, 7.054782567, 7.081237514, 7.107467553, 7.13468381, 7.160855945, 7.18767732, 7.214012693, 7.24195315, 7.269535786, 7.295962871, 7.300437635, 7.321886502, 7.350015578, 7.377033547, 7.405497486, 7.433019252, 7.4589913, 7.484224312, 7.509480975, 7.535177543, 7.563174222, 7.589740204, 7.617272127, 7.641436082, 7.669156399, 7.695433766, 7.722645214, 7.75025712, 7.777826579, 7.803764626, 7.830208436, 7.857264015, 7.88457871, 7.913094416, 7.940003639, 7.967392357, 7.992002797, 8.019264826, 8.045657513, 8.071833114, 8.099880142, 8.126450761, 8.154322493, 8.179606484, 8.205665173, 8.233129794, 8.25945939, 8.286011596, 8.314744113, 8.340107029, 8.368131634, 8.395599891, 8.420679344, 8.447308602, 8.474552598, 8.503726279, 8.531367041, 8.558319543, 8.584233956, 8.611475787, 8.637903116, 8.664611492, 8.693746235, 8.720953586, 8.74855903, 8.772456788, 8.799850054, 8.827245834, 8.851809134, 8.8783896, 8.906608132, 8.932489203, 8.95780733, 8.983422846, 9.010221373, 9.0371145, 9.062998996, 9.090731069, 9.115455796, 9.140009666, 9.170371313, 9.196004519, 9.223438862, 9.248818112, 9.2762774, 9.30201158, 9.328802598, 9.357382862, 9.386877104, 9.412552139, 9.441367623, 9.471048822, 9.496103674, 9.525131654, 9.551257306, 9.578897685, 9.605466702, 9.630588252, 9.657389304, 9.685669283, 9.709879332, 9.736881557, 9.762753787, 9.788893738, 9.811176902, 9.838820336, 9.863660837, 9.887261363, 9.910426424, 9.935534192, 9.959137725, 9.988928301, 10.016689538, 10.046404856, 10.072271938, 10.098067293, 10.121528762, 10.148645822, 10.17463838, 10.202164932, 10.227687762, 10.252137493, 10.282389164, 10.307459581, 10.332604473, 10.361376287, 10.386602614, 10.409449749, 10.436629702, 10.463977187, 10.486895626, 10.512856511, 10.53733616, 10.559770896, 10.58748242, 10.615049283, 10.643387185, 10.66792312, 10.690427691, 10.714161557, 10.742950917, 10.767343569, 10.793840573, 10.820144261, 10.845541662, 10.867635802, 10.896811196, 10.921601791, 10.945795136, 10.968988916, 10.994512412, 11.017172413, 11.04649619, 11.07259058, 11.097565145, 11.124979819, 11.148803042, 11.174386067, 11.195239452, 11.219666001, 11.246408367, 11.272924695, 11.296640611, 11.320186017, 11.343780992, 11.366866179, 11.391055968, 11.416943157, 11.436395771, 11.457787482, 11.479790506, 11.505436132, 11.530921162, 11.554059966, 11.578151329, 11.60197661, 11.626205786, 11.650632776, 11.671926738, 11.699000853, 11.722696435, 11.747525054, 11.772679801, 11.796049636, 11.821827528, 11.847982547, 11.87092289, 11.893673892, 11.920151999, 11.940359165, 11.960495619, 11.984791142, 12.009248554, 12.034422178, 12.058971207, 12.082781797, 12.109605083, 12.134145975, 12.158536996, 12.180825092, 12.200972874, 12.227100925, 12.251323934, 12.276436472, 12.301577153, 12.322950293, 12.340865621, 12.366919573, 12.389719163, 12.414106871, 12.439295725, 12.443480346, 12.46642996, 12.490631842, 12.513669305, 12.535410496, 12.562195927, 12.587624772, 12.615840299, 12.638918433, 12.663558176, 12.687115435, 12.702322491, 12.722594963, 12.746093272, 12.767548646, 12.782877104, 12.802928816, 12.825806447, 12.845439364, 12.864280629, 12.884480543, 12.906659973, 12.92500153, 12.947961269, 12.973611654, 12.995645992, 13.018691178, 13.037676747, 13.054941256, 13.078951902, 13.099849563, 13.12333835, 13.14475832, 13.165475422, 13.189297731, 13.212481258, 13.233914782, 13.256440561, 13.277987935, 13.301333984, 13.331785838, 13.358700909, 13.382190949, 13.410263508, 13.434908815, 13.455217681, 13.476509756, 13.500285761, 13.518528902, 13.537942016, 13.554195237, 13.577337106, 13.598641088, 13.618107421, 13.638417538, 13.656885801, 13.672084372, 13.69840726, 13.728668551, 13.752636739, 13.774413846, 13.796929733, 13.819090162, 13.843651382, 13.864561637, 13.888910065, 13.914113522, 13.939477349, 13.955810111, 13.97030462, 13.984911227, 14.007891115, 14.023164362, 14.040083866, 14.060558448, 14.085774699, 14.109218436, 14.126490707, 14.145069439, 14.169762601, 14.181715868, 14.202540263, 14.217780128, 14.233008567, 14.253154286, 14.274288194, 14.302172335, 14.322892528, 14.342527965, 14.359778149, 14.380172919, 14.404278991, 14.422950341, 14.452868755, 14.470781228, 14.485054958, 14.504710581, 14.520918249, 14.545892945, 14.562123624, 14.583582307, 14.607684329, 14.624342841, 14.636170811, 14.657805307, 14.682201507, 14.707681199, 14.719869646, 14.736790538, 14.756476089, 14.777815555, 14.795499413, 14.81261785, 14.833309583, 14.852999413, 14.865302275, 14.894962315, 14.907404186, 14.925273211, 14.937704806, 14.952857268, 14.977251623, 14.997849832, 15.011729869, 15.031781857, 15.04748503, 15.061780164, 15.080766404, 15.105592656, 15.128226757, 15.145430732, 15.170290215, 15.192388708, 15.211049784, 15.23283873, 15.253217988, 15.266225446, 15.292935716, 15.314404681, 15.327898373, 15.344926989, 15.368638632, 15.387262912, 15.409783905, 15.418422658, 15.436405934, 15.459815976, 15.472947025, 15.485421696, 15.503766142, 15.527219161, 15.547216331, 15.566038949, 15.580929982, 15.600547329, 15.616316447, 15.626722849, 15.645141013, 15.659264075, 15.687032684, 15.719573889, 15.732579768, 15.749656457, 15.767014292, 15.779187017, 15.791819948, 15.803886261, 15.825898152, 15.843584285, 15.863395616, 15.877401778, 15.884423287, 15.901379717, 15.928668094, 15.944886607, 15.954386784, 15.969946535, 15.985863241, 15.998362398, 16.007685919, 16.025729738, 16.04021892, 16.064148284, 16.076368286, 16.091682351, 16.10276669, 16.116088157, 16.136769672, 16.15385302, 16.168704029, 16.184044891, 16.187701525, 16.217644701, 16.245031487, 16.264387034, 16.275463646, 16.307597783, 16.316609953, 16.329023567, 16.341326861, 16.357947133, 16.386639317, 16.407427476, 16.429602368, 16.434842005, 16.452636289, 16.468315762, 16.492599673, 16.509973746, 16.527888245, 16.538108131, 16.556026206, 16.579129335, 16.606937789, 16.640404858, 16.663002711, 16.679432007, 16.695640707, 16.714431652, 16.729942776, 16.746744788, 16.753502778, 16.781157035, 16.79481324, 16.820748003, 16.837823976, 16.850038065, 16.8661048, 16.878623257, 16.892773089, 16.927284421, 16.948865986, 16.972418153, 16.983787425, 16.989474628, 17.00791872, 17.023628424, 17.042585588, 17.055870598, 17.077316386, 17.087380085, 17.093416516, 17.104852613, 17.113116066, 17.120064468, 17.128449322, 17.132675956, 17.142984238, 17.159220707, 17.167290994, 17.17829603, 17.185347539, 17.212428949, 17.221453874, 17.239546898, 17.263520964, 17.281117635, 17.289435432, 17.303228437, 17.317145157, 17.322325686, 17.336825569, 17.342777063, 17.354949937, 17.39984682, 17.41940197, 17.428438947, 17.43161463, 17.437093177, 17.466910894, 17.47501107, 17.47962938, 17.488034758, 17.507413819, 17.528000056, 17.532284604, 17.541609361, 17.551432345, 17.578461966, 17.584806714, 17.586877531, 17.60568531, 17.626931921, 17.638038607, 17.643289652, 17.670931426, 17.68772271, 17.716503294, 17.72229762, 17.727878562, 17.752967124, 17.773472251, 17.788099198, 17.804632293, 17.819809897, 17.824314749, 17.835029965, 17.854614989, 17.869458321, 17.882727328, 17.909990014, 17.915060661, 17.922729578, 17.940601792, 17.956437207, 17.958347692, 17.972383091, 17.984372487, 17.985413022, 17.988150593, 18.008273291, 18.010604515, 18.012889652, 18.017162992, 18.044453239, 18.04800334, 18.049529565, 18.064452202, 18.077567715, 18.083380026, 18.090433925, 18.114071365, 18.118137519, 18.126885661, 18.135695877, 18.173946777, 18.203523664, 18.21307026, 18.224693051, 18.230022404, 18.254181917, 18.269022885, 18.271273493, 18.292291594, 18.307318467, 18.307946899, 18.308364555, 18.31630219, 18.353695546, 18.383430851, 18.391208 ), "20" = c(2.339e-05, 2.3405e-05, 2.3519e-05, 2.384e-05, 2.3923e-05, 2.4142e-05, 2.4246e-05, 2.4257e-05, 2.4343e-05, 2.4416e-05, 2.4642e-05, 2.5679e-05, 2.5717e-05, 2.6083e-05, 2.6536e-05, 2.6728e-05, 2.6734e-05, 2.7574e-05, 2.7686e-05, 2.7964e-05, 2.8245e-05, 2.8432e-05, 2.8796e-05, 2.9036e-05, 2.934e-05, 2.9467e-05, 2.9914e-05, 3.0242e-05, 3.0672e-05, 3.0864e-05, 3.1147e-05, 3.1562e-05, 3.2249e-05, 3.2256e-05, 3.2484e-05, 3.2812e-05, 3.3198e-05, 3.3593e-05, 3.4357e-05, 3.4684e-05, 3.5087e-05, 3.5286e-05, 3.562e-05, 3.5764e-05, 3.6125e-05, 3.6533e-05, 3.6722e-05, 3.6998e-05, 3.722e-05, 3.7624e-05, 3.796e-05, 3.7985e-05, 3.8263e-05, 3.8579e-05, 3.8722e-05, 3.9789e-05, 4.0393e-05, 4.0811e-05, 4.1467e-05, 4.168e-05, 4.2238e-05, 4.3112e-05, 4.4084e-05, 4.4421e-05, 4.674e-05, 4.6869e-05, 4.7272e-05, 4.7542e-05, 4.7891e-05, 4.8685e-05, 4.995e-05, 5.0405e-05, 5.1703e-05, 5.3503e-05, 5.4029e-05, 5.4503e-05, 5.5373e-05, 5.5964e-05, 5.6303e-05, 5.6712e-05, 5.7272e-05, 5.8721e-05, 5.9176e-05, 6.0052e-05, 6.0469e-05, 6.1234e-05, 6.1672e-05, 6.3025e-05, 6.3718e-05, 6.5087e-05, 6.5352e-05, 6.5864e-05, 6.6471e-05, 6.7252e-05, 6.7714e-05, 6.9565e-05, 7.0392e-05, 7.1075e-05, 7.1609e-05, 7.2223e-05, 7.2343e-05, 7.2936e-05, 7.3738e-05, 7.5771e-05, 7.7717e-05, 7.848e-05, 8.0872e-05, 8.1932e-05, 8.347e-05, 8.3823e-05, 8.4615e-05, 8.5282e-05, 8.5652e-05, 8.6725e-05, 8.7278e-05, 8.7969e-05, 8.8379e-05, 8.9748e-05, 9.0097e-05, 9.1165e-05, 9.2829e-05, 9.4325e-05, 9.4941e-05, 9.5342e-05, 9.6262e-05, 9.7621e-05, 9.8888e-05, 9.9649e-05, 0.00010035, 0.000101335, 0.000102846, 0.000105743, 0.000106659, 0.000107226, 0.000108091, 0.000108636, 0.00010999, 0.000112197, 0.000113056, 0.000113808, 0.000114507, 0.000115255, 0.000116178, 0.000119685, 0.00012142, 0.000122493, 0.000123625, 0.000127134, 0.000128936, 0.000130497, 0.00013231, 0.000133497, 0.000134691, 0.000135658, 0.000137656, 0.000138347, 0.000140268, 0.000141504, 0.0001422, 0.000143731, 0.000145464, 0.000147095, 0.000149566, 0.000150626, 0.000152869, 0.000154157, 0.000155797, 0.000158325, 0.000160346, 0.000161569, 0.000162451, 0.00016381, 0.000165406, 0.000166394, 0.000168142, 0.000169909, 0.000172297, 0.000174682, 0.000176502, 0.000178356, 0.000179216, 0.000182802, 0.000185073, 0.000187006, 0.00018884, 0.000190996, 0.000194179, 0.000197068, 0.000199797, 0.000201743, 0.000204286, 0.000206488, 0.000209936, 0.000213365, 0.000215867, 0.000216835, 0.00021893, 0.000222558, 0.000225039, 0.000230972, 0.000233109, 0.00023623, 0.000239072, 0.000241845, 0.000244689, 0.000249244, 0.000251685, 0.00025466, 0.000258671, 0.000262603, 0.000266788, 0.000269628, 0.000273653, 0.000275816, 0.000278981, 0.000283083, 0.000286895, 0.000289482, 0.000292064, 0.000294195, 0.000296073, 0.000299839, 0.000302434, 0.00030596, 0.000308965, 0.000311424, 0.000314635, 0.000317664, 0.000320551, 0.00032294, 0.00032503, 0.00032869, 0.000332484, 0.000336026, 0.000340555, 0.000343925, 0.000348832, 0.00035428, 0.000357499, 0.000361642, 0.000367418, 0.000371612, 0.000377695, 0.000379808, 0.000384336, 0.000389196, 0.000394718, 0.000399181, 0.000403982, 0.00040926, 0.000414611, 0.000420274, 0.000424611, 0.00042969, 0.000433491, 0.000438909, 0.000444681, 0.000450244, 0.000453902, 0.000459696, 0.000463366, 0.000468344, 0.000474665, 0.000480969, 0.000486801, 0.000492886, 0.000499313, 0.00050593, 0.000512346, 0.000517065, 0.000525186, 0.000533393, 0.00053975, 0.000544525, 0.000549103, 0.0005547, 0.000561344, 0.000568144, 0.000575258, 0.000583671, 0.000587485, 0.000595357, 0.000601312, 0.000609046, 0.000614195, 0.00062035, 0.000627281, 0.000634654, 0.000642, 0.00064834, 0.000655551, 0.000662848, 0.000671058, 0.000680239, 0.000687156, 0.00069556, 0.000704877, 0.000712436, 0.000720719, 0.000727619, 0.000738568, 0.000747564, 0.000754166, 0.000761853, 0.00076895, 0.000780226, 0.000788824, 0.000800374, 0.00080936, 0.000817071, 0.000828763, 0.000837876, 0.000847952, 0.000859091, 0.000868771, 0.00087905, 0.000893344, 0.000905242, 0.000915969, 0.000925892, 0.000937254, 0.000944105, 0.000956744, 0.000967528, 0.000976676, 0.000987207, 0.000998741, 0.001011449, 0.001023135, 0.001035721, 0.001049429, 0.001060503, 0.001073242, 0.001085118, 0.001098214, 0.001108014, 0.001118794, 0.0011277, 0.001137371, 0.001149826, 0.001160378, 0.001161687, 0.001177279, 0.001189955, 0.001206121, 0.001222385, 0.001239739, 0.001253606, 0.00126512, 0.001279893, 0.001290073, 0.001305704, 0.00132096, 0.001335764, 0.001354889, 0.001370482, 0.001389627, 0.001403389, 0.001417448, 0.00143318, 0.001448996, 0.001464217, 0.001483137, 0.001496958, 0.001517504, 0.001534109, 0.001552898, 0.001571364, 0.001592578, 0.00161355, 0.00163087, 0.001648756, 0.001666053, 0.001682487, 0.001700536, 0.001719497, 0.001743259, 0.00176063, 0.001781515, 0.001804343, 0.001823211, 0.001840913, 0.001862139, 0.001879966, 0.001902285, 0.001927559, 0.00195009, 0.001971209, 0.001996912, 0.002023295, 0.002047133, 0.002071516, 0.002095616, 0.002123933, 0.00214877, 0.002175045, 0.002200652, 0.002226837, 0.002251468, 0.002273194, 0.002297723, 0.002321414, 0.002346435, 0.002377351, 0.002403049, 0.002426601, 0.002459711, 0.002490665, 0.002517327, 0.002545358, 0.002576057, 0.002603031, 0.002631347, 0.002661549, 0.002687523, 0.002722455, 0.002754744, 0.002786665, 0.002820427, 0.002851708, 0.002888028, 0.002920125, 0.002954685, 0.002986835, 0.003015703, 0.003049906, 0.003083914, 0.003122154, 0.003155291, 0.003192542, 0.003232372, 0.003265475, 0.003302501, 0.003338421, 0.003372545, 0.003415043, 0.003455903, 0.003498752, 0.003536687, 0.003586019, 0.003629313, 0.003669478, 0.003705867, 0.003748221, 0.003798474, 0.00383786, 0.003882106, 0.003925305, 0.00397289, 0.004024825, 0.004068506, 0.00411455, 0.004158467, 0.004211497, 0.004260341, 0.004309571, 0.004361062, 0.004413631, 0.004464356, 0.004516633, 0.004569218, 0.004620783, 0.004674806, 0.004724921, 0.004771783, 0.004819386, 0.004871086, 0.004925231, 0.004978855, 0.005035453, 0.005092426, 0.005149968, 0.005204531, 0.005274921, 0.005336039, 0.005399834, 0.005462169, 0.005527781, 0.005597183, 0.005658147, 0.005722023, 0.00579476, 0.005863545, 0.005934403, 0.006005717, 0.006072159, 0.006146696, 0.006221127, 0.006291758, 0.006365661, 0.00644214, 0.006521469, 0.006590293, 0.006665381, 0.006738967, 0.006817739, 0.00689996, 0.006972098, 0.007061182, 0.007144484, 0.007228005, 0.007303476, 0.007391813, 0.007479179, 0.007566231, 0.007652663, 0.007743889, 0.007831998, 0.007918137, 0.008009358, 0.008105319, 0.008192745, 0.008295796, 0.008392147, 0.008487878, 0.008599599, 0.00869887, 0.008801272, 0.008902367, 0.008999645, 0.009104777, 0.009208316, 0.00931229, 0.009418154, 0.009519975, 0.009633283, 0.009756424, 0.009861943, 0.009981448, 0.010098873, 0.01021596, 0.010329932, 0.010447395, 0.010570613, 0.010690873, 0.010811883, 0.010937048, 0.011055954, 0.011183922, 0.011317567, 0.011455511, 0.011571288, 0.011597712, 0.011735445, 0.011876069, 0.012009835, 0.012141962, 0.012286348, 0.012428562, 0.012570807, 0.012709545, 0.012857001, 0.013010937, 0.013160388, 0.013311762, 0.013461575, 0.013608056, 0.01376278, 0.013932067, 0.014095637, 0.014259644, 0.01443011, 0.014591499, 0.014751073, 0.014921655, 0.015089325, 0.015276327, 0.015451507, 0.015624237, 0.015809245, 0.01597986, 0.01616866, 0.016351404, 0.016548746, 0.016725605, 0.016904281, 0.017097985, 0.017290808, 0.017479317, 0.017669673, 0.017868601, 0.018066945, 0.01827421, 0.018489972, 0.01869718, 0.018919047, 0.019140176, 0.019351876, 0.019579916, 0.019807261, 0.020036362, 0.020269431, 0.020507983, 0.020745022, 0.020979088, 0.021209967, 0.021435342, 0.021689344, 0.021931172, 0.022192878, 0.022450465, 0.022705099, 0.022968175, 0.023229958, 0.023495024, 0.023759014, 0.024034806, 0.0243045, 0.024572776, 0.024848429, 0.025136363, 0.025428427, 0.025715371, 0.025997647, 0.026296504, 0.026581528, 0.026891179, 0.027197713, 0.027511705, 0.027818345, 0.028133322, 0.028445839, 0.028754167, 0.02908739, 0.029429882, 0.029744995, 0.030089201, 0.030432919, 0.030782308, 0.031122072, 0.031474938, 0.031836713, 0.032185056, 0.03254148, 0.032902541, 0.033286195, 0.033676629, 0.034065455, 0.034463716, 0.034855203, 0.035251733, 0.035642134, 0.036031395, 0.036430142, 0.036820879, 0.037235212, 0.037672619, 0.038087655, 0.038505179, 0.038949088, 0.039389628, 0.039825825, 0.040290519, 0.040737909, 0.041194873, 0.041637885, 0.042122393, 0.042597187, 0.043087469, 0.043572289, 0.044065971, 0.044553933, 0.045036921, 0.045543705, 0.0460437, 0.046561362, 0.047080359, 0.047616819, 0.048152184, 0.048681961, 0.049224882, 0.049773421, 0.050320693, 0.050888911, 0.051469173, 0.052038755, 0.052605626, 0.053175679, 0.053744595, 0.054370734, 0.054979419, 0.05558686, 0.056209296, 0.05682207, 0.057462141, 0.058095073, 0.05874974, 0.059411657, 0.060093836, 0.060778485, 0.061442327, 0.062144185, 0.062822774, 0.063519288, 0.064232733, 0.064942462, 0.065664884, 0.066382536, 0.067119083, 0.067870965, 0.068626289, 0.069383765, 0.070158746, 0.070926574, 0.071710956, 0.07251174, 0.073328441, 0.074158325, 0.074989496, 0.075836998, 0.076660762, 0.077484095, 0.078365573, 0.079252605, 0.080128556, 0.081013423, 0.08190712, 0.082823393, 0.083733689, 0.084625296, 0.085546448, 0.086484958, 0.087431266, 0.088371024, 0.089336105, 0.09031658, 0.091307492, 0.09232661, 0.093345124, 0.094368443, 0.095406477, 0.096427818, 0.097477359, 0.098546625, 0.099630265, 0.100706161, 0.10180417, 0.102902782, 0.104038184, 0.105173492, 0.106310264, 0.107452217, 0.108376928, 0.10863057, 0.109811234, 0.111015422, 0.112221133, 0.113430021, 0.114674723, 0.115909673, 0.117154835, 0.11840225, 0.119670833, 0.120935985, 0.122212891, 0.123530741, 0.124856864, 0.126184276, 0.127492343, 0.128832237, 0.130223208, 0.131625824, 0.133006868, 0.13442335, 0.135869698, 0.137340713, 0.138841154, 0.140335503, 0.141831969, 0.143358334, 0.144893702, 0.146419267, 0.147985139, 0.149560238, 0.15114867, 0.15276661, 0.154400409, 0.156043122, 0.157697237, 0.159385678, 0.161087419, 0.162806765, 0.164536979, 0.166279737, 0.168012197, 0.169777006, 0.171584828, 0.173372519, 0.175190418, 0.17702673, 0.178922294, 0.180776327, 0.182682813, 0.184552776, 0.186520582, 0.188461531, 0.190423978, 0.192408085, 0.194412914, 0.19644324, 0.198508694, 0.200561328, 0.20261208, 0.204737194, 0.206841619, 0.208997399, 0.211188408, 0.213357869, 0.215574724, 0.217803841, 0.220080959, 0.222354372, 0.224648362, 0.227019283, 0.22938731, 0.231744104, 0.234097746, 0.236522643, 0.238997896, 0.241483289, 0.244019516, 0.246551936, 0.249084591, 0.251665068, 0.254252195, 0.25684652, 0.259492087, 0.262135716, 0.264808568, 0.267489293, 0.270214725, 0.272999038, 0.275792356, 0.27863504, 0.281482482, 0.284363093, 0.287258414, 0.290203288, 0.29317944, 0.293826844, 0.29616221, 0.299192898, 0.302240066, 0.305281435, 0.308381827, 0.311509736, 0.314657921, 0.317836665, 0.32105776, 0.324306586, 0.327561156, 0.330873453, 0.334190044, 0.337528781, 0.340935399, 0.344359048, 0.347890757, 0.351387219, 0.354944441, 0.358510066, 0.362186203, 0.365851251, 0.369525307, 0.373191773, 0.376988659, 0.377748401, 0.380735374, 0.384561063, 0.388414747, 0.392337689, 0.396315202, 0.400311886, 0.404228721, 0.40833113, 0.412493166, 0.416681273, 0.420882997, 0.425121007, 0.429427971, 0.433759108, 0.438088001, 0.442461013, 0.446884241, 0.451413471, 0.455937187, 0.460535197, 0.465172232, 0.469881828, 0.474645011, 0.479402191, 0.484251849, 0.489189729, 0.494136254, 0.49912714, 0.504144297, 0.509278843, 0.514410423, 0.519602532, 0.524866162, 0.530174704, 0.535528243, 0.537816684, 0.540934514, 0.546425184, 0.551922901, 0.557543067, 0.563271729, 0.569044849, 0.574852965, 0.580722597, 0.586619961, 0.592601611, 0.598679633, 0.604809273, 0.610990893, 0.617234367, 0.623623711, 0.630112693, 0.636656802, 0.64326281, 0.649931071, 0.656627476, 0.663505984, 0.670453392, 0.67743513, 0.68454151, 0.691805353, 0.694798815, 0.699120504, 0.706477717, 0.713961322, 0.721558051, 0.729265449, 0.737043516, 0.744968124, 0.753009616, 0.761115039, 0.769340425, 0.777691134, 0.786228494, 0.794891402, 0.803683698, 0.812598052, 0.821660237, 0.830832196, 0.840210557, 0.849740367, 0.857388683, 0.874716476, 0.884235722, 0.893813601, 0.903287621, 0.912637989, 0.921935423, 0.931240899, 0.940449343, 0.949705872, 0.958889692, 0.968058628, 0.97713591, 0.986170158, 0.995173983, 1.004125292, 1.013068276, 1.021947866, 1.030862678, 1.03604984, 1.039790087, 1.048584894, 1.057391919, 1.066142826, 1.074847014, 1.083612736, 1.092270991, 1.100994856, 1.109737772, 1.118367596, 1.127023417, 1.135589981, 1.144272629, 1.152910687, 1.161473805, 1.170045775, 1.178651469, 1.187284762, 1.195774714, 1.204277009, 1.212825589, 1.221415025, 1.229864603, 1.238301115, 1.246738097, 1.251640141, 1.25527671, 1.263788549, 1.272326851, 1.280882088, 1.289431317, 1.2979597, 1.306578433, 1.315100907, 1.323661512, 1.332295528, 1.340889365, 1.349480031, 1.35806656, 1.366746197, 1.375441231, 1.384043917, 1.39280746, 1.401580923, 1.410335206, 1.419058664, 1.427864042, 1.436757488, 1.445669425, 1.45453694, 1.463450957, 1.472363269, 1.481336842, 1.490312328, 1.499417952, 1.508596269, 1.517805334, 1.52699762, 1.536190454, 1.545407034, 1.554857576, 1.562342881, 1.564252255, 1.573752308, 1.583199353, 1.592720477, 1.602424362, 1.612178836, 1.621968177, 1.631836477, 1.641871125, 1.651933243, 1.662010749, 1.672284249, 1.682634414, 1.693051014, 1.703527587, 1.714040797, 1.724646462, 1.735356464, 1.746223147, 1.757178521, 1.768181571, 1.779196135, 1.790464674, 1.802039274, 1.813701076, 1.822973242, 1.825619447, 1.837392048, 1.849344899, 1.861660605, 1.873745524, 1.886098001, 1.898672651, 1.911288695, 1.924322852, 1.937583825, 1.950852251, 1.964371635, 1.97794849, 1.991581829, 2.00560285, 2.019988902, 2.034397638, 2.04897311, 2.063485939, 2.078437491, 2.093667008, 2.108891816, 2.12444023, 2.140318565, 2.156264405, 2.172323878, 2.188793841, 2.205860861, 2.222711416, 2.239830062, 2.257248748, 2.274628294, 2.292495423, 2.310419448, 2.328598057, 2.346991589, 2.36578668, 2.38486793, 2.404056501, 2.4231701, 2.442625995, 2.462442751, 2.482432278, 2.50275071, 2.522986138, 2.543397005, 2.564021752, 2.585059927, 2.605903202, 2.627053127, 2.648280631, 2.670018483, 2.691818676, 2.713512777, 2.735391631, 2.757648891, 2.779921094, 2.802613231, 2.825626353, 2.848179486, 2.871805204, 2.89479692, 2.918204833, 2.94201004, 2.96586424, 2.989724786, 3.013804075, 3.037907762, 3.062029206, 3.086599924, 3.111724065, 3.136669961, 3.161716291, 3.186907067, 3.212605345, 3.237794427, 3.263759355, 3.289602086, 3.316231133, 3.342794, 3.369178829, 3.395305289, 3.422612993, 3.449983365, 3.477347668, 3.504277516, 3.531994593, 3.560155973, 3.588601519, 3.616883381, 3.645000352, 3.673504631, 3.701783851, 3.730631256, 3.760491666, 3.789469628, 3.795424042, 3.818307975, 3.847981486, 3.877909623, 3.907435929, 3.937826965, 3.967640744, 3.998306133, 4.02919948, 4.060607997, 4.091409204, 4.123320955, 4.153898734, 4.186216501, 4.217594688, 4.249388755, 4.282055915, 4.313644767, 4.346214253, 4.379265777, 4.411342987, 4.44333187, 4.476605079, 4.510131826, 4.54373602, 4.57640653, 4.609826122, 4.644098443, 4.678280048, 4.713180605, 4.74792371, 4.782090518, 4.816040729, 4.851225226, 4.886825977, 4.923146276, 4.957622406, 4.993794145, 5.029810976, 5.06662141, 5.102397214, 5.139041554, 5.176901205, 5.214184041, 5.250617479, 5.28853164, 5.326537716, 5.36373022, 5.401634472, 5.440956866, 5.478873672, 5.517080716, 5.556388903, 5.594919387, 5.633123355, 5.672080949, 5.710414022, 5.749796311, 5.791295074, 5.832352006, 5.872867261, 5.91364419, 5.954763551, 5.996507901, 6.03786911, 6.079425739, 6.121443477, 6.162680164, 6.204111513, 6.247054799, 6.28827861, 6.33084096, 6.37351583, 6.416250808, 6.459463569, 6.502197556, 6.545830325, 6.590496915, 6.633255961, 6.676262843, 6.719698052, 6.764827923, 6.808157607, 6.855661419, 6.899436227, 6.944256875, 6.987901135, 7.033203009, 7.079242389, 7.122810322, 7.167576581, 7.21353527, 7.260160366, 7.306462379, 7.353806179, 7.401272586, 7.449156804, 7.499190972, 7.546011146, 7.592959319, 7.640597528, 7.690651535, 7.737248491, 7.78685522, 7.834339849, 7.883073211, 7.933447607, 7.98325094, 8.031516636, 8.081555105, 8.130155592, 8.180966193, 8.230078823, 8.280139673, 8.332748425, 8.383959936, 8.434930378, 8.486984608, 8.53760183, 8.58799115, 8.639458286, 8.689450855, 8.739971736, 8.793609389, 8.844581607, 8.896138883, 8.948140736, 9.003183891, 9.057967096, 9.111398241, 9.166120076, 9.22018651, 9.27418226, 9.329430211, 9.382493946, 9.439149577, 9.49573727, 9.550743725, 9.606331254, 9.663390452, 9.718246069, 9.776090761, 9.831876873, 9.890579365, 9.945222269, 10.002728222, 10.057169048, 10.11586651, 10.172180325, 10.229874135, 10.289760473, 10.348630989, 10.407589922, 10.467793926, 10.527776161, 10.588986864, 10.647987097, 10.710776377, 10.775031058, 10.835754433, 10.895623744, 10.956059789, 11.015282277, 11.077751909, 11.140167267, 11.207365257, 11.267658924, 11.332493196, 11.391542151, 11.456294093, 11.519084635, 11.581049603, 11.639783087, 11.706117869, 11.767398353, 11.827717528, 11.887731868, 11.950975907, 12.014667432, 12.077083721, 12.141403213, 12.205786774, 12.270109131, 12.33676559, 12.401615137, 12.462450912, 12.524564161, 12.593733005, 12.657392189, 12.722473803, 12.787563703, 12.856800013, 12.922154564, 12.986755941, 13.051111219, 13.120267386, 13.189035996, 13.25472057, 13.323065251, 13.389254145, 13.455927473, 13.471002791, 13.52148907, 13.585255758, 13.652588717, 13.722205925, 13.788030681, 13.855530505, 13.922422613, 13.99554954, 14.062133903, 14.132630878, 14.206508156, 14.273228462, 14.345506667, 14.415980783, 14.488636895, 14.556675596, 14.62509698, 14.697948593, 14.772992934, 14.851940372, 14.921927961, 14.99327583, 15.0610092, 15.137370137, 15.216545286, 15.294928174, 15.366420092, 15.443652691, 15.519493707, 15.591270495, 15.666925518, 15.743038129, 15.815787288, 15.894855141, 15.971473067, 16.047721144, 16.128735327, 16.207910522, 16.286405014, 16.358932323, 16.436692413, 16.514961299, 16.587431397, 16.669240121, 16.738499698, 16.821075838, 16.900505671, 16.97945839, 17.056900521, 17.134348442, 17.216898794, 17.298216568, 17.375861096, 17.443966091, 17.52228353, 17.603146768, 17.681008055, 17.755242393, 17.833688368, 17.925314748, 18.008131174, 18.091921457, 18.185178465, 18.265290717, 18.33581754, 18.41497471, 18.487615993, 18.571171853, 18.653272444, 18.740173574, 18.833230713, 18.91918716, 18.996543874, 19.074665595, 19.163036008, 19.244447756, 19.326197582, 19.408173683, 19.481950313, 19.564460567, 19.658002924, 19.742945106, 19.832784007, 19.907186859, 19.994121041, 20.081694683, 20.167293294, 20.249475139, 20.328855845, 20.410350949, 20.487237442, 20.578656401, 20.665931734, 20.747391218, 20.825484342, 20.919613889, 21.007337383, 21.099204197, 21.195795313, 21.292173681, 21.389240337, 21.478477543, 21.573860303, 21.654448253, 21.742024213, 21.833663461, 21.938444372, 22.035568131, 22.125424619, 22.219256144, 22.300889982, 22.394669637, 22.461271105, 22.556483674, 22.654916987, 22.739718643, 22.834617363, 22.929554319, 23.023448758, 23.112076065, 23.193653067, 23.277642903, 23.372910817, 23.463352544, 23.552974204, 23.650688772, 23.750781452, 23.844679697, 23.934138959, 24.026694627, 24.132209405, 24.229567347, 24.319678695, 24.414371836, 24.504201578, 24.600448178, 24.699767017, 24.785139421, 24.877299094, 24.97042491, 25.070560177, 25.160042818, 25.273716803, 25.363460459, 25.445533792, 25.529326342, 25.628124491, 25.718457103, 25.810918646, 25.914867151, 26.018391197, 26.109077669, 26.209292305, 26.316204992, 26.43347714, 26.537757456, 26.627747223, 26.719957392, 26.824524947, 26.922383026, 27.030461588, 27.13204212, 27.241678778, 27.343616155, 27.457384224, 27.557998354, 27.658225678, 27.765644539, 27.850015718, 27.943389747, 28.056837429, 28.15776089, 28.242031954, 28.330707643, 28.431276204, 28.54031006, 28.646446023, 28.728844086, 28.810809172, 28.912473875, 29.026973914, 29.14943742, 29.239744083, 29.370191334, 29.473377094, 29.586959512, 29.679112999, 29.781706395, 29.90447304, 29.994376328, 30.126170324, 30.261980807, 30.373545934, 30.490150798, 30.58719532, 30.688695565, 30.800436634, 30.912027644, 31.016198804, 31.135852095, 31.15864159, 31.245223469, 31.343737758, 31.457105126, 31.565076562, 31.650272932, 31.73391576, 31.817578733, 31.917155969, 32.019105826, 32.123608831, 32.250400939, 32.360557049, 32.443320653, 32.547909497, 32.675847934, 32.780616103, 32.885735022, 33.001344841, 33.12624878, 33.223178967, 33.315102097, 33.442334165, 33.561476868, 33.694190738, 33.813764846, 33.925246699, 34.02232781, 34.141864365, 34.272526733, 34.376800813, 34.46198071, 34.547925389, 34.626621289, 34.723703916, 34.831913238, 34.96496818, 35.052961046, 35.16095201, 35.274157906, 35.40094168, 35.520629261, 35.642373329, 35.765110445, 35.86589917, 35.976707103, 36.076917958, 36.203829863, 36.350360384, 36.469534429, 36.587213311, 36.714732389, 36.842627291, 36.932219477, 37.047850134, 37.156513669, 37.274493026, 37.386979051, 37.499979877, 37.625176836, 37.736875939, 37.855723154, 37.993927329, 38.097156657, 38.191041973, 38.311091287, 38.430207403, 38.55559921, 38.650157959, 38.771023082, 38.873584718, 38.964402379, 39.05726144, 39.164824911, 39.310484701, 39.387752358, 39.484717593, 39.598244566, 39.74324648, 39.855190813, 39.969745552, 40.054085474, 40.160430516, 40.272295593, 40.376084878, 40.453484337, 40.569611241, 40.709021248, 40.847103888, 40.934904152, 41.031348196, 41.144710494, 41.258961353, 41.36669598, 41.461662051, 41.566329229, 41.65678098, 41.747095099, 41.876450405, 41.984675724, 42.108939254, 42.255511826, 42.355562916, 42.439963275, 42.545454881, 42.621295454, 42.749329503, 42.881820164, 43.0104063, 43.104953486, 43.184360606, 43.354029253, 43.4749484, 43.555393749, 43.666318054, 43.85606742, 44.051682984, 44.158147112, 44.29080016, 44.390965465, 44.556286766, 44.660895651, 44.788904289, 44.883199885, 45.026117579, 45.118583967, 45.259749897, 45.382219634, 45.521079058, 45.672070654, 45.838208999, 45.918770199, 46.041714873, 46.16997643, 46.275198204, 46.374454715, 46.448547857, 46.605590043, 46.750351285, 46.874463037, 46.996140729, 47.073178205, 47.165728878, 47.242088577, 47.301619054, 47.405367383, 47.467486261, 47.561767926, 47.691577344, 47.77367005, 47.871416553, 48.018263676, 48.198653263, 48.431707174, 48.54405848, 48.656490428, 48.758056134, 48.927771077, 49.002687604, 49.100000123, 49.23731429, 49.334258713, 49.565421015, 49.721288162, 49.794455232, 50.071743513, 50.211251045, 50.26765642, 50.399592256, 50.460774767, 50.57887838, 50.693753386, 50.761406703, 50.880252381, 50.959979139, 51.043516412, 51.231881356, 51.313760248, 51.430131009, 51.480152174, 51.557131414, 51.602928158, 51.669320811, 51.7946554, 51.981541947, 52.094358865, 52.225604631, 52.298685824, 52.402248733, 52.483023082, 52.595807902, 52.65046407, 52.76459214, 52.864390749, 53.06495084, 53.215414354, 53.348200245, 53.456550755, 53.660737398, 53.751834414, 53.955516983, 54.075093722, 54.246091425, 54.392003756, 54.553048569, 54.63516793, 54.770461387, 54.86377939, 54.970744406, 55.067825073, 55.126943103, 55.250223992, 55.34308901, 55.524397533, 55.652405424, 55.749573112, 55.951799281, 56.032670328, 56.227230719, 56.271589707, 56.329511434, 56.460676402, 56.551308679, 56.715289656, 56.800982473, 56.878069887, 56.978621317, 57.232207293, 57.271853826, 57.349112858, 57.516311356, 57.576940989, 57.744219975, 57.825553585, 57.976497341, 58.136213218, 58.183616201, 58.341376554, 58.408162613, 58.598549671, 58.682405351, 58.764242023, 58.85858274, 59.187076736, 59.330261934, 59.626221151, 59.895095069, 59.958164774, 60.122878873, 60.349044676, 60.47565427, 60.592016107, 60.778839491, 60.960887373, 61.084134613, 61.136246869, 61.305553797, 61.427402164, 61.523733177, 61.671908305, 61.76857039, 62.066495252, 62.138515119, 62.156065799, 62.229197391, 62.354830881, 62.429470891, 62.560546944, 62.636425633, 62.765326863, 62.803069412, 62.811369954, 62.835718635, 63.266259913, 63.319050644, 63.344072504, 63.413235799, 63.497480383, 63.668026913, 63.884742433, 63.958760583, 64.032977971, 64.207332582, 64.25362591, 64.275129345, 64.312530591, 64.377556522, 64.579393554, 64.589683811, 64.77986858, 64.832392144, 65.001633281, 65.059906486, 65.191877692, 65.287329894, 65.360237705, 65.733058624, 65.76350781, 65.994475666, 66.159244558, 66.26318932, 66.316439295, 66.48579639, 66.677906823, 66.79474387, 66.873170929, 67.130016676, 67.244180298, 67.276847579, 67.367319089, 67.613013371, 67.708809602, 67.786384978, 68.002444095, 68.071334931, 68.182617885, 68.190615455, 68.400271619, 68.486591771, 68.496685543, 68.526993689, 68.688526826, 68.700388882, 68.802851625, 68.95435695, 68.959541049, 69.091487863, 69.166426609, 69.19844385, 69.205142901, 69.483726806, 69.568686928, 69.643046114, 69.726188411, 69.754310044, 69.777047349, 70.211107473, 70.213906104, 70.516982926, 70.533103714, 70.563754305), "35" = c(2.114e-05, 2.1781e-05, 2.2061e-05, 2.2124e-05, 2.2253e-05, 2.2254e-05, 2.2396e-05, 2.3064e-05, 2.3541e-05, 2.3631e-05, 2.3657e-05, 2.373e-05, 2.3929e-05, 2.3956e-05, 2.4362e-05, 2.4477e-05, 2.4584e-05, 2.4892e-05, 2.4969e-05, 2.5495e-05, 2.5824e-05, 2.6079e-05, 2.6333e-05, 2.6435e-05, 2.6977e-05, 2.7048e-05, 2.7415e-05, 2.7496e-05, 2.7716e-05, 2.788e-05, 2.8463e-05, 2.9027e-05, 2.9361e-05, 2.959e-05, 3.0133e-05, 3.0694e-05, 3.0758e-05, 3.1354e-05, 3.2105e-05, 3.2777e-05, 3.3018e-05, 3.316e-05, 3.3847e-05, 3.4293e-05, 3.4605e-05, 3.5464e-05, 3.624e-05, 3.6481e-05, 3.6592e-05, 3.6659e-05, 3.6903e-05, 3.7036e-05, 3.7254e-05, 3.7709e-05, 3.781e-05, 3.7987e-05, 3.8939e-05, 3.9246e-05, 3.9604e-05, 4.0073e-05, 4.0501e-05, 4.0914e-05, 4.1032e-05, 4.1443e-05, 4.1608e-05, 4.1703e-05, 4.2201e-05, 4.2601e-05, 4.2994e-05, 4.3796e-05, 4.4617e-05, 4.4944e-05, 4.5144e-05, 4.5247e-05, 4.557e-05, 4.5754e-05, 4.6546e-05, 4.7257e-05, 4.7723e-05, 4.7909e-05, 4.8177e-05, 4.9148e-05, 5.0361e-05, 5.0544e-05, 5.1285e-05, 5.1495e-05, 5.2461e-05, 5.3174e-05, 5.3646e-05, 5.4307e-05, 5.5185e-05, 5.5533e-05, 5.5974e-05, 5.662e-05, 5.7194e-05, 5.8013e-05, 5.8547e-05, 5.912e-05, 5.9531e-05, 6.0224e-05, 6.0501e-05, 6.1098e-05, 6.1591e-05, 6.2106e-05, 6.2821e-05, 6.3693e-05, 6.4387e-05, 6.5381e-05, 6.5787e-05, 6.659e-05, 6.7917e-05, 6.8511e-05, 6.9024e-05, 6.9476e-05, 7.0682e-05, 7.1087e-05, 7.2354e-05, 7.308e-05, 7.4171e-05, 7.4725e-05, 7.6629e-05, 7.7305e-05, 7.8525e-05, 7.8927e-05, 8.0109e-05, 8.1002e-05, 8.1777e-05, 8.4199e-05, 8.5007e-05, 8.5459e-05, 8.6125e-05, 8.7182e-05, 8.8011e-05, 8.846e-05, 8.9655e-05, 9.0504e-05, 9.1488e-05, 9.2703e-05, 9.4129e-05, 9.4572e-05, 9.7239e-05, 9.8316e-05, 9.9037e-05, 0.000100048, 0.000101252, 0.000103677, 0.000105845, 0.000106832, 0.000109192, 0.000109844, 0.000110775, 0.000112322, 0.000113407, 0.00011415, 0.000116203, 0.000117297, 0.000119293, 0.000120244, 0.000121051, 0.000123352, 0.000124758, 0.000126406, 0.000128835, 0.000130681, 0.000132443, 0.000134748, 0.00013539, 0.000136779, 0.000137584, 0.000138953, 0.000140247, 0.000141336, 0.000142559, 0.000144217, 0.000146139, 0.000148278, 0.000150361, 0.000151848, 0.000154325, 0.000155679, 0.000156969, 0.00016169, 0.000163323, 0.000165206, 0.000167166, 0.000168764, 0.000171389, 0.000172961, 0.000174341, 0.000176685, 0.000178332, 0.000179699, 0.000182047, 0.000183618, 0.00018595, 0.000188893, 0.000190188, 0.000192094, 0.00019401, 0.000196609, 0.000199604, 0.000202132, 0.000205318, 0.000208665, 0.000210535, 0.000212923, 0.000215495, 0.000218003, 0.000219436, 0.00022197, 0.000223606, 0.000227475, 0.000228921, 0.000231646, 0.000234884, 0.00023801, 0.000241212, 0.000243356, 0.000247597, 0.000250032, 0.00025212, 0.00025487, 0.000257546, 0.000260209, 0.000263213, 0.000266572, 0.000269467, 0.000272967, 0.000275812, 0.00027978, 0.000282979, 0.000286577, 0.000289937, 0.000292627, 0.000297065, 0.000299549, 0.000302718, 0.000305201, 0.000310255, 0.000314136, 0.000317372, 0.00032169, 0.00032672, 0.000331448, 0.000334772, 0.0003398, 0.000342713, 0.000346923, 0.000350486, 0.000354466, 0.000359276, 0.000362608, 0.000366473, 0.000369092, 0.000373363, 0.000378225, 0.000380822, 0.000387069, 0.000392695, 0.000397891, 0.00040449, 0.000408574, 0.000411725, 0.00041602, 0.000420534, 0.00042417, 0.000429898, 0.000436294, 0.000441999, 0.000445965, 0.000452686, 0.000459505, 0.000466045, 0.000471354, 0.00047838, 0.000483853, 0.000489381, 0.000493843, 0.000499016, 0.000504524, 0.000511014, 0.0005171, 0.000524768, 0.000530954, 0.000537867, 0.000544043, 0.000550203, 0.000555852, 0.000563872, 0.000571215, 0.000579275, 0.000586291, 0.000592737, 0.000598307, 0.000604883, 0.000612681, 0.000619659, 0.000628705, 0.000635713, 0.000643223, 0.000651932, 0.000658816, 0.000666747, 0.000674472, 0.000680254, 0.00068761, 0.000695816, 0.000703018, 0.000709745, 0.000718531, 0.000728707, 0.000737885, 0.000747474, 0.000754817, 0.000764154, 0.000772726, 0.000783514, 0.000792349, 0.000800689, 0.000810534, 0.000818805, 0.00082905, 0.000836133, 0.000848171, 0.000857757, 0.000868244, 0.000881078, 0.000890269, 0.000899186, 0.000908361, 0.000917075, 0.000928576, 0.000938444, 0.000948362, 0.000959489, 0.00097066, 0.000982957, 0.00099203, 0.001002715, 0.001015314, 0.001024098, 0.001026735, 0.001042215, 0.00105715, 0.0010686, 0.001080544, 0.001094402, 0.001106417, 0.001119403, 0.001130924, 0.001144487, 0.00115638, 0.001172378, 0.001184661, 0.001197408, 0.001210626, 0.001225222, 0.001238577, 0.001252773, 0.001269318, 0.001281179, 0.00129669, 0.001310345, 0.001324101, 0.00133987, 0.001355296, 0.001368161, 0.001384103, 0.001402238, 0.00141546, 0.001430107, 0.001447049, 0.001467068, 0.00148263, 0.001499145, 0.001519187, 0.001538268, 0.001556218, 0.001572607, 0.001588914, 0.001607167, 0.001623399, 0.001638022, 0.001659139, 0.001680786, 0.00170425, 0.001722928, 0.001742661, 0.00176218, 0.001781692, 0.001800731, 0.001820189, 0.001845206, 0.00186924, 0.001894827, 0.001919658, 0.00194163, 0.001966641, 0.001987364, 0.002012574, 0.002037001, 0.002064755, 0.002092246, 0.0021143, 0.002136793, 0.002166385, 0.00219488, 0.002217065, 0.002239843, 0.002261637, 0.002287464, 0.002314566, 0.002340055, 0.002367317, 0.002396911, 0.002428037, 0.002455153, 0.002486752, 0.002515545, 0.002544427, 0.002572581, 0.002607963, 0.00263857, 0.002669137, 0.002700921, 0.00273004, 0.002759116, 0.002790789, 0.002823554, 0.002855719, 0.002889567, 0.002920933, 0.002956517, 0.002986238, 0.003018853, 0.003058631, 0.003090487, 0.003125742, 0.003162849, 0.003198021, 0.00323688, 0.003269633, 0.003307325, 0.003343699, 0.003380198, 0.003416259, 0.0034584, 0.003498564, 0.003544599, 0.003589042, 0.003630074, 0.003670961, 0.003709781, 0.003749282, 0.003794265, 0.003840086, 0.00388479, 0.003932327, 0.003976913, 0.004022136, 0.004074474, 0.004122794, 0.004169066, 0.004221604, 0.004270521, 0.004326132, 0.004377325, 0.004430089, 0.004481328, 0.004530429, 0.004584875, 0.0046405, 0.004690349, 0.004744396, 0.004799938, 0.004863017, 0.004918982, 0.004980464, 0.005032324, 0.005085539, 0.005143982, 0.005200816, 0.005261916, 0.005325935, 0.00538451, 0.005451245, 0.005518099, 0.005582301, 0.005647679, 0.005714775, 0.005777057, 0.005846814, 0.005918197, 0.005987433, 0.006056938, 0.006132189, 0.006199337, 0.006268819, 0.006337558, 0.006409757, 0.006479938, 0.006557962, 0.006638052, 0.006721134, 0.006796081, 0.006880799, 0.006964199, 0.007042618, 0.007126583, 0.007210164, 0.007300198, 0.007384714, 0.00747379, 0.007562205, 0.007647586, 0.00774033, 0.007830959, 0.007924905, 0.008014316, 0.008101219, 0.008194504, 0.008295678, 0.008395303, 0.00848982, 0.008589168, 0.008685489, 0.008778586, 0.008870953, 0.008975537, 0.009074746, 0.009183275, 0.009285707, 0.009394189, 0.009498362, 0.009607109, 0.009709715, 0.009824655, 0.009931608, 0.010045919, 0.010169999, 0.010292323, 0.010388806, 0.010413833, 0.010530703, 0.010650641, 0.010781765, 0.010912008, 0.011035159, 0.011162201, 0.011300925, 0.011429215, 0.011560107, 0.011688707, 0.011824651, 0.01196384, 0.012097182, 0.012246367, 0.01238869, 0.012537509, 0.012686415, 0.012840933, 0.012989611, 0.013140835, 0.0133002, 0.013454433, 0.013605412, 0.013759341, 0.013911729, 0.014063095, 0.014234343, 0.014400527, 0.014565745, 0.014726534, 0.014901144, 0.015075288, 0.015247174, 0.01543053, 0.015619522, 0.01579394, 0.015999384, 0.016187559, 0.016377075, 0.016565359, 0.016756173, 0.016951918, 0.017149043, 0.017349244, 0.01754551, 0.017739392, 0.017945834, 0.018154371, 0.0183603, 0.018572273, 0.018789974, 0.019005376, 0.019223781, 0.01944745, 0.019668082, 0.019897809, 0.020129674, 0.020357341, 0.020588249, 0.020815409, 0.021059415, 0.021307016, 0.021567119, 0.021815827, 0.022064732, 0.022319336, 0.022574063, 0.022825881, 0.02308199, 0.023344745, 0.023620929, 0.023906975, 0.024186046, 0.024459151, 0.024738315, 0.025018738, 0.025308047, 0.025600347, 0.025895505, 0.026194182, 0.026486324, 0.0267933, 0.027092387, 0.027417007, 0.027746206, 0.028059214, 0.02839247, 0.028722516, 0.029069087, 0.029405191, 0.029742434, 0.030073605, 0.030421206, 0.030762155, 0.031117217, 0.031468066, 0.031848664, 0.032210384, 0.03258932, 0.032969728, 0.033342029, 0.033711699, 0.034106108, 0.034505807, 0.034901405, 0.035287375, 0.03569849, 0.036091597, 0.036513184, 0.036929853, 0.037338196, 0.03778477, 0.03821308, 0.03864263, 0.039082521, 0.039542887, 0.040020474, 0.040477383, 0.040919613, 0.04138279, 0.041882714, 0.042351625, 0.042854724, 0.043350223, 0.043824778, 0.044310918, 0.044813869, 0.045350285, 0.045867652, 0.046385242, 0.046921857, 0.047447281, 0.04798214, 0.048538218, 0.049102894, 0.049678017, 0.050248628, 0.050824256, 0.051421315, 0.051993922, 0.052589395, 0.053194381, 0.053823054, 0.054437535, 0.055059517, 0.05567628, 0.056305334, 0.056936258, 0.057572288, 0.058229565, 0.058892945, 0.059556461, 0.060226178, 0.06090877, 0.061589757, 0.062308959, 0.063019989, 0.063738345, 0.064458579, 0.065191332, 0.065947626, 0.066689774, 0.067456172, 0.068220271, 0.069021765, 0.069796576, 0.070580651, 0.071392749, 0.072189252, 0.073016552, 0.07386058, 0.074694941, 0.075527431, 0.076376865, 0.077216452, 0.078100868, 0.078983589, 0.07987384, 0.08075131, 0.081680425, 0.082625606, 0.083568408, 0.084527497, 0.085496962, 0.086463912, 0.087449316, 0.088448917, 0.089465907, 0.090494069, 0.091502136, 0.092534577, 0.093599424, 0.094647955, 0.095766341, 0.096849178, 0.097944506, 0.099028783, 0.100170136, 0.101294736, 0.102201451, 0.102435915, 0.103605236, 0.104786181, 0.105964586, 0.107172469, 0.10839161, 0.109627594, 0.110866906, 0.112114411, 0.113388161, 0.114671249, 0.115971619, 0.117291206, 0.118623001, 0.119957505, 0.121289293, 0.122641322, 0.124061491, 0.125445588, 0.126830621, 0.128239542, 0.129667575, 0.131137468, 0.132619484, 0.134111252, 0.135582601, 0.137117821, 0.138642963, 0.140184452, 0.141776441, 0.143372654, 0.144984607, 0.146586603, 0.148226638, 0.149872426, 0.151554143, 0.153270084, 0.155013612, 0.156737894, 0.158482422, 0.160266537, 0.162060887, 0.163896654, 0.165742032, 0.167602855, 0.169488552, 0.171369521, 0.173275891, 0.175222383, 0.177186811, 0.179136524, 0.181148268, 0.183188715, 0.185210676, 0.187288837, 0.189395399, 0.191490935, 0.193639864, 0.195787246, 0.197959621, 0.200157277, 0.202425781, 0.204664006, 0.206923017, 0.209226614, 0.211569279, 0.213940919, 0.216332457, 0.218781201, 0.221219147, 0.22371581, 0.226194256, 0.228733434, 0.231316541, 0.233898237, 0.236507663, 0.239128454, 0.241793658, 0.244450769, 0.24717139, 0.249951817, 0.252779547, 0.255588122, 0.258427758, 0.261283255, 0.264205226, 0.267111755, 0.270067082, 0.273067169, 0.276135302, 0.279203586, 0.282309698, 0.285436517, 0.288616533, 0.291800778, 0.295043162, 0.295770828, 0.298346171, 0.30160941, 0.304920859, 0.308298726, 0.311699983, 0.315147279, 0.318632824, 0.322170219, 0.325717784, 0.329335287, 0.332982259, 0.33666076, 0.340378574, 0.344191876, 0.348053362, 0.351948503, 0.355833332, 0.359769664, 0.363776396, 0.36782594, 0.371912097, 0.376076539, 0.380245539, 0.38449416, 0.388742747, 0.389637178, 0.393073995, 0.397435358, 0.401874373, 0.406372738, 0.410901252, 0.415421142, 0.42003791, 0.424714686, 0.429450784, 0.434226093, 0.439051137, 0.443876081, 0.448793313, 0.453804835, 0.458846941, 0.463991437, 0.469193828, 0.474452066, 0.479744209, 0.485124383, 0.490573211, 0.496116947, 0.501678815, 0.507328628, 0.513060529, 0.51882964, 0.524656954, 0.53059892, 0.536553843, 0.542613844, 0.548801972, 0.555014507, 0.561340049, 0.567715849, 0.574188549, 0.57691988, 0.58070068, 0.587269454, 0.593951434, 0.60075521, 0.60761429, 0.614557521, 0.621668338, 0.628749378, 0.635992253, 0.643312781, 0.65076945, 0.658321331, 0.666010468, 0.673701852, 0.681592774, 0.689542891, 0.697591688, 0.70574286, 0.714012458, 0.722311617, 0.730872027, 0.739593419, 0.748329786, 0.757174293, 0.766147987, 0.769884316, 0.775235075, 0.784488493, 0.793945775, 0.803539288, 0.813247181, 0.823028037, 0.833056253, 0.843224836, 0.853620284, 0.864166658, 0.874829559, 0.885634043, 0.896641973, 0.907850993, 0.919266319, 0.930906055, 0.942823929, 0.954875911, 0.967203378, 0.977115098, 0.999609808, 1.012039651, 1.024403826, 1.036694585, 1.048943082, 1.061216094, 1.073458622, 1.085572186, 1.097646687, 1.109749821, 1.121685141, 1.133766871, 1.145626288, 1.157554086, 1.169422589, 1.181149193, 1.192886052, 1.20458977, 1.211507853, 1.216406986, 1.228121978, 1.239749851, 1.25147078, 1.263002162, 1.274673892, 1.286155969, 1.297675447, 1.309214334, 1.320690282, 1.332292174, 1.343809167, 1.355303167, 1.366728843, 1.378256972, 1.389918532, 1.401311901, 1.412743399, 1.42424855, 1.435654263, 1.447143137, 1.458596266, 1.470082863, 1.481545128, 1.493130336, 1.499694785, 1.504563801, 1.516058428, 1.527489414, 1.538939458, 1.550364186, 1.561846553, 1.573317223, 1.584781973, 1.596300752, 1.607867648, 1.61938151, 1.630888235, 1.642365283, 1.653925181, 1.665581818, 1.677313869, 1.689144875, 1.701027572, 1.712692508, 1.724456124, 1.736306899, 1.748174268, 1.759994063, 1.771981604, 1.78398656, 1.795997636, 1.808046978, 1.820145556, 1.832381782, 1.844674509, 1.856921374, 1.869183227, 1.881370005, 1.893846713, 1.906329713, 1.91623015, 1.918803967, 1.931234534, 1.943811188, 1.956494067, 1.969307054, 1.982069376, 1.994989708, 2.007943772, 2.021166425, 2.03426174, 2.047339624, 2.060636338, 2.074047526, 2.087443546, 2.100923579, 2.114596569, 2.128363889, 2.142249463, 2.156087403, 2.170175541, 2.184155785, 2.198513095, 2.212862123, 2.227297354, 2.241870437, 2.253333424, 2.256522858, 2.271375438, 2.286177751, 2.301261583, 2.316431474, 2.332105957, 2.347831697, 2.363599473, 2.379491729, 2.395529882, 2.411635039, 2.427960666, 2.444471371, 2.460846859, 2.477744579, 2.494585234, 2.511769865, 2.529237943, 2.54684658, 2.564680661, 2.582743513, 2.601040718, 2.619489059, 2.638173202, 2.657124469, 2.676269769, 2.695857688, 2.715307367, 2.735049731, 2.755163695, 2.775406263, 2.795986533, 2.816978309, 2.838012646, 2.859516478, 2.881358897, 2.90269923, 2.924674344, 2.947023426, 2.9696621, 2.992353788, 3.015162806, 3.038316104, 3.061751263, 3.085431218, 3.109292448, 3.133526883, 3.158014477, 3.183354633, 3.208879291, 3.23427488, 3.259526259, 3.285167743, 3.310554175, 3.336371475, 3.362172707, 3.388259364, 3.415032801, 3.441624981, 3.468493404, 3.496418366, 3.523887001, 3.551535042, 3.579155707, 3.607505048, 3.63615867, 3.664483266, 3.693869359, 3.723464268, 3.752763963, 3.782222225, 3.811872886, 3.841755023, 3.871631556, 3.902531008, 3.93293298, 3.963820976, 3.994686517, 4.025028621, 4.056731235, 4.08830789, 4.120303166, 4.151603653, 4.183148673, 4.2164921, 4.249455461, 4.282576856, 4.315177562, 4.348486875, 4.381681449, 4.415565832, 4.44877879, 4.482277467, 4.516759267, 4.550836157, 4.58563332, 4.592892531, 4.621420116, 4.656644565, 4.6918497, 4.727128816, 4.7634627, 4.799013439, 4.835033238, 4.871937258, 4.909051146, 4.947076645, 4.984353452, 5.02144922, 5.057896781, 5.095713527, 5.13281899, 5.170451523, 5.208951945, 5.24737281, 5.286267986, 5.324948674, 5.363574003, 5.403214857, 5.442084317, 5.482336028, 5.522495303, 5.562015177, 5.602776341, 5.643484615, 5.684144058, 5.726150441, 5.766912714, 5.809501037, 5.851045158, 5.893389255, 5.93635367, 5.977959163, 6.01989649, 6.063385706, 6.106935401, 6.150597741, 6.194174571, 6.23724292, 6.281656316, 6.326385208, 6.371384918, 6.415990432, 6.460869951, 6.505660789, 6.552941158, 6.597283365, 6.64238047, 6.688261346, 6.733824206, 6.780247586, 6.827751163, 6.875486892, 6.923819731, 6.97131241, 7.018546806, 7.066832588, 7.115316115, 7.164538463, 7.21279219, 7.264309006, 7.312839863, 7.361888298, 7.410750201, 7.46086377, 7.510664755, 7.561342546, 7.611361639, 7.660895797, 7.714019, 7.765816912, 7.817895741, 7.871225833, 7.923009526, 7.973523995, 8.025588785, 8.078273846, 8.130794229, 8.185596393, 8.23850096, 8.29130525, 8.347312552, 8.402102419, 8.457684498, 8.51075941, 8.565554345, 8.620357613, 8.675836533, 8.729986242, 8.78776728, 8.845142144, 8.902310542, 8.95889559, 9.017066156, 9.075905709, 9.131688291, 9.189967806, 9.247236756, 9.306131, 9.365735614, 9.425424212, 9.483899755, 9.543131042, 9.604669045, 9.665011344, 9.728275216, 9.788248186, 9.851663614, 9.910613499, 9.974132826, 10.035054177, 10.095004273, 10.158889074, 10.221147332, 10.285124, 10.349098897, 10.413227282, 10.476081023, 10.538970341, 10.602741336, 10.667449284, 10.734404374, 10.799259277, 10.86301981, 10.927647935, 10.993588124, 11.057225515, 11.124715062, 11.191689073, 11.26098097, 11.324918451, 11.393212239, 11.461839806, 11.530830011, 11.601563118, 11.668518153, 11.736312714, 11.807225052, 11.880901942, 11.949198379, 12.018517287, 12.090381584, 12.163291383, 12.23505575, 12.307118596, 12.381934637, 12.454435689, 12.524426337, 12.600569891, 12.674895479, 12.743521571, 12.813845949, 12.888316352, 12.964230893, 13.03347883, 13.107036892, 13.187626092, 13.260256338, 13.332844039, 13.406640571, 13.476018077, 13.551053477, 13.622745321, 13.699508423, 13.77274896, 13.848711509, 13.925576148, 14.005810452, 14.087932427, 14.163720053, 14.243410271, 14.322280275, 14.403901828, 14.487747788, 14.56676353, 14.647404998, 14.727869604, 14.818363654, 14.893415269, 14.975566129, 15.062592709, 15.142090413, 15.219445612, 15.298015019, 15.382567546, 15.464608993, 15.548582081, 15.635461942, 15.719251191, 15.803118781, 15.886267097, 15.978657133, 16.062453529, 16.144447682, 16.231236306, 16.312710065, 16.399252552, 16.413501272, 16.483035947, 16.575869078, 16.664124166, 16.754097643, 16.836204372, 16.927541256, 17.014808071, 17.106280388, 17.199313321, 17.285515507, 17.378266516, 17.468882853, 17.551926223, 17.643018055, 17.736101648, 17.8230864, 17.915431292, 18.008851953, 18.102768585, 18.192581257, 18.283087548, 18.382144354, 18.482893651, 18.588062705, 18.676547863, 18.7692377, 18.861120643, 18.957028427, 19.05840003, 19.164866294, 19.259437744, 19.351547773, 19.452706606, 19.543588542, 19.635623661, 19.733646369, 19.831238732, 19.925565945, 20.025403155, 20.118379514, 20.231543915, 20.328554614, 20.4278698, 20.524722507, 20.631924142, 20.733713687, 20.839927599, 20.947920035, 21.047295932, 21.151336977, 21.256740563, 21.365350808, 21.471483694, 21.575990144, 21.676284162, 21.783417293, 21.888286046, 21.99141798, 22.101359501, 22.208002503, 22.30929655, 22.422468215, 22.533823557, 22.647732331, 22.753648353, 22.85937594, 22.976106163, 23.072689346, 23.183598536, 23.279815971, 23.399501994, 23.509132484, 23.624709446, 23.737300371, 23.847272608, 23.961187607, 24.07743337, 24.190202345, 24.295303087, 24.408207231, 24.531496297, 24.647632382, 24.754070464, 24.870591427, 24.988383793, 25.101488686, 25.226170278, 25.344008914, 25.459458113, 25.565253755, 25.68121513, 25.809694448, 25.925922618, 26.059389168, 26.179509725, 26.286036885, 26.408198868, 26.534222468, 26.65673517, 26.78735186, 26.901265595, 27.03158618, 27.147857168, 27.261466946, 27.386508004, 27.507964938, 27.64335501, 27.766992496, 27.902944466, 28.019479694, 28.14586437, 28.280914824, 28.428013173, 28.550314489, 28.672427852, 28.808751552, 28.9592421, 29.093536311, 29.232739514, 29.334001505, 29.438523387, 29.567052035, 29.696050784, 29.840064713, 29.959667047, 30.112407956, 30.234583016, 30.36688697, 30.496516865, 30.623709211, 30.760430816, 30.874628206, 31.000163533, 31.139607951, 31.270829384, 31.405007068, 31.538074717, 31.670557691, 31.817389963, 31.968535989, 32.090092778, 32.222699584, 32.344565665, 32.467530606, 32.592130553, 32.727235312, 32.87932986, 33.001227412, 33.121900542, 33.274321226, 33.427908494, 33.543618315, 33.711085065, 33.855627568, 34.003211017, 34.164531305, 34.298318558, 34.438103361, 34.572447801, 34.720269922, 34.845036493, 34.994077264, 35.124154642, 35.287456868, 35.43597724, 35.598699642, 35.733645441, 35.883176223, 36.022957403, 36.167038583, 36.32208633, 36.488862233, 36.621749394, 36.776826541, 36.91653389, 37.057412825, 37.190317023, 37.319691751, 37.48362917, 37.618316074, 37.767584788, 37.928931894, 38.087329435, 38.251850768, 38.383779627, 38.519981763, 38.677674483, 38.821077154, 38.981929413, 39.152418785, 39.282349345, 39.454953206, 39.61493747, 39.754668596, 39.905517483, 40.048624329, 40.237858936, 40.403061351, 40.538046906, 40.722148354, 40.758463253, 40.884434126, 41.049132774, 41.219878264, 41.369198439, 41.507893355, 41.621818584, 41.783468881, 42.03460508, 42.195686153, 42.370342181, 42.518737339, 42.673582474, 42.902560698, 43.05949202, 43.193554189, 43.334353299, 43.517446064, 43.674869913, 43.814693155, 43.963797335, 44.132804445, 44.316804397, 44.477155468, 44.624599692, 44.791811073, 45.02124427, 45.178033422, 45.354535662, 45.539477133, 45.691955679, 45.895718254, 46.141368626, 46.302015722, 46.554979759, 46.738588609, 46.946452287, 47.113792886, 47.336403502, 47.501275637, 47.687546883, 47.892968505, 48.073711263, 48.259474864, 48.407617636, 48.568541189, 48.739627066, 48.919517497, 49.081461467, 49.217685717, 49.366185738, 49.572613135, 49.683612787, 49.834219095, 50.027081608, 50.204646082, 50.356046579, 50.557335771, 50.722151671, 50.970424544, 51.113103599, 51.331212753, 51.530208383, 51.705969659, 51.907744935, 52.098288421, 52.252827367, 52.445626341, 52.583286756, 52.702365326, 52.912402058, 53.081944961, 53.239256605, 53.396801286, 53.538609961, 53.725399909, 53.921845694, 54.122870748, 54.323661354, 54.531082041, 54.699552469, 54.947013956, 55.084530284, 55.272027031, 55.454877649, 55.620436979, 55.788766333, 55.995771602, 56.243776091, 56.462479108, 56.620773679, 56.785031272, 56.963576247, 57.149987224, 57.337833963, 57.50069253, 57.718188421, 57.897928702, 58.057970071, 58.293433633, 58.451139348, 58.669495931, 58.899025142, 59.042285507, 59.308110663, 59.545467535, 59.76636179, 59.970244643, 60.135709801, 60.271492305, 60.373365124, 60.58004772, 60.673447919, 60.896819644, 61.09509106, 61.302647877, 61.522925201, 61.693637153, 61.838876798, 62.06631538, 62.327016881, 62.499531319, 62.765252764, 62.900072692, 63.151103308, 63.343467006, 63.57036453, 63.860918671, 64.059648499, 64.253660522, 64.424883177, 64.666060618, 64.85554302, 65.0759968, 65.237490821, 65.44880355, 65.727460839, 65.894045276, 66.2084666, 66.474368574, 66.612287245, 66.854544293, 67.201520869, 67.427661123, 67.719680643, 67.921051436, 68.05234241, 68.237209321, 68.440631892, 68.711960887, 68.998996926, 69.420312747, 69.603426771, 69.794726112, 69.984334753, 70.22079556, 70.511271268, 70.617501681, 70.829861255, 71.03793747, 71.330014274, 71.482871876, 71.771735888, 71.916304023, 72.100197937, 72.34543968, 72.669943509, 72.833424533, 72.989328595, 73.171798214, 73.298525537, 73.436309865, 73.628016162, 73.877612387, 74.125927483, 74.283158243, 74.490681363, 74.75484971, 74.96373709, 75.319757437, 75.549868583, 75.677713211, 75.994843096, 76.156016037, 76.325611314, 76.659659325, 77.125292936, 77.299410302, 77.463056986, 77.592193548, 77.687519319, 77.785299441, 78.10468257, 78.309069539, 78.524639382, 78.794035207, 79.329247745, 79.647747949, 79.845542764, 80.140748485, 80.581739533, 80.898815101, 81.029824382, 81.331419238, 81.66189363, 81.844629267, 81.947865916, 82.282298831, 82.561106782, 82.835838199, 83.142854781, 83.350851894, 83.550934944, 83.806523069, 84.105202916, 84.437392898, 84.753197363, 85.12393925, 85.505531289, 85.685504682, 85.827567117, 85.879312927, 86.03277549, 86.174867573, 86.439059881, 86.59603768, 86.727455724, 87.188460801, 87.34944352, 87.503378305, 87.729001426, 87.926915899, 88.120173508, 88.36081338, 88.492157034, 88.65695608, 88.904368121, 89.08596032, 89.721590564, 89.996736033, 90.328041057, 90.504965884, 91.138974238, 91.390894653, 91.47017051, 91.612203566, 91.820408397, 92.066156446, 92.30576694, 92.517541093, 92.931681782, 93.184331431, 93.711322962, 94.03784139, 94.463193925, 94.9917164, 95.331687151, 95.388681778, 95.928735894, 95.990193627, 96.109304147, 96.753267192, 97.313734954, 97.506216742, 97.574715398, 97.694071569, 97.803842382, 97.943317876, 98.225379166, 98.415154052, 98.754755371, 98.889004089, 99.002218328, 99.241698479, 99.891010717, 100.309574995, 100.548846667, 100.60652688, 101.150603587, 101.309138641, 101.583135673, 102.034253024, 102.097979777, 102.246124336, 102.706379872, 103.219187876, 103.381794909, 103.732579264, 103.783725825, 104.933808555, 105.175550165, 105.250163169, 105.314491587, 105.37388747, 105.525008307, 105.628448336, 106.270050375, 106.394631647, 107.046283556, 107.638429388, 107.688922297, 107.733365474, 108.043445993, 108.721176327, 109.175799077, 109.218075437, 109.287442326, 109.420857653, 109.458811399, 109.959045411, 110.242607557, 110.539336252, 111.211375888, 111.620316462, 111.647446758, 111.853893602, 111.973790431, 112.212419505, 112.333996466, 112.442586253, 112.579127315, 112.965819913, 113.204043651, 113.390937027, 113.906347108, 113.934448013, 114.112537592, 114.582560379, 114.763713923, 114.89142731, 115.047249186, 115.839358312, 116.186530239, 116.954924575, 117.173546524, 117.468616154, 117.744636156, 117.873659844, 117.922609293, 118.456775516, 118.474326013 ), "50" = c(2.3459e-05, 2.3488e-05, 2.3543e-05, 2.3764e-05, 2.3835e-05, 2.4066e-05, 2.4481e-05, 2.4767e-05, 2.5362e-05, 2.5394e-05, 2.5779e-05, 2.5963e-05, 2.6609e-05, 2.663e-05, 2.6708e-05, 2.6723e-05, 2.7115e-05, 2.751e-05, 2.8003e-05, 2.8053e-05, 2.812e-05, 2.8726e-05, 2.943e-05, 2.9601e-05, 2.9714e-05, 3.0511e-05, 3.0762e-05, 3.0778e-05, 3.0918e-05, 3.1132e-05, 3.1289e-05, 3.1764e-05, 3.2169e-05, 3.2333e-05, 3.2386e-05, 3.2493e-05, 3.2602e-05, 3.3069e-05, 3.3464e-05, 3.364e-05, 3.368e-05, 3.5003e-05, 3.5084e-05, 3.5423e-05, 3.6148e-05, 3.6602e-05, 3.676e-05, 3.7084e-05, 3.7567e-05, 3.9385e-05, 3.998e-05, 4.0446e-05, 4.0834e-05, 4.1636e-05, 4.2452e-05, 4.2682e-05, 4.3414e-05, 4.354e-05, 4.4152e-05, 4.4446e-05, 4.5069e-05, 4.5554e-05, 4.6351e-05, 4.6782e-05, 4.7255e-05, 4.8483e-05, 4.9277e-05, 4.9626e-05, 5.0393e-05, 5.0476e-05, 5.2121e-05, 5.2327e-05, 5.2631e-05, 5.3224e-05, 5.3272e-05, 5.3413e-05, 5.3976e-05, 5.4587e-05, 5.4871e-05, 5.5184e-05, 5.5754e-05, 5.6072e-05, 5.6285e-05, 5.7067e-05, 5.771e-05, 5.81e-05, 5.8739e-05, 5.9344e-05, 5.9685e-05, 5.9849e-05, 6.0782e-05, 6.136e-05, 6.1663e-05, 6.2335e-05, 6.2969e-05, 6.3937e-05, 6.4305e-05, 6.4762e-05, 6.5219e-05, 6.6729e-05, 6.7616e-05, 6.8914e-05, 6.9645e-05, 7.0327e-05, 7.0818e-05, 7.1639e-05, 7.2286e-05, 7.2754e-05, 7.333e-05, 7.4221e-05, 7.5533e-05, 7.686e-05, 7.7258e-05, 7.8116e-05, 7.8712e-05, 8.0337e-05, 8.0876e-05, 8.2162e-05, 8.2721e-05, 8.4618e-05, 8.4934e-05, 8.6727e-05, 8.7301e-05, 8.8069e-05, 8.9688e-05, 9.0613e-05, 9.1747e-05, 9.1991e-05, 9.283e-05, 9.3566e-05, 9.4011e-05, 9.5007e-05, 9.5754e-05, 9.6411e-05, 9.7037e-05, 9.872e-05, 0.000100588, 0.000102067, 0.000103002, 0.000103641, 0.000105375, 0.000106434, 0.000107652, 0.000110131, 0.000111512, 0.00011282, 0.000114182, 0.000115682, 0.000117045, 0.000117525, 0.000119305, 0.00012151, 0.000123645, 0.000124468, 0.000125206, 0.000126865, 0.000127895, 0.000128929, 0.000129616, 0.000131752, 0.000132798, 0.000133781, 0.000134839, 0.00013555, 0.000136587, 0.000137401, 0.000139155, 0.000141744, 0.000143216, 0.00014464, 0.000146355, 0.000147355, 0.000149285, 0.000150582, 0.000152599, 0.000153816, 0.000156117, 0.000157381, 0.000159278, 0.000162696, 0.000164433, 0.000165957, 0.00016874, 0.000170044, 0.000171683, 0.000173206, 0.000174891, 0.000178189, 0.000180469, 0.000182319, 0.000184166, 0.000185747, 0.00018812, 0.000189685, 0.000190699, 0.00019272, 0.000194591, 0.000196283, 0.000197791, 0.000200227, 0.000203458, 0.000206593, 0.000208516, 0.000211517, 0.000213873, 0.000216, 0.000220051, 0.000223917, 0.000226542, 0.00022942, 0.000234391, 0.000236134, 0.000238589, 0.000241011, 0.000242862, 0.000245164, 0.00024808, 0.00024998, 0.000252412, 0.000255631, 0.000257388, 0.000260221, 0.000262028, 0.000266213, 0.000268744, 0.000271955, 0.00027563, 0.000280144, 0.000282983, 0.00028449, 0.000287544, 0.000289502, 0.000294186, 0.000297042, 0.000299524, 0.0003029, 0.000306844, 0.000310461, 0.000314096, 0.000318257, 0.000322668, 0.000325278, 0.000327949, 0.000333193, 0.000335889, 0.000338897, 0.000342498, 0.000346947, 0.000351049, 0.000354633, 0.000359194, 0.000363175, 0.000367213, 0.000370694, 0.000375642, 0.000379881, 0.000384462, 0.000388529, 0.000394007, 0.000400529, 0.000405468, 0.000409403, 0.000414619, 0.000419494, 0.000422867, 0.000426866, 0.000431767, 0.000438888, 0.000442404, 0.000448617, 0.000453769, 0.000458339, 0.000462901, 0.000467147, 0.000474117, 0.000480834, 0.000487061, 0.000493104, 0.000498892, 0.000504579, 0.000508368, 0.000513132, 0.000520771, 0.00052589, 0.000531365, 0.000537328, 0.00054367, 0.000549957, 0.000554768, 0.000560357, 0.000566714, 0.000573017, 0.000576219, 0.000582422, 0.000591227, 0.000597267, 0.000606522, 0.000613536, 0.000620582, 0.000627816, 0.000634202, 0.00064191, 0.000649705, 0.000657993, 0.000665917, 0.00067556, 0.000681603, 0.000689062, 0.000696327, 0.000705395, 0.000712455, 0.000720583, 0.000731773, 0.000742481, 0.000753397, 0.000762779, 0.000774347, 0.000782097, 0.000788858, 0.000797841, 0.000806481, 0.000816836, 0.0008269, 0.000836126, 0.000846185, 0.000855992, 0.000866413, 0.000879189, 0.000890103, 0.000901946, 0.000910867, 0.000920016, 0.000929485, 0.000939344, 0.000950821, 0.000960742, 0.000969527, 0.000982373, 0.000995269, 0.001005952, 0.001013887, 0.00101764, 0.001031092, 0.001040227, 0.00105162, 0.001064265, 0.001075428, 0.00108765, 0.001102759, 0.001116054, 0.001126517, 0.001138989, 0.001154559, 0.001166312, 0.001182988, 0.001196336, 0.001209402, 0.001224765, 0.001238648, 0.001253211, 0.001267471, 0.001284077, 0.001300143, 0.001314828, 0.001331831, 0.001345023, 0.001359421, 0.00137541, 0.001391503, 0.001406173, 0.001422953, 0.001441677, 0.00145754, 0.001474604, 0.001490846, 0.001507149, 0.001524485, 0.001542421, 0.001561338, 0.001580136, 0.001596139, 0.001616435, 0.001633711, 0.001649927, 0.001666848, 0.00168734, 0.001706352, 0.00172684, 0.001745034, 0.001766447, 0.001787037, 0.001809534, 0.00183022, 0.00185187, 0.001874942, 0.001898782, 0.001919188, 0.00194302, 0.001965965, 0.001988155, 0.002008566, 0.002032904, 0.002053405, 0.002075796, 0.002101991, 0.002125058, 0.002147175, 0.002171125, 0.00219641, 0.002221926, 0.002247062, 0.002273785, 0.002302411, 0.002326196, 0.002351904, 0.002377832, 0.002406768, 0.002434797, 0.0024657, 0.002490857, 0.002519815, 0.002549419, 0.00257953, 0.002605721, 0.002633587, 0.00266221, 0.002689225, 0.002720565, 0.002754622, 0.002787795, 0.002818381, 0.002848583, 0.002881608, 0.002911603, 0.002943803, 0.002979864, 0.003013806, 0.003050346, 0.003085379, 0.003125404, 0.003156186, 0.003190661, 0.003223689, 0.003260933, 0.00329907, 0.003335294, 0.003372812, 0.003410377, 0.003447642, 0.003492924, 0.003536004, 0.003575697, 0.003620743, 0.003661108, 0.003701194, 0.003744165, 0.003786043, 0.003834304, 0.003876419, 0.003920351, 0.00396747, 0.00401226, 0.004060206, 0.004113954, 0.004168055, 0.004224192, 0.004277171, 0.004327769, 0.004376568, 0.004431651, 0.004479433, 0.004528825, 0.004583121, 0.004638677, 0.004690625, 0.004745775, 0.004800068, 0.004853048, 0.004912544, 0.004972842, 0.005026589, 0.005087044, 0.00514489, 0.005201285, 0.005258378, 0.005318877, 0.005382026, 0.005446991, 0.00551486, 0.005579086, 0.005641289, 0.005704254, 0.005774559, 0.005841232, 0.005912509, 0.00598763, 0.006053938, 0.006127602, 0.006202264, 0.006274129, 0.006344935, 0.006416923, 0.006495519, 0.006573688, 0.006648673, 0.006726146, 0.006807484, 0.006889941, 0.006967968, 0.007053212, 0.007135032, 0.007214538, 0.007303296, 0.007393899, 0.00747263, 0.007564349, 0.00765343, 0.007742087, 0.00783679, 0.007929342, 0.008022082, 0.008113583, 0.008215439, 0.008311359, 0.008410769, 0.008498085, 0.008588998, 0.008683844, 0.008786649, 0.00889275, 0.008987108, 0.00908454, 0.009180864, 0.009283315, 0.009396685, 0.00950194, 0.009611882, 0.009718261, 0.009834575, 0.009947845, 0.010064478, 0.010147393, 0.010171691, 0.010282565, 0.010394092, 0.010520564, 0.010646405, 0.010781068, 0.010908089, 0.011039389, 0.01117263, 0.011300701, 0.011443232, 0.011575723, 0.011701079, 0.011844982, 0.011984937, 0.012121946, 0.012267657, 0.012403403, 0.012548657, 0.012686032, 0.012834127, 0.012984192, 0.013135206, 0.013295089, 0.013453288, 0.013617049, 0.013771672, 0.013940871, 0.014090098, 0.014248777, 0.014415984, 0.014588807, 0.014757527, 0.014929293, 0.015105113, 0.015266442, 0.015440256, 0.015623385, 0.015808408, 0.015986042, 0.016169234, 0.016355021, 0.016546281, 0.016749596, 0.016939634, 0.017136453, 0.017332197, 0.017532255, 0.017719473, 0.01792359, 0.018120603, 0.01832482, 0.018538684, 0.018751458, 0.018974785, 0.019187349, 0.019407798, 0.019633469, 0.019869359, 0.020113225, 0.020342813, 0.020577374, 0.020818854, 0.021062674, 0.021309748, 0.021545894, 0.021787301, 0.02204259, 0.02229376, 0.022546329, 0.022810781, 0.023080218, 0.023336901, 0.023591619, 0.023877514, 0.02415078, 0.024435157, 0.02471709, 0.024997259, 0.025288061, 0.025576392, 0.025877362, 0.026162872, 0.026461011, 0.026769455, 0.027084737, 0.027393332, 0.027716192, 0.028025638, 0.028357765, 0.028683832, 0.029000594, 0.029334149, 0.029683788, 0.03003251, 0.030377505, 0.030721051, 0.031074617, 0.031419746, 0.031779013, 0.032149502, 0.032524962, 0.032895516, 0.033273137, 0.033665741, 0.034057633, 0.034439189, 0.034839301, 0.035229709, 0.035628259, 0.036025166, 0.03643291, 0.036840412, 0.037273194, 0.037687878, 0.038123051, 0.038584123, 0.039052778, 0.03949937, 0.039958963, 0.040412717, 0.040873459, 0.041338166, 0.041804122, 0.042281879, 0.042773719, 0.043267578, 0.043744457, 0.044242752, 0.044747407, 0.045281398, 0.045801368, 0.046310924, 0.046841218, 0.047387197, 0.047908436, 0.048468812, 0.049027799, 0.049577727, 0.050161472, 0.050728923, 0.051325128, 0.051920599, 0.052521316, 0.053114475, 0.053725993, 0.05434356, 0.054975799, 0.055622047, 0.056253651, 0.056913406, 0.057557087, 0.058220008, 0.058869274, 0.059531913, 0.060213622, 0.060913729, 0.061621254, 0.062342302, 0.063060591, 0.063789375, 0.064535323, 0.065258775, 0.066005175, 0.06676532, 0.067555614, 0.068351923, 0.06913658, 0.069926005, 0.070739206, 0.071554511, 0.072386235, 0.073207892, 0.074060271, 0.074907779, 0.075799857, 0.076653035, 0.077556075, 0.078455805, 0.079325089, 0.080226062, 0.081168184, 0.082079381, 0.083016742, 0.083965597, 0.084917429, 0.085871107, 0.086856105, 0.087864629, 0.08887092, 0.089870014, 0.090903023, 0.091942231, 0.093009541, 0.09408125, 0.095167955, 0.096261484, 0.097357539, 0.098466287, 0.099592672, 0.100490094, 0.100735279, 0.101898587, 0.103044783, 0.10422858, 0.105403942, 0.106641946, 0.107871006, 0.109108507, 0.110353368, 0.111614654, 0.11291433, 0.114217922, 0.115499196, 0.11679871, 0.118131187, 0.119503103, 0.120878347, 0.122282803, 0.123676609, 0.125077333, 0.126533967, 0.127937296, 0.129384364, 0.130864238, 0.132363833, 0.133890674, 0.135426968, 0.136963836, 0.138520687, 0.14010285, 0.141722503, 0.143332127, 0.144995039, 0.146655274, 0.148333918, 0.150033304, 0.151776839, 0.153498858, 0.155257507, 0.157028399, 0.158824125, 0.160620236, 0.162490146, 0.164373605, 0.166272364, 0.168208313, 0.170156806, 0.172113157, 0.174091447, 0.176099304, 0.178128077, 0.180165389, 0.182259664, 0.184359958, 0.186512365, 0.188662998, 0.190841814, 0.193054471, 0.195247673, 0.197459628, 0.1997243, 0.202009973, 0.204306783, 0.20661834, 0.209024949, 0.211426453, 0.213836388, 0.216284091, 0.218772834, 0.221277463, 0.223758905, 0.226303094, 0.228871458, 0.231511836, 0.234201788, 0.23688129, 0.239580913, 0.242329137, 0.245098927, 0.247906432, 0.250770279, 0.25362155, 0.25653149, 0.259495593, 0.262492913, 0.265483562, 0.268475712, 0.271556898, 0.274666929, 0.277811649, 0.280989967, 0.284254702, 0.287526184, 0.290830139, 0.294139915, 0.297517041, 0.298247234, 0.300957573, 0.304381945, 0.307857154, 0.311408235, 0.314983616, 0.318621206, 0.322266211, 0.325945496, 0.32969886, 0.333508846, 0.337311738, 0.341203143, 0.345140072, 0.349099669, 0.35318121, 0.357267863, 0.361376495, 0.36551871, 0.369703436, 0.373936893, 0.378303689, 0.382680486, 0.387080373, 0.391473565, 0.395956456, 0.39689192, 0.400545543, 0.405205791, 0.409909692, 0.414639694, 0.419464814, 0.424287332, 0.429245153, 0.434220292, 0.439278633, 0.444383367, 0.449610474, 0.4548177, 0.460149101, 0.465497097, 0.470949075, 0.476448025, 0.48202817, 0.48763691, 0.493261725, 0.499074283, 0.504923202, 0.51084046, 0.516772988, 0.522843707, 0.52905977, 0.535341804, 0.541680744, 0.548130981, 0.554622447, 0.56116211, 0.567881031, 0.574642129, 0.581504045, 0.588459976, 0.595473122, 0.598496273, 0.602598026, 0.60982204, 0.617123552, 0.624562334, 0.632093488, 0.639764885, 0.647537194, 0.655341087, 0.663290748, 0.671284045, 0.679451223, 0.687672516, 0.696078251, 0.704594591, 0.71333099, 0.722163226, 0.731022932, 0.740015691, 0.749224428, 0.758485446, 0.767991879, 0.777557872, 0.787268682, 0.797159079, 0.807203739, 0.811387308, 0.817388438, 0.827809029, 0.838304089, 0.849041795, 0.859933812, 0.870938066, 0.882297233, 0.893668559, 0.905282285, 0.91707555, 0.92901388, 0.94131805, 0.953798692, 0.966581558, 0.979494405, 0.99251355, 1.005912279, 1.019608707, 1.03358439, 1.0447379, 1.070051195, 1.084139794, 1.098264783, 1.112324365, 1.126336126, 1.140338894, 1.154326832, 1.168209383, 1.181980656, 1.195863565, 1.209651078, 1.22341245, 1.237115634, 1.250836692, 1.264368349, 1.277946024, 1.291405718, 1.304913607, 1.312844216, 1.31841107, 1.331833768, 1.345202296, 1.358670898, 1.372117493, 1.385431521, 1.398846222, 1.412274208, 1.425677911, 1.439060934, 1.45242263, 1.465753645, 1.478968304, 1.492416861, 1.505759181, 1.519054556, 1.532469636, 1.545748036, 1.559093227, 1.572336449, 1.58555107, 1.598825487, 1.612200318, 1.625605655, 1.638924332, 1.646614529, 1.652302606, 1.665629696, 1.678970294, 1.692352453, 1.705576898, 1.718837972, 1.732092568, 1.745499745, 1.758884463, 1.772296095, 1.785722584, 1.799064839, 1.812492065, 1.825842433, 1.839428099, 1.852864715, 1.866488081, 1.880024805, 1.893482252, 1.907206681, 1.920952511, 1.934695681, 1.94843163, 1.96223207, 1.976180607, 1.990061417, 2.003827614, 2.017702395, 2.031673648, 2.0456824, 2.059794608, 2.073900285, 2.087993512, 2.102135659, 2.116414439, 2.12782403, 2.130840127, 2.145305641, 2.159662516, 2.174250252, 2.188759784, 2.203429982, 2.218066887, 2.232782368, 2.247620377, 2.262452827, 2.277303267, 2.292284834, 2.307667149, 2.322686176, 2.337957291, 2.353418206, 2.368829403, 2.384522691, 2.400261944, 2.416116188, 2.431970497, 2.447796224, 2.464029208, 2.480235676, 2.496405767, 2.509364968, 2.513006366, 2.529506923, 2.546223402, 2.562867004, 2.579937372, 2.59674608, 2.613749406, 2.630917069, 2.648395712, 2.665829782, 2.683459195, 2.701323111, 2.719306098, 2.737544142, 2.755958392, 2.774236398, 2.792884937, 2.811743859, 2.830897975, 2.849941747, 2.86934231, 2.88904065, 2.908499813, 2.928519751, 2.948830908, 2.969203492, 2.989621838, 3.010321869, 3.031196135, 3.052218839, 3.073460635, 3.095207753, 3.116946584, 3.138758808, 3.161262425, 3.183376461, 3.20612686, 3.22949247, 3.25264956, 3.275987703, 3.299214249, 3.322915375, 3.347278459, 3.371272289, 3.395812635, 3.420495625, 3.445221198, 3.470968244, 3.496652725, 3.522615573, 3.548869409, 3.575169859, 3.601465679, 3.628237088, 3.6548304, 3.681834362, 3.709156127, 3.737287456, 3.765631662, 3.79371242, 3.821906137, 3.850877938, 3.880562659, 3.909414329, 3.939739178, 3.969232032, 3.99913138, 4.029597303, 4.05989882, 4.090958089, 4.121821482, 4.153134818, 4.183891831, 4.21573655, 4.247297258, 4.279564675, 4.312057396, 4.34405157, 4.37655697, 4.40929535, 4.442449794, 4.475782972, 4.509867869, 4.543902716, 4.577585767, 4.611646792, 4.645502348, 4.680052972, 4.714768897, 4.75036301, 4.786166455, 4.821796308, 4.858101504, 4.894813969, 4.93143891, 4.96841648, 4.97574453, 5.004064695, 5.039991843, 5.076984658, 5.113881328, 5.150564622, 5.188943745, 5.227038253, 5.265285297, 5.304154019, 5.343277989, 5.382007283, 5.421113171, 5.459991541, 5.499388172, 5.539764171, 5.578880646, 5.619165543, 5.660162791, 5.699110667, 5.739856515, 5.780374896, 5.820200439, 5.861894059, 5.902946123, 5.944869752, 5.986151675, 6.029896402, 6.072541755, 6.115104843, 6.157598315, 6.200229678, 6.243535202, 6.287384645, 6.331003517, 6.375355991, 6.420753913, 6.464189563, 6.509453868, 6.554418518, 6.597604931, 6.64249612, 6.688108226, 6.734755207, 6.780946656, 6.826979809, 6.87428588, 6.922132716, 6.969869036, 7.015784152, 7.064755157, 7.113807563, 7.163312303, 7.212206183, 7.259190737, 7.308788133, 7.358414484, 7.408115888, 7.459275551, 7.509503211, 7.559460414, 7.60829547, 7.657881609, 7.707626965, 7.76004499, 7.811546659, 7.864641557, 7.916580052, 7.968461789, 8.020531438, 8.072025641, 8.123355931, 8.176133988, 8.228021208, 8.28108358, 8.336015881, 8.389986033, 8.445052783, 8.500299117, 8.553743555, 8.607949207, 8.663723607, 8.716915679, 8.771813712, 8.827779666, 8.884756664, 8.941256189, 8.997020833, 9.052228803, 9.110019299, 9.169150478, 9.226380369, 9.284010934, 9.342120104, 9.397884181, 9.456236468, 9.514243663, 9.577263119, 9.637038242, 9.700254166, 9.759343741, 9.821968142, 9.883089268, 9.944710711, 10.005758327, 10.068853755, 10.128950957, 10.189705658, 10.250157123, 10.313030711, 10.376303949, 10.439876704, 10.504137306, 10.567384111, 10.632464217, 10.694772873, 10.759357306, 10.824258992, 10.890227395, 10.956332201, 11.018961138, 11.085759422, 11.149730253, 11.215657194, 11.284211111, 11.350873688, 11.42105375, 11.489884872, 11.555834794, 11.624359881, 11.695466403, 11.763181418, 11.835376702, 11.904687611, 11.970874046, 12.039159818, 12.111141852, 12.18207874, 12.25050605, 12.321797514, 12.392210204, 12.461935844, 12.530679289, 12.60482987, 12.677269161, 12.75082973, 12.82643928, 12.904426693, 12.981191771, 13.054282312, 13.129928443, 13.206790395, 13.285686021, 13.36430169, 13.441729122, 13.522188398, 13.595632482, 13.675601068, 13.756382909, 13.832626927, 13.909782074, 13.992814916, 14.074462184, 14.155081123, 14.227801516, 14.30255052, 14.382670482, 14.462331692, 14.544035603, 14.627520328, 14.705147346, 14.788951837, 14.874713353, 14.951328816, 15.034740965, 15.115404237, 15.198141608, 15.27701122, 15.355675662, 15.437375321, 15.519949609, 15.601838241, 15.682251363, 15.76994148, 15.854239237, 15.94789553, 16.029830683, 16.113493343, 16.193209612, 16.285209031, 16.370175113, 16.454913978, 16.542380838, 16.635495708, 16.721715846, 16.813355533, 16.901834313, 16.993225505, 17.081208408, 17.166000071, 17.263926495, 17.280912064, 17.354613683, 17.445969951, 17.532509084, 17.618981999, 17.709049244, 17.801017034, 17.898287709, 17.989425472, 18.076778923, 18.166513233, 18.258219447, 18.352160351, 18.447073118, 18.545046476, 18.649902424, 18.743627514, 18.844103962, 18.93995672, 19.033641351, 19.127994985, 19.22674408, 19.318026164, 19.413749936, 19.516583928, 19.602773848, 19.712924739, 19.813125862, 19.917604524, 20.026069348, 20.125966634, 20.233163542, 20.339660504, 20.432899073, 20.535459063, 20.637934472, 20.738099036, 20.842222876, 20.943493974, 21.057750829, 21.152752224, 21.258810794, 21.365330756, 21.472509672, 21.576662176, 21.682138699, 21.79679492, 21.901920871, 22.013025162, 22.119300064, 22.230514613, 22.342856542, 22.447431091, 22.562194449, 22.670868649, 22.773208826, 22.886540739, 22.98884591, 23.108571104, 23.223655072, 23.324155162, 23.431163689, 23.542148431, 23.655079594, 23.772178358, 23.873227636, 23.986110952, 24.091478021, 24.200026174, 24.303769388, 24.415115357, 24.54210985, 24.653305219, 24.772059155, 24.899970374, 25.021421978, 25.140523527, 25.264457866, 25.380700499, 25.495610867, 25.622686417, 25.740900614, 25.867493402, 25.975583099, 26.095653068, 26.247250157, 26.356410397, 26.457811175, 26.598902007, 26.744929718, 26.881351984, 27.000233574, 27.114869457, 27.243640518, 27.377283069, 27.494453511, 27.637869706, 27.77882592, 27.912335276, 28.031473058, 28.149779645, 28.277413553, 28.404469397, 28.539500311, 28.692251394, 28.820316465, 28.969216564, 29.106533313, 29.251407033, 29.384868735, 29.516607584, 29.652145378, 29.808736222, 29.942293555, 30.078973447, 30.220836834, 30.348247811, 30.487587464, 30.645138929, 30.794744679, 30.910658105, 31.054397499, 31.201859442, 31.351994051, 31.486716938, 31.629095174, 31.76833776, 31.908879054, 32.068536744, 32.215422436, 32.334144345, 32.499139359, 32.622631266, 32.755604953, 32.915189547, 33.069513382, 33.196956822, 33.336915224, 33.466944695, 33.60089337, 33.752829693, 33.887570142, 34.0383013, 34.18614147, 34.333045718, 34.488609854, 34.618283824, 34.746442657, 34.887682344, 35.030953666, 35.165769003, 35.308662753, 35.472956904, 35.611351779, 35.783350498, 35.939685606, 36.085659605, 36.231694088, 36.370554768, 36.510189545, 36.662841113, 36.813172716, 36.965498146, 37.131377622, 37.279864099, 37.424418437, 37.557674371, 37.726500793, 37.899042239, 38.041555716, 38.19152569, 38.32237562, 38.48669187, 38.661326717, 38.842753312, 38.990082559, 39.161519836, 39.340217699, 39.478061131, 39.600391868, 39.798948188, 39.984313755, 40.145165602, 40.328025617, 40.479059494, 40.675066737, 40.853873175, 41.016021773, 41.185484376, 41.337066484, 41.52946957, 41.688547783, 41.836886603, 42.049371011, 42.208699428, 42.369869275, 42.518030149, 42.718029559, 42.894670323, 43.046868838, 43.220827237, 43.255676848, 43.409486453, 43.576846337, 43.777735106, 43.966466885, 44.126601414, 44.310151734, 44.475294993, 44.643742514, 44.805261656, 44.918748931, 45.093559116, 45.27214507, 45.477031669, 45.631552739, 45.808374906, 45.986056965, 46.114997477, 46.313622809, 46.482072469, 46.669134063, 46.829000063, 47.044608739, 47.21489944, 47.413564871, 47.606513136, 47.765362379, 47.928166571, 48.119163358, 48.28578671, 48.471831971, 48.73757178, 48.898771783, 49.138229763, 49.296311563, 49.493673619, 49.693338565, 49.87322605, 50.026464039, 50.222446426, 50.472550114, 50.658326598, 50.871067335, 51.05283004, 51.285232344, 51.473541469, 51.688875653, 51.830154575, 52.024928209, 52.169819487, 52.377745069, 52.576514158, 52.815944306, 52.992547544, 53.13788021, 53.33948381, 53.582693777, 53.79317019, 54.001134178, 54.243661605, 54.436865821, 54.612322624, 54.834561462, 55.030217833, 55.194374063, 55.403473876, 55.564149625, 55.751016542, 55.956871954, 56.107914544, 56.298383326, 56.534283428, 56.680021851, 56.831775066, 57.05944334, 57.210817155, 57.413408574, 57.533574379, 57.734773131, 58.030316061, 58.215958367, 58.474773782, 58.669738265, 58.86115215, 59.011566287, 59.214911338, 59.407796866, 59.687801717, 60.021886403, 60.258800494, 60.363438864, 60.620823269, 60.831277305, 61.039043465, 61.259602596, 61.526145308, 61.844179164, 62.116227157, 62.286981508, 62.619974235, 62.814095515, 63.002643631, 63.257363825, 63.388562591, 63.597108503, 63.840729562, 64.019107782, 64.208715482, 64.50169267, 64.628354063, 64.823155124, 64.997809818, 65.44356564, 65.539881354, 65.800009126, 66.030437895, 66.280312317, 66.567077169, 66.668098229, 66.876019504, 67.153529398, 67.411280972, 67.568303116, 67.792183078, 68.036388017, 68.220476835, 68.538238371, 68.746208712, 68.978088023, 69.146200695, 69.329485779, 69.568059209, 69.78265228, 69.965392013, 70.13902224, 70.414842665, 70.672375649, 70.935584586, 71.15466812, 71.358832275, 71.734427789, 71.917152342, 72.25160482, 72.510782546, 72.81863373, 72.929605358, 73.188642125, 73.404066193, 73.573085135, 73.865746695, 74.118720987, 74.31762623, 74.663293522, 74.838072563, 75.018072795, 75.298859172, 75.493911358, 75.903057138, 76.098197981, 76.283834403, 76.805829014, 77.010369865, 77.370662448, 77.652782035, 77.879113174, 78.352568687, 78.621226741, 78.889946671, 79.133525545, 79.250266277, 79.629513093, 79.947720224, 80.289133592, 80.68991408, 80.768956526, 80.962180462, 81.297223925, 81.524013543, 81.831451907, 82.116362556, 82.290840653, 82.71199557, 82.973353985, 83.213231586, 83.464620336, 83.71403628, 83.845167159, 84.343488173, 84.447852247, 84.627562636, 84.845474233, 85.295608815, 85.495343603, 85.72941252, 85.809048562, 86.123827881, 86.342089604, 86.592962508, 86.809753015, 86.914876606, 87.052550521, 87.29994832, 87.550955527, 88.204022449, 88.417579649, 88.623297679, 88.909854371, 89.120577693, 89.354924901, 89.61333951, 89.792352134, 90.180709163, 90.658976948, 90.877280875, 91.174581973, 91.406927886, 91.93217966, 92.14488673, 92.410216048, 92.75437233, 93.041011508, 93.145634142, 93.268377993, 93.469652535, 93.517701033, 93.792905585, 94.067240082, 94.22546962, 94.555739116, 94.834516244, 95.25186722, 95.620761991, 95.993565375, 96.259822101, 96.431534571, 96.867753724, 96.994938808, 97.483226713, 97.653890118, 98.0395559, 98.427455395, 98.626083865, 98.822710254, 99.303279162, 99.418229472, 99.677670451, 99.969224317, 100.268062123, 100.592473231, 100.862156219, 101.156040921, 101.285539401, 101.752031408, 102.093685249, 102.327455735, 102.63438942, 103.245346725, 103.44414504, 103.559115814, 103.680413555, 103.897987566, 104.5600904, 105.121580857, 105.202608762, 105.436705503, 105.614519071, 105.913356763, 106.207835256, 106.389073407, 106.919107595, 107.354935631, 107.467156534, 107.862449231, 107.941813425, 108.061573573, 108.589190594, 109.007206208, 109.028718709, 110.023110606, 110.316757984, 110.415919632, 110.530547094, 112.388542346, 112.441772737, 112.650183117, 113.356986996, 113.459067202, 113.68578268, 113.846433546, 114.10317855, 114.39054056, 114.599508811, 114.811211115, 115.273832451, 115.483938518, 115.974501561, 116.019294721, 116.289748641, 117.199952687, 117.34192979, 117.474547792, 117.514755953, 117.620238882, 118.085802113, 118.412075151, 118.803923459, 119.399609207, 120.201470073, 120.612410313, 120.867811399, 121.151566203, 121.189271773, 121.279708169, 121.724592839, 121.901979262, 122.049292612, 122.117690135, 122.449730819, 122.886017516, 123.625635491, 123.811318881, 124.323971983, 124.389537568, 124.619442442, 125.353659296, 125.439631764, 125.537999334, 125.699394402, 126.061109276, 126.274495562, 126.462611783, 126.634908312, 126.915659094, 127.915750737, 128.011118659, 128.188445176, 128.726958042, 128.938960749, 129.130284989, 129.273995598, 129.276086753), "75" = c(1.9926e-05, 2.0008e-05, 2.0385e-05, 2.1582e-05, 2.1808e-05, 2.1893e-05, 2.1932e-05, 2.2121e-05, 2.2526e-05, 2.3232e-05, 2.3292e-05, 2.3594e-05, 2.379e-05, 2.4026e-05, 2.4275e-05, 2.4877e-05, 2.5259e-05, 2.5502e-05, 2.5611e-05, 2.5698e-05, 2.6289e-05, 2.6438e-05, 2.7329e-05, 2.7536e-05, 2.7644e-05, 2.7718e-05, 2.866e-05, 2.9818e-05, 3.0473e-05, 3.0589e-05, 3.0776e-05, 3.1023e-05, 3.1244e-05, 3.1409e-05, 3.1522e-05, 3.2579e-05, 3.3005e-05, 3.3525e-05, 3.3666e-05, 3.4297e-05, 3.4399e-05, 3.4562e-05, 3.4755e-05, 3.5491e-05, 3.6366e-05, 3.7106e-05, 3.7297e-05, 3.7574e-05, 3.8128e-05, 3.8675e-05, 3.8972e-05, 3.9115e-05, 4.1447e-05, 4.1503e-05, 4.1979e-05, 4.2266e-05, 4.2477e-05, 4.255e-05, 4.3575e-05, 4.3931e-05, 4.4393e-05, 4.4551e-05, 4.5011e-05, 4.5622e-05, 4.6149e-05, 4.6499e-05, 4.7175e-05, 4.783e-05, 4.8241e-05, 4.8287e-05, 4.8868e-05, 4.8988e-05, 4.9798e-05, 5.1023e-05, 5.1304e-05, 5.1746e-05, 5.3192e-05, 5.3692e-05, 5.3907e-05, 5.449e-05, 5.5097e-05, 5.5864e-05, 5.6597e-05, 5.6706e-05, 5.7617e-05, 5.844e-05, 5.8791e-05, 5.9081e-05, 5.985e-05, 6.0431e-05, 6.123e-05, 6.1972e-05, 6.2706e-05, 6.3098e-05, 6.3505e-05, 6.3749e-05, 6.4121e-05, 6.4656e-05, 6.5265e-05, 6.6212e-05, 6.7391e-05, 6.7794e-05, 6.854e-05, 6.93e-05, 7.0571e-05, 7.1609e-05, 7.2166e-05, 7.2955e-05, 7.3822e-05, 7.4783e-05, 7.5537e-05, 7.6474e-05, 7.7525e-05, 7.8667e-05, 7.9505e-05, 8.052e-05, 8.1199e-05, 8.2274e-05, 8.2997e-05, 8.3677e-05, 8.4412e-05, 8.5289e-05, 8.6208e-05, 8.7253e-05, 8.8733e-05, 8.9362e-05, 8.9914e-05, 9.102e-05, 9.1447e-05, 9.2998e-05, 9.4287e-05, 9.5269e-05, 9.6139e-05, 9.6581e-05, 9.7638e-05, 9.9416e-05, 0.00010098, 0.000101366, 0.000102071, 0.000103051, 0.000103755, 0.000104791, 0.000105291, 0.000107071, 0.000108582, 0.000109757, 0.000110478, 0.000111316, 0.000112261, 0.000112986, 0.000113815, 0.000115041, 0.000115839, 0.000117448, 0.000118267, 0.000118827, 0.000119618, 0.000120605, 0.0001222, 0.00012345, 0.000124872, 0.00012605, 0.000127025, 0.000128234, 0.000130543, 0.000131598, 0.000131996, 0.000133812, 0.000135429, 0.000137498, 0.000139364, 0.00014141, 0.000143611, 0.000145601, 0.00014695, 0.000148414, 0.000150361, 0.000152515, 0.000155253, 0.000156881, 0.000158615, 0.000160965, 0.000162523, 0.00016382, 0.00016542, 0.000168138, 0.000169684, 0.000172035, 0.000173632, 0.000175327, 0.000178322, 0.00018106, 0.0001827, 0.000184148, 0.000186076, 0.00018788, 0.000190469, 0.000192447, 0.000194425, 0.000196223, 0.00019755, 0.000200138, 0.000202466, 0.000204901, 0.00020708, 0.000209006, 0.000210608, 0.000212993, 0.000214926, 0.000217167, 0.000219635, 0.000221607, 0.000224589, 0.000227522, 0.000229108, 0.000230898, 0.00023364, 0.000237081, 0.000240049, 0.000244165, 0.00024663, 0.000249565, 0.000251697, 0.000255026, 0.000256873, 0.000260588, 0.000263516, 0.000265781, 0.000269424, 0.000272221, 0.000275057, 0.000276965, 0.000279901, 0.000282678, 0.000285924, 0.000289275, 0.000294005, 0.000296985, 0.000300995, 0.000305178, 0.000309034, 0.000312268, 0.000315977, 0.000320739, 0.000326553, 0.000331537, 0.000336519, 0.000339973, 0.000343915, 0.000347619, 0.000351954, 0.00035589, 0.000359344, 0.000363802, 0.000369434, 0.000374037, 0.000377876, 0.000383064, 0.000386987, 0.000390008, 0.000394365, 0.000398859, 0.000403114, 0.000407484, 0.000412573, 0.000416636, 0.000420671, 0.000426284, 0.000431252, 0.000437742, 0.000441717, 0.000447633, 0.000452455, 0.000462493, 0.000467497, 0.000473302, 0.000477663, 0.000482796, 0.000487487, 0.000494469, 0.000502626, 0.000508074, 0.000511598, 0.000518444, 0.000524746, 0.000529674, 0.000536019, 0.000542718, 0.00054819, 0.000554928, 0.000562425, 0.000568859, 0.00057505, 0.000580535, 0.000588557, 0.000595246, 0.00060263, 0.000610146, 0.000616631, 0.000624308, 0.000630953, 0.000637526, 0.000643568, 0.0006489, 0.000657013, 0.000666181, 0.000671517, 0.000680816, 0.000688438, 0.000696725, 0.000706144, 0.000714238, 0.000721153, 0.000732102, 0.000739255, 0.000746498, 0.000756852, 0.000764514, 0.000773356, 0.00078262, 0.000793557, 0.000802502, 0.000812878, 0.000823891, 0.000832964, 0.00084028, 0.000851717, 0.000863834, 0.000875031, 0.00088575, 0.000895026, 0.000904352, 0.000914788, 0.000925746, 0.000937002, 0.000947436, 0.000956921, 0.000967128, 0.000979563, 0.00099199, 0.001004034, 0.001007491, 0.001021799, 0.001034835, 0.001046194, 0.001059011, 0.001071378, 0.001082573, 0.001097574, 0.001109905, 0.001121798, 0.001135039, 0.001151245, 0.001163096, 0.001175644, 0.001188422, 0.001203852, 0.001217752, 0.001231812, 0.001243642, 0.001256653, 0.001274734, 0.001289672, 0.001303188, 0.00131862, 0.001333604, 0.001349962, 0.001364803, 0.001379406, 0.001398632, 0.001414492, 0.001429183, 0.001445884, 0.001463142, 0.001481469, 0.001496111, 0.00151357, 0.001533614, 0.001550292, 0.001567589, 0.001583405, 0.00159848, 0.001615945, 0.00163198, 0.001651671, 0.001670306, 0.001688008, 0.001707006, 0.001729937, 0.001748799, 0.001767137, 0.001783467, 0.001800725, 0.001819795, 0.001841482, 0.0018609, 0.001882537, 0.001904729, 0.001925837, 0.001949627, 0.001971304, 0.001993815, 0.002018549, 0.002039659, 0.002062082, 0.002085406, 0.002108171, 0.002132534, 0.002156637, 0.002178771, 0.002203661, 0.002227438, 0.002248875, 0.002278595, 0.002307573, 0.002333736, 0.002359829, 0.002384013, 0.002409816, 0.002436586, 0.002463893, 0.002495421, 0.002526547, 0.002557696, 0.002585832, 0.002617665, 0.002648936, 0.002678392, 0.002708905, 0.002743956, 0.002773472, 0.002804792, 0.00283807, 0.002873017, 0.002903934, 0.002936393, 0.002967045, 0.002998175, 0.003029929, 0.003063566, 0.003099063, 0.003137308, 0.003173732, 0.003214423, 0.003251052, 0.003286017, 0.003325581, 0.003365557, 0.003408106, 0.003443784, 0.003485741, 0.003531565, 0.003570438, 0.003610815, 0.003654142, 0.003696675, 0.003737082, 0.003782872, 0.003822526, 0.003866892, 0.003908356, 0.00395455, 0.003999571, 0.004045878, 0.004088984, 0.004142262, 0.004188075, 0.004238375, 0.004281831, 0.004331384, 0.00437894, 0.004427566, 0.004482056, 0.004533626, 0.004584114, 0.004639004, 0.004696475, 0.004749003, 0.004805075, 0.004861379, 0.004916152, 0.004979107, 0.005041756, 0.005100325, 0.005158877, 0.005220914, 0.005281421, 0.005339962, 0.00540595, 0.005463467, 0.005532255, 0.005597708, 0.005663057, 0.005725101, 0.005793743, 0.005861741, 0.005927356, 0.005999203, 0.006073196, 0.006141068, 0.006219749, 0.006286931, 0.00635649, 0.006427204, 0.006501247, 0.006573587, 0.006657182, 0.00673329, 0.00681637, 0.006897579, 0.006979872, 0.007064968, 0.007148851, 0.007229018, 0.007313727, 0.007399816, 0.007481987, 0.007561429, 0.007651177, 0.007737684, 0.007829306, 0.007918571, 0.008009056, 0.008102338, 0.008199902, 0.008293835, 0.008388583, 0.008489969, 0.008584689, 0.008682444, 0.00877732, 0.008874165, 0.008973627, 0.009078272, 0.009179862, 0.009281871, 0.009393476, 0.00949625, 0.009608853, 0.009721187, 0.009833293, 0.009920112, 0.009941647, 0.010053759, 0.010171958, 0.010287587, 0.010402661, 0.010515532, 0.010635243, 0.010750055, 0.010870614, 0.011000206, 0.011124979, 0.011257869, 0.011391389, 0.011514796, 0.011645585, 0.01179006, 0.0119261, 0.012053551, 0.01218608, 0.012321871, 0.012466541, 0.012615066, 0.012757039, 0.012907676, 0.01305624, 0.013220621, 0.013385722, 0.013546751, 0.013706813, 0.013861945, 0.014011276, 0.014182509, 0.014345854, 0.014512663, 0.014689881, 0.014865428, 0.015037275, 0.015214821, 0.015391351, 0.01556956, 0.015754579, 0.015931899, 0.016116862, 0.016302905, 0.01649429, 0.016682245, 0.016871728, 0.017066906, 0.017268368, 0.017469644, 0.017669236, 0.017880784, 0.018101856, 0.018311386, 0.01852651, 0.018741681, 0.018953572, 0.019179406, 0.01939771, 0.019618888, 0.019841391, 0.020076931, 0.020306719, 0.020538202, 0.020776628, 0.021020014, 0.021260945, 0.021503823, 0.021755277, 0.02200509, 0.022260713, 0.02252413, 0.022767544, 0.023026029, 0.023292419, 0.023568785, 0.023839924, 0.02411701, 0.024400725, 0.024677682, 0.024964285, 0.02526059, 0.025567869, 0.025857449, 0.026158686, 0.026460384, 0.026776368, 0.02708845, 0.027400763, 0.027710941, 0.028032315, 0.028361886, 0.028692197, 0.029028536, 0.029357258, 0.029715139, 0.030068717, 0.030421563, 0.030767706, 0.031115616, 0.031471277, 0.031833321, 0.032194297, 0.032547574, 0.032923893, 0.033290531, 0.033682553, 0.034094146, 0.03448713, 0.03489605, 0.035279167, 0.035686264, 0.036091058, 0.036516668, 0.036934399, 0.037354829, 0.037795679, 0.038240443, 0.038689519, 0.039131001, 0.039581493, 0.04005133, 0.040498717, 0.040957226, 0.041448159, 0.041932716, 0.042422303, 0.042913717, 0.043423282, 0.04391653, 0.044424687, 0.044935394, 0.04545522, 0.045998804, 0.046528047, 0.047059423, 0.047618004, 0.048165238, 0.048737574, 0.049293548, 0.049877354, 0.050473762, 0.051064636, 0.051672303, 0.052296108, 0.052897759, 0.053515141, 0.054137023, 0.054791101, 0.055432374, 0.056070315, 0.056718692, 0.05736932, 0.058047696, 0.058708263, 0.059393637, 0.060077602, 0.060783711, 0.061476152, 0.062188898, 0.062909171, 0.063633024, 0.064362186, 0.065123598, 0.065879092, 0.066621396, 0.067400083, 0.068172378, 0.068974947, 0.069775179, 0.070582042, 0.071418064, 0.072248371, 0.073093379, 0.073943475, 0.074809196, 0.07568846, 0.076565326, 0.077466479, 0.078366482, 0.079252339, 0.080184663, 0.081110283, 0.082040155, 0.083002517, 0.083970125, 0.084948654, 0.085941601, 0.086960742, 0.087992583, 0.08899445, 0.090020011, 0.091052404, 0.09211079, 0.093185065, 0.094248006, 0.095307949, 0.096406283, 0.097535818, 0.098625607, 0.099534964, 0.099775301, 0.100926136, 0.102106921, 0.103297996, 0.104503634, 0.105724141, 0.106947782, 0.108205992, 0.109433378, 0.11072439, 0.111967855, 0.113264713, 0.11457501, 0.115910299, 0.117258819, 0.11859499, 0.119967924, 0.121341871, 0.122731108, 0.124143687, 0.125602626, 0.12705951, 0.128534972, 0.130018761, 0.131521904, 0.133037789, 0.134596399, 0.136163596, 0.137714477, 0.139330786, 0.140950401, 0.142600892, 0.144248995, 0.145928493, 0.147651082, 0.149388627, 0.151120279, 0.152864596, 0.154638043, 0.156424667, 0.158263223, 0.160142953, 0.162014647, 0.163892394, 0.165831802, 0.167742732, 0.169709491, 0.171693788, 0.173660948, 0.175678456, 0.177729151, 0.17979807, 0.181900204, 0.184020595, 0.186167108, 0.188327432, 0.190563099, 0.192771184, 0.195056539, 0.197351085, 0.199661189, 0.201977288, 0.204351732, 0.206732127, 0.209165251, 0.211638347, 0.214092202, 0.216589294, 0.219095417, 0.221674396, 0.224235797, 0.226830966, 0.229512624, 0.232226657, 0.234941318, 0.237686438, 0.24044084, 0.243244063, 0.246108608, 0.248979895, 0.251888442, 0.254846968, 0.25782899, 0.260850077, 0.263921579, 0.267021944, 0.270164609, 0.273343468, 0.276547183, 0.279789516, 0.283120036, 0.28644187, 0.289827667, 0.29322163, 0.296697477, 0.300240509, 0.301020176, 0.303822864, 0.307442477, 0.311060961, 0.31474271, 0.31849776, 0.322254681, 0.326029374, 0.329871273, 0.333805906, 0.33782913, 0.341853439, 0.34589863, 0.349986043, 0.354100448, 0.35830011, 0.36258363, 0.366895362, 0.371307911, 0.375721798, 0.380250281, 0.384829638, 0.389461335, 0.394152556, 0.398876919, 0.403633452, 0.404596547, 0.408479137, 0.413354503, 0.418357859, 0.423395861, 0.428508426, 0.433673496, 0.43886669, 0.444141393, 0.449460405, 0.454891907, 0.460378974, 0.465909258, 0.471575238, 0.477262066, 0.483017407, 0.48887837, 0.494823834, 0.50083452, 0.506935618, 0.513120632, 0.519344357, 0.525821422, 0.532317374, 0.538783143, 0.545463385, 0.552146751, 0.558934882, 0.565834852, 0.572823254, 0.579915645, 0.58705497, 0.594359866, 0.601720611, 0.609257657, 0.616897194, 0.620159999, 0.62463396, 0.632393569, 0.640306494, 0.648337399, 0.656441161, 0.664700569, 0.673179752, 0.681669818, 0.690301043, 0.69909318, 0.70803116, 0.71705569, 0.726180231, 0.735548909, 0.744944668, 0.754505112, 0.764259579, 0.774320322, 0.784429532, 0.794655629, 0.805076063, 0.815638322, 0.826314588, 0.837193653, 0.848337813, 0.852889134, 0.85954841, 0.870978584, 0.882589914, 0.894466242, 0.906510638, 0.918772045, 0.931160869, 0.94386571, 0.956833184, 0.97005893, 0.983409303, 0.996936375, 1.010830571, 1.024997707, 1.039404075, 1.0542006, 1.069210224, 1.084432077, 1.100002002, 1.112642294, 1.141317016, 1.157242094, 1.173070036, 1.18897463, 1.204713797, 1.220591982, 1.236416104, 1.252055501, 1.267770984, 1.283380634, 1.298955412, 1.314632062, 1.33015199, 1.345696415, 1.361239212, 1.376724528, 1.392135468, 1.407487585, 1.416504332, 1.422844184, 1.438102779, 1.453350966, 1.468743558, 1.484085434, 1.499376048, 1.514703681, 1.529933508, 1.545238921, 1.560487812, 1.575774438, 1.591063512, 1.606280938, 1.621482583, 1.6367233, 1.651985594, 1.667254002, 1.68237079, 1.697580684, 1.712715106, 1.727904121, 1.743050873, 1.758237151, 1.773420278, 1.78869453, 1.797495188, 1.80391898, 1.819106079, 1.834352044, 1.849563365, 1.864871997, 1.880224102, 1.895492924, 1.910840162, 1.926145125, 1.941405416, 1.956831584, 1.972226825, 1.987661502, 2.002956008, 2.018485332, 2.033908516, 2.049275877, 2.064611737, 2.0799798, 2.095454639, 2.111095245, 2.12675087, 2.142222018, 2.15797565, 2.173704529, 2.189456198, 2.205400761, 2.221282222, 2.237220467, 2.253136312, 2.269053787, 2.28517093, 2.301236118, 2.317465544, 2.333534138, 2.346277805, 2.349648191, 2.365703175, 2.38190189, 2.398370982, 2.414859323, 2.431239836, 2.447629715, 2.464217304, 2.480965837, 2.497673828, 2.514382915, 2.531469327, 2.548521737, 2.565471271, 2.582595594, 2.599788525, 2.617005884, 2.634075327, 2.6514722, 2.668960707, 2.686513168, 2.70389386, 2.721777396, 2.739497723, 2.757252035, 2.771347314, 2.77528088, 2.79320824, 2.811452934, 2.82939088, 2.847771857, 2.866365006, 2.885207649, 2.904015954, 2.922697479, 2.941483914, 2.960662016, 2.980108786, 2.999380427, 3.018952193, 3.03875265, 3.058800515, 3.078608031, 3.098464055, 3.118829379, 3.139157872, 3.159575244, 3.180217975, 3.200909519, 3.221773896, 3.243112627, 3.264252457, 3.28578577, 3.3074665, 3.329095669, 3.350951741, 3.373147188, 3.39533351, 3.417678781, 3.440309289, 3.463187922, 3.486232028, 3.509345268, 3.532978825, 3.556651899, 3.580404835, 3.604247218, 3.628168054, 3.652336168, 3.676881682, 3.70192819, 3.72684761, 3.752158735, 3.77777219, 3.803777186, 3.829523494, 3.855742094, 3.88182545, 3.908357577, 3.935022192, 3.962317667, 3.989403595, 4.017343416, 4.045545161, 4.073390654, 4.102087489, 4.130816766, 4.159311438, 4.18759797, 4.216707911, 4.245456245, 4.275356415, 4.305198855, 4.334894942, 4.365032224, 4.395287998, 4.426471548, 4.457694052, 4.488730943, 4.519695158, 4.551107828, 4.583574006, 4.615375526, 4.648347284, 4.681061221, 4.714543963, 4.747577396, 4.781079783, 4.815308869, 4.849310177, 4.882601056, 4.916964185, 4.951199688, 4.985807049, 5.020554254, 5.056394255, 5.091424678, 5.127053192, 5.16217218, 5.197471957, 5.234126779, 5.270361693, 5.277682715, 5.307628203, 5.344796745, 5.382297963, 5.419496037, 5.456939775, 5.495003912, 5.532166183, 5.570861725, 5.608693106, 5.64763753, 5.686537552, 5.725483454, 5.765230705, 5.803804082, 5.844145514, 5.883305272, 5.923085301, 5.964095052, 6.00443908, 6.0448316, 6.08618218, 6.127861547, 6.169847985, 6.211983045, 6.253548125, 6.296546025, 6.33917013, 6.382581227, 6.425603351, 6.468285203, 6.511950696, 6.554148612, 6.596927605, 6.640524909, 6.684520057, 6.727936756, 6.774671692, 6.819953404, 6.863777119, 6.90748279, 6.952424696, 6.996961398, 7.041201208, 7.086495295, 7.134225719, 7.179714076, 7.225026377, 7.269975207, 7.316590615, 7.364152495, 7.410249915, 7.455832383, 7.504742777, 7.551713274, 7.601749543, 7.650030883, 7.699114264, 7.749564767, 7.797259042, 7.848053955, 7.897246087, 7.94717801, 7.996592629, 8.044889949, 8.09447516, 8.145849755, 8.198166523, 8.249633886, 8.301497645, 8.353618212, 8.405739836, 8.457896068, 8.510419824, 8.561409779, 8.614753222, 8.666467958, 8.717875551, 8.770023992, 8.82349278, 8.877000517, 8.930939228, 8.986553589, 9.039634575, 9.095522927, 9.151713275, 9.208592527, 9.263056447, 9.320469404, 9.377056696, 9.433645958, 9.491680389, 9.549224513, 9.607619134, 9.666848681, 9.724548232, 9.781688562, 9.839618541, 9.897930122, 9.956383476, 10.013881394, 10.073535228, 10.130293585, 10.189173995, 10.249983751, 10.311422134, 10.373434804, 10.434573126, 10.496463866, 10.55719245, 10.619278297, 10.679100645, 10.740707208, 10.805472699, 10.866241364, 10.92859632, 10.991682191, 11.05411833, 11.119366358, 11.182538908, 11.247821358, 11.312081147, 11.375355457, 11.438995013, 11.505189028, 11.571981389, 11.636623618, 11.704395262, 11.770973303, 11.834760219, 11.900196968, 11.967739342, 12.034635477, 12.103737641, 12.17111953, 12.238577634, 12.308895662, 12.375763365, 12.446143734, 12.516108013, 12.586104215, 12.657418491, 12.726160372, 12.798246266, 12.869004636, 12.936141032, 13.005716245, 13.078796026, 13.150464478, 13.223341613, 13.294087529, 13.364159649, 13.437415093, 13.511889343, 13.584978458, 13.660016824, 13.733562886, 13.806801166, 13.881113245, 13.952892544, 14.028039928, 14.100924398, 14.180216904, 14.259423078, 14.336756791, 14.40713669, 14.481695855, 14.559252676, 14.634481309, 14.711413257, 14.791474631, 14.869100162, 14.947552818, 15.031793992, 15.112869303, 15.195521906, 15.272167653, 15.355780651, 15.441853384, 15.52407653, 15.605226572, 15.691193553, 15.77467161, 15.856130316, 15.936933808, 16.019976263, 16.102652024, 16.182535717, 16.269014223, 16.351780713, 16.428327872, 16.512204866, 16.594821207, 16.679970777, 16.765054053, 16.849974904, 16.933127822, 17.017952455, 17.106935023, 17.19648364, 17.285326774, 17.304607969, 17.372270971, 17.460085835, 17.547278741, 17.631440514, 17.722730431, 17.811317211, 17.897301835, 17.982707413, 18.076088039, 18.16927638, 18.263898136, 18.358171517, 18.446661222, 18.531759673, 18.622134156, 18.716676115, 18.805334669, 18.902017815, 18.993888292, 19.094862128, 19.181136274, 19.275003927, 19.370737827, 19.467120717, 19.562055345, 19.64512511, 19.748171793, 19.839827758, 19.93778789, 20.031795843, 20.118916978, 20.204437147, 20.302982924, 20.407862244, 20.511769569, 20.597692651, 20.699736762, 20.804408365, 20.907905706, 21.005888065, 21.099619388, 21.193898124, 21.28074048, 21.381380688, 21.470932563, 21.578231155, 21.686058427, 21.794504976, 21.903250412, 22.003328965, 22.105037862, 22.221257761, 22.337541026, 22.456677064, 22.554926362, 22.659164215, 22.758755506, 22.864905868, 22.969425364, 23.081267442, 23.185856518, 23.295082775, 23.399981447, 23.516633181, 23.626276384, 23.738106656, 23.843910772, 23.957507751, 24.055839959, 24.167188195, 24.272502044, 24.378286958, 24.480550973, 24.57802788, 24.68133711, 24.796400786, 24.903087198, 25.013433162, 25.112367595, 25.220923041, 25.330708201, 25.449579765, 25.568182702, 25.678438284, 25.80768823, 25.917591706, 26.027798168, 26.152685572, 26.271315167, 26.381546263, 26.498783511, 26.616629148, 26.734514231, 26.85367742, 26.957470646, 27.099405707, 27.218349329, 27.328524982, 27.450770644, 27.581925572, 27.712541571, 27.852762474, 27.981626123, 28.118173978, 28.239999546, 28.350794453, 28.461865591, 28.587364988, 28.714356944, 28.850380935, 28.969908021, 29.12617478, 29.235195153, 29.374700744, 29.512633313, 29.64618087, 29.789214624, 29.910030091, 30.03279491, 30.176284284, 30.32211944, 30.476265898, 30.596481795, 30.714959588, 30.855075261, 30.970987043, 31.083902994, 31.223297639, 31.355319137, 31.485166049, 31.580677831, 31.702950699, 31.829512719, 31.943029383, 32.083042359, 32.206154047, 32.362078403, 32.491706552, 32.624351548, 32.738154461, 32.856838211, 33.018268215, 33.169821625, 33.30814675, 33.445449395, 33.589571954, 33.714444741, 33.846786265, 33.978939757, 34.148876609, 34.292813058, 34.444136502, 34.595927199, 34.721510068, 34.882286746, 35.013810563, 35.149287073, 35.270380352, 35.41909007, 35.583144206, 35.711651972, 35.839920573, 36.041803837, 36.162343164, 36.312263014, 36.470440381, 36.613487927, 36.762143808, 36.924122027, 37.059026101, 37.220382201, 37.369667734, 37.544005664, 37.729244247, 37.89057017, 38.038584742, 38.183405722, 38.35464719, 38.512190876, 38.679468137, 38.868850819, 39.011377799, 39.142450523, 39.30596865, 39.462846852, 39.624404526, 39.78832261, 39.953358704, 40.12666474, 40.266996137, 40.444407078, 40.6159048, 40.771834644, 40.92963362, 41.070938744, 41.226953373, 41.383947689, 41.571865356, 41.721915694, 41.867599504, 41.909143038, 42.031467459, 42.210274668, 42.360781507, 42.543526708, 42.715794078, 42.902716592, 43.088887824, 43.264244057, 43.456066573, 43.635969172, 43.798870706, 43.935138896, 44.067916026, 44.252385034, 44.417963645, 44.630029059, 44.830041235, 44.989434013, 45.175272988, 45.311409076, 45.510096405, 45.673558474, 45.852563254, 46.047641437, 46.237139164, 46.39251055, 46.601767237, 46.768514844, 46.957670058, 47.14206772, 47.348504686, 47.555871513, 47.716277307, 47.880854384, 48.070019998, 48.259259903, 48.472956642, 48.651268333, 48.799169225, 49.01739959, 49.240922184, 49.420236047, 49.682317958, 49.891484443, 50.064214616, 50.227744357, 50.404202686, 50.544198606, 50.749953891, 50.982728697, 51.143028814, 51.318085554, 51.468463292, 51.709410498, 51.887496301, 52.098173329, 52.260203224, 52.487273202, 52.693807247, 52.845124318, 53.012293732, 53.20033269, 53.343165262, 53.561980188, 53.71563949, 53.897688012, 54.07659027, 54.287568351, 54.465964384, 54.647452903, 54.835112197, 55.011298928, 55.182483061, 55.303688197, 55.511966273, 55.71434993, 55.896858167, 56.085747289, 56.285416279, 56.475630291, 56.663452853, 56.877077029, 57.018012688, 57.195300015, 57.387018459, 57.574874648, 57.866882074, 58.027368222, 58.208390607, 58.404040593, 58.623124666, 58.829725198, 59.166823694, 59.430100223, 59.60603961, 59.806570561, 60.003631179, 60.166573071, 60.320559683, 60.573054296, 60.786945053, 60.980205454, 61.218285773, 61.403517434, 61.619421285, 61.83886515, 62.061832259, 62.30657404, 62.518616714, 62.758532932, 62.927951721, 63.073012068, 63.320583569, 63.588250085, 63.841634594, 64.064181496, 64.326080396, 64.702158993, 64.944408273, 65.232640978, 65.456460594, 65.714085003, 65.833353152, 66.019562662, 66.224459687, 66.521079564, 66.751490521, 67.055417213, 67.244944786, 67.535851374, 67.896088983, 68.196473568, 68.285622329, 68.433520419, 68.655454659, 68.892914195, 69.078107255, 69.314079425, 69.696814695, 69.910080373, 70.13959349, 70.337922612, 70.520450063, 70.654999377, 70.919420464, 71.106304871, 71.328757439, 71.562597479, 71.732208206, 71.949178952, 72.420288867, 72.620514649, 72.887954861, 73.251697074, 73.477490762, 73.76481754, 74.056946606, 74.309308599, 74.533423702, 74.810856726, 75.2519076, 75.378175399, 75.569660254, 75.937143395, 76.234180576, 76.507831729, 76.652222311, 76.898308564, 77.022980299, 77.233955803, 77.63846302, 77.813969091, 78.051191873, 78.476617712, 78.850221025, 79.105752548, 79.516659362, 79.695450931, 80.054861545, 80.187698877, 80.423007372, 80.630659604, 80.833678117, 81.056453312, 81.25905194, 81.8108268, 81.889625514, 82.227491539, 82.395789473, 82.628076386, 82.763482731, 83.324100079, 83.631904737, 83.860563976, 84.046065875, 84.375308042, 84.680886989, 84.844806616, 84.977897121, 85.2524766, 85.597544194, 85.930482941, 86.125410227, 86.402207327, 86.663472862, 86.949491524, 87.067948762, 87.301402081, 87.604235639, 87.955850825, 88.349407016, 88.648514334, 88.854421481, 89.001137487, 89.519207705, 89.883249445, 90.242299437, 90.618754244, 90.738178414, 91.207054698, 91.301086864, 91.786519175, 92.103134996, 92.66012925, 92.842152604, 93.117521056, 93.286580601, 93.61848019, 93.993129831, 94.205392733, 94.33870803, 94.638488965, 94.878549297, 95.093153733, 95.217215465, 95.350325931, 95.638582933, 95.927191472, 96.094288691, 96.495907804, 96.80149314, 97.400607116, 97.888872944, 98.32235967, 98.549743596, 98.773698279, 98.873725165, 99.290987967, 99.698764828, 100.117475461, 100.804705123, 101.155015129, 101.245066689, 101.514609734, 101.818879871, 102.013354763, 102.279856122, 102.462346101, 103.092512895, 103.462272971, 103.585366391, 103.829659957, 104.092166849, 104.267376157, 104.766862567, 105.042716121, 105.201178247, 105.679878216, 105.967941348, 106.246069172, 107.114241456, 107.395560802, 107.827243507, 108.102552103, 108.585590472, 108.68997585, 108.97575373, 110.290141728, 111.013226163, 111.326648178, 111.62406051, 111.955968995, 112.50422195, 112.545540811, 112.87594895, 113.500456736, 113.833582295, 114.401290079, 114.631838397, 114.820868982, 115.095091011, 116.031059517, 116.348265352, 116.813482772, 117.067135774, 118.018491859, 118.373663213, 118.496056746, 119.66993259, 119.890087885, 119.990408531, 120.52910327, 121.002907001, 121.351553516, 121.382846723, 121.487422562, 121.635724257, 121.796160441, 122.783619768, 123.088969236, 123.247745169, 123.388805589, 124.008948741, 124.202106345, 124.47385446, 124.64764597, 125.140503348, 125.256850457, 126.046137541, 126.811279699, 127.4743812, 127.757850093, 127.921146115, 128.248710705, 128.50036943, 129.005970643, 129.136799378, 129.61042453, 129.79706749, 129.921992799, 130.057867798, 130.17787838, 131.503872695, 131.680741846, 131.785650209, 132.075579867, 132.499953229, 132.731408048, 133.044622802, 133.188601703 ), "100" = c(2.2046e-05, 2.21e-05, 2.2301e-05, 2.2673e-05, 2.2864e-05, 2.2902e-05, 2.3154e-05, 2.3804e-05, 2.4213e-05, 2.4652e-05, 2.4896e-05, 2.501e-05, 2.5371e-05, 2.5492e-05, 2.5644e-05, 2.6348e-05, 2.6398e-05, 2.6884e-05, 2.7076e-05, 2.739e-05, 2.7511e-05, 2.7671e-05, 2.7876e-05, 2.7943e-05, 2.8361e-05, 2.8406e-05, 2.8641e-05, 2.873e-05, 2.9152e-05, 2.9693e-05, 2.9826e-05, 2.9937e-05, 3.0122e-05, 3.0193e-05, 3.0999e-05, 3.1048e-05, 3.1391e-05, 3.1818e-05, 3.2355e-05, 3.2758e-05, 3.2914e-05, 3.341e-05, 3.4117e-05, 3.4451e-05, 3.4561e-05, 3.4831e-05, 3.5301e-05, 3.5519e-05, 3.5736e-05, 3.5931e-05, 3.6099e-05, 3.6304e-05, 3.6699e-05, 3.6962e-05, 3.7482e-05, 3.7777e-05, 3.8233e-05, 3.8477e-05, 3.895e-05, 3.8983e-05, 3.9665e-05, 4.0027e-05, 4.0265e-05, 4.0605e-05, 4.0652e-05, 4.0934e-05, 4.148e-05, 4.2196e-05, 4.2878e-05, 4.3157e-05, 4.3617e-05, 4.393e-05, 4.4211e-05, 4.4694e-05, 4.495e-05, 4.5376e-05, 4.5985e-05, 4.6239e-05, 4.6505e-05, 4.7862e-05, 4.8719e-05, 4.9517e-05, 5.0171e-05, 5.0946e-05, 5.1352e-05, 5.1554e-05, 5.2033e-05, 5.2277e-05, 5.2765e-05, 5.3696e-05, 5.4182e-05, 5.4596e-05, 5.5192e-05, 5.5617e-05, 5.5971e-05, 5.6306e-05, 5.6901e-05, 5.7602e-05, 5.7909e-05, 5.8582e-05, 5.8838e-05, 5.9969e-05, 6.0744e-05, 6.1435e-05, 6.2104e-05, 6.233e-05, 6.3555e-05, 6.4948e-05, 6.5531e-05, 6.5983e-05, 6.6404e-05, 6.7249e-05, 6.7468e-05, 6.9046e-05, 6.9505e-05, 7.0207e-05, 7.12e-05, 7.2618e-05, 7.302e-05, 7.389e-05, 7.4158e-05, 7.4886e-05, 7.518e-05, 7.6717e-05, 7.7197e-05, 7.7796e-05, 7.9113e-05, 8.0554e-05, 8.1271e-05, 8.3116e-05, 8.4294e-05, 8.5022e-05, 8.5699e-05, 8.6484e-05, 8.787e-05, 8.8455e-05, 8.9181e-05, 8.9901e-05, 9.1068e-05, 9.1854e-05, 9.3009e-05, 9.4945e-05, 9.5928e-05, 9.6299e-05, 9.7374e-05, 9.8664e-05, 0.000100159, 0.000101589, 0.000102803, 0.000103672, 0.000104473, 0.000106613, 0.000107287, 0.000107851, 0.00010897, 0.000111109, 0.000111923, 0.000113873, 0.00011492, 0.000115728, 0.000116688, 0.000117544, 0.000119468, 0.000120704, 0.00012276, 0.000124797, 0.000126283, 0.000128897, 0.000129817, 0.000130835, 0.000132083, 0.000134923, 0.000136168, 0.000137598, 0.000139089, 0.000140576, 0.000142969, 0.000143792, 0.000145114, 0.000146444, 0.000148238, 0.000149753, 0.000151957, 0.00015366, 0.000155327, 0.000157008, 0.000158785, 0.000160364, 0.000162864, 0.000164797, 0.000167355, 0.000169446, 0.0001721, 0.000175441, 0.000177425, 0.000179381, 0.000182777, 0.000184808, 0.000187197, 0.000189022, 0.000190955, 0.000192868, 0.000194333, 0.000197013, 0.000198572, 0.000201138, 0.000204289, 0.00020611, 0.000207779, 0.000210597, 0.000212887, 0.000214564, 0.000217453, 0.000219513, 0.000221651, 0.000223656, 0.000225722, 0.000228047, 0.000230927, 0.000234075, 0.000238049, 0.00024159, 0.000243297, 0.00024555, 0.00024943, 0.00025173, 0.000255046, 0.000258552, 0.000261533, 0.000265449, 0.00026829, 0.000272163, 0.000274495, 0.000277602, 0.000279885, 0.000282717, 0.000284675, 0.0002869, 0.000291035, 0.000295737, 0.000299299, 0.000303633, 0.000306551, 0.000308745, 0.00031186, 0.000315565, 0.000319335, 0.00032332, 0.000327046, 0.000331575, 0.000336428, 0.000340346, 0.000344051, 0.000347137, 0.000350297, 0.000354921, 0.000359233, 0.000364497, 0.000366786, 0.000370382, 0.000373492, 0.00037742, 0.000381359, 0.000385329, 0.000389757, 0.000393919, 0.000398907, 0.000404194, 0.000409365, 0.000414027, 0.000420326, 0.000425612, 0.000430728, 0.000435118, 0.000442439, 0.000446824, 0.000452144, 0.000457252, 0.000463168, 0.000467292, 0.000472522, 0.000478102, 0.000482746, 0.000487238, 0.000492684, 0.000498803, 0.000505003, 0.00051364, 0.000519546, 0.000525379, 0.000531061, 0.000536924, 0.000544461, 0.000549227, 0.000555245, 0.000561661, 0.00056926, 0.00057622, 0.000583446, 0.000590375, 0.000595806, 0.000602372, 0.000608627, 0.000615206, 0.000622309, 0.000630504, 0.000637168, 0.000642875, 0.000652259, 0.000661019, 0.000666941, 0.000674891, 0.000681656, 0.000688418, 0.000696433, 0.000707135, 0.000713987, 0.000721125, 0.000727681, 0.000737443, 0.000746213, 0.000753625, 0.000764955, 0.000773955, 0.000782903, 0.000791077, 0.000798653, 0.000807501, 0.000816195, 0.000826463, 0.000839023, 0.000851726, 0.000861493, 0.000871512, 0.000880551, 0.000891295, 0.000903731, 0.000914804, 0.000927258, 0.000937222, 0.000945828, 0.000948729, 0.000959256, 0.000971721, 0.000983289, 0.000993458, 0.001006209, 0.001019447, 0.001030558, 0.00104123, 0.001053811, 0.001067216, 0.001081556, 0.001094365, 0.001106271, 0.001119245, 0.001133595, 0.001148798, 0.001159868, 0.001172947, 0.001186432, 0.001200825, 0.001215312, 0.001228586, 0.001242517, 0.001257438, 0.001271464, 0.001288909, 0.001304378, 0.001316997, 0.001331995, 0.001349445, 0.001363998, 0.001378511, 0.001396551, 0.001414905, 0.001433568, 0.001451659, 0.001469718, 0.00148923, 0.001507355, 0.001525868, 0.001542659, 0.001564372, 0.001582941, 0.00160133, 0.001617605, 0.001637256, 0.001657499, 0.001675688, 0.001694384, 0.001716933, 0.001733465, 0.001751349, 0.001772212, 0.00179033, 0.001812626, 0.001835029, 0.001854687, 0.001876432, 0.001894003, 0.001916278, 0.001943983, 0.001966535, 0.00198976, 0.002013911, 0.002036115, 0.002059274, 0.00208418, 0.00210994, 0.002134507, 0.002156575, 0.002184775, 0.002209424, 0.002233885, 0.002260416, 0.002290511, 0.002316387, 0.002342944, 0.002371213, 0.00240288, 0.002434141, 0.00245808, 0.002487761, 0.002516404, 0.002545423, 0.002574468, 0.002606061, 0.002635302, 0.002661895, 0.002692126, 0.002722019, 0.002757156, 0.002790119, 0.002821882, 0.002861482, 0.002895574, 0.002925966, 0.00296128, 0.002995106, 0.003030188, 0.003064064, 0.003096956, 0.003135267, 0.00316749, 0.00320432, 0.003245203, 0.003278626, 0.003318474, 0.003360552, 0.003398364, 0.003442344, 0.003482602, 0.003518428, 0.003560865, 0.003600476, 0.00364776, 0.003689881, 0.003736952, 0.003773659, 0.003820946, 0.003868191, 0.003916116, 0.003960839, 0.004008783, 0.00405502, 0.004105684, 0.004152341, 0.004202312, 0.004250609, 0.004308767, 0.00436127, 0.004410807, 0.004466608, 0.004518566, 0.004574437, 0.004625613, 0.004678856, 0.00473719, 0.004790274, 0.004849461, 0.00490517, 0.004961351, 0.005017706, 0.005081629, 0.005141006, 0.005198246, 0.005261217, 0.005320535, 0.005376729, 0.005436226, 0.005504335, 0.005571156, 0.00563334, 0.005699229, 0.005765702, 0.005828585, 0.005900045, 0.005971053, 0.00603885, 0.006101531, 0.006175246, 0.006241269, 0.006316367, 0.006392056, 0.006459509, 0.006531461, 0.006610934, 0.006688643, 0.006768093, 0.006852275, 0.006934984, 0.007016588, 0.00709985, 0.007180721, 0.007267687, 0.007355738, 0.007438997, 0.007526743, 0.007615891, 0.007702029, 0.007790993, 0.007885261, 0.007980859, 0.008074399, 0.0081662, 0.00825876, 0.008350244, 0.008453559, 0.008545673, 0.008645358, 0.008745536, 0.008841583, 0.008943474, 0.009046326, 0.009161898, 0.009268581, 0.009369447, 0.00948275, 0.009594321, 0.009701545, 0.009786526, 0.009810919, 0.009932886, 0.010042471, 0.010158005, 0.010276498, 0.010399671, 0.010525016, 0.010655423, 0.010777088, 0.010899858, 0.011024924, 0.011154067, 0.011280999, 0.011418972, 0.011557075, 0.011691381, 0.011829462, 0.011977053, 0.012109036, 0.012248515, 0.012392418, 0.012531099, 0.012670822, 0.012815535, 0.012960321, 0.013109524, 0.01327079, 0.013430489, 0.013593319, 0.013745128, 0.013914402, 0.014082288, 0.014242725, 0.014418746, 0.014588778, 0.014764624, 0.014943992, 0.015126911, 0.015303778, 0.015491292, 0.015674683, 0.015854716, 0.016044596, 0.016232589, 0.016416438, 0.01660696, 0.016804246, 0.016998376, 0.01718748, 0.017387313, 0.017584097, 0.017791622, 0.017993947, 0.018191053, 0.018386193, 0.018596614, 0.018822394, 0.01904355, 0.019266806, 0.019485516, 0.019702643, 0.019931634, 0.020172852, 0.020402193, 0.020621876, 0.020860086, 0.021098006, 0.021341012, 0.02159309, 0.02183181, 0.022086043, 0.022339586, 0.022605876, 0.022870076, 0.023147278, 0.023407464, 0.023671398, 0.023947395, 0.024231613, 0.024528724, 0.024826582, 0.02512088, 0.025418022, 0.025713575, 0.02601329, 0.026315852, 0.026636527, 0.02694876, 0.027267677, 0.027590679, 0.027913887, 0.028233198, 0.028552432, 0.02887989, 0.029220274, 0.029552872, 0.029898033, 0.030249539, 0.030607352, 0.030977626, 0.031331127, 0.031690849, 0.032050711, 0.032420636, 0.032790499, 0.033170926, 0.033542521, 0.033919157, 0.034302012, 0.034704942, 0.035110674, 0.035514701, 0.035915058, 0.036344273, 0.036773563, 0.037211272, 0.037652678, 0.038094323, 0.038539497, 0.038985772, 0.039432974, 0.039886864, 0.040339293, 0.040809738, 0.041278949, 0.041757134, 0.042252859, 0.042755216, 0.043262101, 0.043769459, 0.044263314, 0.04477855, 0.045297733, 0.045836776, 0.046370891, 0.046925339, 0.047471139, 0.048018869, 0.048595733, 0.049157487, 0.049724819, 0.050299999, 0.050874495, 0.051475952, 0.052070672, 0.052676457, 0.053287066, 0.053895259, 0.054539942, 0.055198054, 0.055858149, 0.056512273, 0.057169618, 0.057848225, 0.058536716, 0.059209824, 0.059897728, 0.060591742, 0.061296905, 0.062010538, 0.062730511, 0.063452818, 0.064191814, 0.064939497, 0.065703122, 0.066471837, 0.06725283, 0.068023069, 0.068797405, 0.069594645, 0.070404827, 0.071231306, 0.072059432, 0.072915402, 0.073791186, 0.074645355, 0.075526652, 0.076415047, 0.077312462, 0.078234166, 0.079150766, 0.08009144, 0.08103014, 0.08197015, 0.082935692, 0.083894165, 0.084865678, 0.085855617, 0.086856573, 0.087858083, 0.088874839, 0.089936314, 0.09099475, 0.092074988, 0.093146084, 0.094232442, 0.095321905, 0.096431373, 0.097547208, 0.098683731, 0.0995933, 0.099827242, 0.100975398, 0.102169037, 0.103356076, 0.104536807, 0.105763944, 0.106992721, 0.10823383, 0.109467507, 0.110769463, 0.112049482, 0.113362463, 0.114691779, 0.116049333, 0.117404465, 0.118787076, 0.120178138, 0.121588725, 0.123002351, 0.124433431, 0.125888464, 0.127349591, 0.12886263, 0.130359566, 0.131879476, 0.133399465, 0.134961313, 0.136538028, 0.138134912, 0.13972864, 0.141356954, 0.142996087, 0.144669832, 0.146350795, 0.14806779, 0.149818764, 0.151601433, 0.153360499, 0.15517908, 0.157014687, 0.158863887, 0.16070761, 0.162632037, 0.164548014, 0.166480385, 0.168425172, 0.170402059, 0.172395882, 0.174397754, 0.176438304, 0.178482295, 0.180570446, 0.182682089, 0.184804149, 0.186970571, 0.189164948, 0.191386359, 0.193642581, 0.195926858, 0.198240751, 0.200573818, 0.20295756, 0.205330883, 0.20774982, 0.210195783, 0.212702065, 0.215243494, 0.217822984, 0.220437537, 0.223044558, 0.225688219, 0.228358542, 0.231091417, 0.233853248, 0.236589112, 0.23948006, 0.242320858, 0.245190393, 0.248104698, 0.251094914, 0.254011376, 0.257050623, 0.26008293, 0.263215915, 0.266343363, 0.269526316, 0.272751899, 0.276023754, 0.279328391, 0.28262111, 0.286027925, 0.289408997, 0.292886668, 0.296383077, 0.299915538, 0.303558732, 0.304350055, 0.307226313, 0.310869675, 0.314593496, 0.318418643, 0.322253257, 0.326109848, 0.330038998, 0.333988443, 0.338064394, 0.342114253, 0.346222409, 0.350377858, 0.354588973, 0.358825423, 0.363089137, 0.367461504, 0.371930349, 0.376420158, 0.380967083, 0.385576181, 0.390247848, 0.394989961, 0.399751512, 0.404570381, 0.40947571, 0.410476221, 0.414475444, 0.419543777, 0.424752874, 0.429919498, 0.435181101, 0.440592749, 0.446040336, 0.451577491, 0.457107021, 0.462729794, 0.468495501, 0.474227251, 0.480103454, 0.486033308, 0.492043301, 0.498187011, 0.504444097, 0.510713081, 0.517072875, 0.523450555, 0.529962788, 0.536523114, 0.543274229, 0.550063019, 0.556955819, 0.563903635, 0.570992353, 0.578218935, 0.585544365, 0.59297132, 0.600401585, 0.607940009, 0.615657963, 0.623461627, 0.631397379, 0.634769974, 0.639499839, 0.647651737, 0.65594429, 0.664349968, 0.672928526, 0.681613398, 0.690483814, 0.699432038, 0.708524233, 0.717775239, 0.727220157, 0.736745298, 0.746360846, 0.756174717, 0.766164844, 0.776270447, 0.78651804, 0.796928869, 0.807600517, 0.818389337, 0.829384088, 0.84057276, 0.851921487, 0.863379215, 0.875087697, 0.879969668, 0.88686926, 0.899024963, 0.911400825, 0.92397949, 0.936771252, 0.949771466, 0.963005956, 0.976471183, 0.99028456, 1.004405345, 1.018659807, 1.033152566, 1.047819452, 1.06286159, 1.078099569, 1.093852635, 1.109915739, 1.126151959, 1.14293514, 1.156339871, 1.186881856, 1.203859696, 1.220860226, 1.237895505, 1.254904049, 1.271748183, 1.288825679, 1.305658144, 1.322448372, 1.33926091, 1.356065386, 1.37281981, 1.389619142, 1.406257522, 1.422980881, 1.43964158, 1.456307746, 1.473011247, 1.482822502, 1.489619808, 1.506135825, 1.522706056, 1.539224926, 1.555671109, 1.572176172, 1.588567986, 1.605056301, 1.621663618, 1.638023335, 1.654470689, 1.670894453, 1.687367434, 1.703879777, 1.720203925, 1.736595851, 1.753210728, 1.769607058, 1.786112273, 1.802470983, 1.818964293, 1.835511418, 1.851846055, 1.868359628, 1.884910383, 1.894402161, 1.901439261, 1.91795232, 1.934425073, 1.950872304, 1.967279343, 1.98375715, 2.000314666, 2.016866647, 2.033374692, 2.050029264, 2.0667086, 2.083248359, 2.100037277, 2.116552293, 2.133213734, 2.149958112, 2.16681886, 2.183579198, 2.20030173, 2.217175763, 2.234041363, 2.250879956, 2.267840196, 2.284537026, 2.301511876, 2.318523307, 2.335614945, 2.352642766, 2.369637843, 2.386780605, 2.403792516, 2.421098927, 2.438281062, 2.455445173, 2.472698794, 2.486527371, 2.490116137, 2.507579938, 2.525086997, 2.542548746, 2.560200833, 2.577756627, 2.5952444, 2.613182459, 2.630930061, 2.648940883, 2.666807427, 2.68458309, 2.702773711, 2.720776831, 2.739101141, 2.757189877, 2.775620497, 2.793740507, 2.811962028, 2.830350294, 2.848667268, 2.86734385, 2.886184052, 2.905064442, 2.923998668, 2.9390101, 2.943150294, 2.962183437, 2.981449704, 3.000642345, 3.019785564, 3.039437625, 3.058808576, 3.078618959, 3.09819757, 3.117819728, 3.137971791, 3.158011877, 3.178108836, 3.198371992, 3.21867403, 3.239156828, 3.259472616, 3.280245722, 3.301006653, 3.321587754, 3.342473633, 3.363725877, 3.384706536, 3.406021878, 3.427498187, 3.4490459, 3.470976187, 3.493322042, 3.515322682, 3.537269369, 3.559674066, 3.582290844, 3.604875953, 3.627348109, 3.650113317, 3.673366422, 3.696355935, 3.719719588, 3.743252029, 3.766870589, 3.790759509, 3.815096527, 3.839198126, 3.864137475, 3.888990564, 3.913846911, 3.938894285, 3.963921946, 3.989399698, 4.015418298, 4.041004099, 4.067597668, 4.093953122, 4.120446698, 4.146746566, 4.173615791, 4.200846986, 4.228095521, 4.255818103, 4.283401868, 4.310979784, 4.338932187, 4.36725408, 4.395586481, 4.424315563, 4.45309492, 4.482248547, 4.512078014, 4.541577692, 4.571499693, 4.601740925, 4.632323419, 4.662621363, 4.693679819, 4.724383488, 4.755875798, 4.787320315, 4.818018431, 4.850051024, 4.88226503, 4.914196953, 4.947380229, 4.980092608, 5.012759349, 5.045516966, 5.078501025, 5.111819227, 5.14501304, 5.178681681, 5.212507995, 5.247319271, 5.282283036, 5.316432459, 5.350616567, 5.38591507, 5.422136026, 5.430013901, 5.458016765, 5.494078735, 5.530486495, 5.56626393, 5.603365913, 5.640652422, 5.67819778, 5.715328843, 5.752699777, 5.79045162, 5.828795686, 5.866844549, 5.904919995, 5.943302877, 5.981175325, 6.020577244, 6.05977389, 6.09913535, 6.138060318, 6.178048443, 6.218006988, 6.258842036, 6.299323312, 6.339544871, 6.380274684, 6.421301103, 6.462368406, 6.50421716, 6.545153761, 6.586910134, 6.628721099, 6.671860275, 6.714431467, 6.75660349, 6.797944366, 6.842502434, 6.886304227, 6.930667363, 6.974141956, 7.017360195, 7.06012585, 7.104143951, 7.148391741, 7.193343667, 7.238369711, 7.28317896, 7.329649126, 7.375239126, 7.42205219, 7.466688907, 7.513390045, 7.560233044, 7.606967616, 7.653934088, 7.699869391, 7.745260637, 7.791972645, 7.839678273, 7.885948262, 7.933502658, 7.982642394, 8.031911489, 8.080226923, 8.130292559, 8.17911969, 8.228802789, 8.280008862, 8.327583392, 8.37816072, 8.426945429, 8.476087274, 8.525621151, 8.574839797, 8.625032565, 8.676859253, 8.7270657, 8.777219274, 8.82837904, 8.879377233, 8.93198319, 8.985064181, 9.037970095, 9.090763669, 9.144516265, 9.198725321, 9.252810474, 9.306190453, 9.359590358, 9.413947581, 9.470020327, 9.527052392, 9.57989044, 9.637771191, 9.693645481, 9.751169323, 9.805102991, 9.860345399, 9.915630897, 9.97369207, 10.029033191, 10.085468924, 10.140804448, 10.200965828, 10.259401641, 10.318475519, 10.376793771, 10.433439016, 10.492886126, 10.552438195, 10.608820264, 10.669812397, 10.728797175, 10.789650196, 10.850379627, 10.911164641, 10.973704381, 11.034539097, 11.093195434, 11.15545639, 11.21665481, 11.28052361, 11.33969023, 11.398303471, 11.459060377, 11.519178731, 11.581238884, 11.646276395, 11.708580212, 11.771354322, 11.836272243, 11.900028293, 11.961386512, 12.02415565, 12.090802651, 12.156212822, 12.220935193, 12.286957066, 12.355897377, 12.424869039, 12.491256977, 12.556353552, 12.621772406, 12.684840513, 12.752043393, 12.821182087, 12.890079436, 12.960909682, 13.024719386, 13.095689738, 13.17066366, 13.239831089, 13.310763255, 13.380822999, 13.451375527, 13.521087914, 13.594217229, 13.663094977, 13.735406222, 13.804844295, 13.872677343, 13.942369059, 14.010505666, 14.079112816, 14.156171216, 14.230128573, 14.304846923, 14.379184671, 14.456513715, 14.525274493, 14.599859838, 14.668405941, 14.741376372, 14.815257393, 14.89474761, 14.971833702, 15.04376377, 15.121781474, 15.200915822, 15.280298555, 15.352393181, 15.423803416, 15.502220507, 15.575922936, 15.654307822, 15.731577348, 15.809738635, 15.891520708, 15.96972721, 16.048772081, 16.123507835, 16.206514044, 16.283690581, 16.36451381, 16.445821935, 16.528591311, 16.610320297, 16.694194111, 16.776453764, 16.859360188, 16.943500651, 16.959063376, 17.021200811, 17.102583791, 17.19044808, 17.278698433, 17.358439571, 17.441968914, 17.528900251, 17.607674487, 17.688603229, 17.768515841, 17.855325113, 17.939175191, 18.029878048, 18.119546085, 18.201567426, 18.292648279, 18.380019316, 18.470153125, 18.559600468, 18.64664327, 18.735775238, 18.825143075, 18.914266356, 19.004073327, 19.096984826, 19.188955469, 19.275383735, 19.358411404, 19.449406902, 19.544713716, 19.630525983, 19.728506745, 19.82155505, 19.913445149, 20.007280735, 20.10484248, 20.20467446, 20.290535362, 20.388370672, 20.488837767, 20.590699927, 20.680168669, 20.781468635, 20.876650999, 20.966538192, 21.066923848, 21.178694831, 21.277648113, 21.382762457, 21.476992422, 21.574151326, 21.67093195, 21.780403148, 21.885141879, 21.979236407, 22.078798678, 22.182662889, 22.277610712, 22.376347003, 22.493111864, 22.593437901, 22.69058174, 22.794010536, 22.897957576, 22.999837422, 23.097414365, 23.199347339, 23.295235547, 23.406345878, 23.514225467, 23.62981113, 23.733972532, 23.83622068, 23.947061613, 24.062921186, 24.166106154, 24.276438763, 24.382758917, 24.492325139, 24.59497256, 24.703451588, 24.814289985, 24.92426164, 25.023657822, 25.13515211, 25.231797518, 25.339956542, 25.44574999, 25.552593312, 25.655126542, 25.767646071, 25.889412838, 25.999314167, 26.097166341, 26.215886485, 26.329591416, 26.434876333, 26.533924839, 26.653775203, 26.772271703, 26.891804262, 26.996351829, 27.129442949, 27.247047921, 27.369408734, 27.487745139, 27.614916255, 27.725308356, 27.836802817, 27.961156175, 28.070080767, 28.183588208, 28.311119443, 28.457562731, 28.575420886, 28.705347625, 28.840105259, 28.972406119, 29.098981419, 29.240005607, 29.353952402, 29.472733182, 29.602242944, 29.733795144, 29.866375751, 30.005439545, 30.133054049, 30.255454259, 30.389615649, 30.546894607, 30.642330982, 30.782051309, 30.93658643, 31.052559249, 31.198850709, 31.322558869, 31.471380506, 31.603979137, 31.72544234, 31.840240515, 31.985575088, 32.132429553, 32.265657367, 32.397182346, 32.521850173, 32.637346198, 32.769717315, 32.916455274, 33.045404394, 33.155448101, 33.28403114, 33.420225367, 33.569068106, 33.689533667, 33.82395603, 33.974557826, 34.104331221, 34.246316628, 34.386700889, 34.521054774, 34.682760996, 34.840849773, 34.957633644, 35.10322806, 35.239181792, 35.382101349, 35.514084069, 35.689628799, 35.83150553, 35.955312228, 36.096927987, 36.221487738, 36.356822395, 36.4763809, 36.62917011, 36.758019074, 36.911300201, 37.050911294, 37.183152376, 37.327622307, 37.466525528, 37.605935682, 37.749499387, 37.898630368, 38.033643277, 38.19092779, 38.375971347, 38.556926783, 38.696651303, 38.859005009, 39.043639208, 39.166149747, 39.313774656, 39.477573985, 39.625851318, 39.79004548, 39.947930284, 40.104762855, 40.22982726, 40.390248198, 40.429995205, 40.574490582, 40.748050125, 40.882094422, 41.020672834, 41.152868447, 41.358357078, 41.542392241, 41.719589136, 41.868949186, 42.030249947, 42.207014222, 42.362719817, 42.493494569, 42.613699879, 42.794910096, 42.983803365, 43.181119885, 43.341931375, 43.482367347, 43.692473268, 43.856660784, 43.987115093, 44.170155022, 44.374097191, 44.614708342, 44.807131236, 44.976003439, 45.125612323, 45.29206216, 45.448121491, 45.664460502, 45.838249671, 46.052650926, 46.208676983, 46.354814605, 46.493016039, 46.698729239, 46.864518739, 47.040453742, 47.250687059, 47.467711579, 47.644895878, 47.805933814, 48.008390469, 48.193214281, 48.336504316, 48.569059034, 48.722984792, 48.868317633, 49.045908322, 49.20577429, 49.368452121, 49.54178601, 49.776224491, 49.943205013, 50.160651053, 50.374419997, 50.563856656, 50.742178854, 50.930718463, 51.181323257, 51.342513377, 51.553318429, 51.765256457, 51.920671565, 52.136050864, 52.420457304, 52.549390616, 52.732572244, 52.940375574, 53.175574234, 53.389374086, 53.639780113, 53.822946793, 54.013939091, 54.18552773, 54.413064283, 54.553025502, 54.7274191, 54.940184147, 55.22585911, 55.382498294, 55.606066051, 55.75400631, 56.003101637, 56.209772696, 56.375454098, 56.547715023, 56.840923037, 57.014667061, 57.21297409, 57.408869512, 57.643609796, 57.84090301, 58.027265296, 58.263302623, 58.436553217, 58.618149965, 58.966297802, 59.216261903, 59.388679182, 59.631547824, 59.786333547, 59.929726319, 60.25588042, 60.482343125, 60.647192103, 60.842144648, 61.009536075, 61.22706126, 61.390499036, 61.568693499, 61.715428997, 62.011624773, 62.173440544, 62.427808782, 62.723659699, 62.928446544, 63.206595094, 63.463151485, 63.631145815, 63.813464004, 64.06230361, 64.227632067, 64.434075518, 64.711771639, 64.814283959, 64.982411312, 65.223856116, 65.584715844, 65.895664247, 66.164664316, 66.473435547, 66.69057511, 66.902991511, 67.068492794, 67.178923649, 67.486222539, 67.739891093, 68.031682592, 68.295234532, 68.471388235, 68.729551489, 68.904310088, 69.050840007, 69.243240404, 69.552693348, 69.735247484, 70.031229944, 70.415384293, 70.62426677, 70.78612381, 71.09006887, 71.345737201, 71.575888487, 71.746413144, 71.91680912, 72.101848831, 72.33307302, 72.46407485, 72.750530822, 72.991064102, 73.198649779, 73.315167541, 73.525982376, 73.665188495, 73.932091378, 74.066201909, 74.34601789, 74.585570188, 74.844896049, 75.018144794, 75.276530586, 75.442334375, 75.650678888, 76.086573621, 76.421626812, 76.763048913, 76.878500909, 76.996163783, 77.454951235, 77.627688589, 77.810469312, 78.165746475, 78.423740174, 78.654668466, 78.807962921, 79.116997279, 79.494288592, 79.846985486, 79.94463211, 80.338343816, 80.890953582, 81.123999444, 81.378086177, 81.648523841, 81.914838547, 82.159496175, 82.430691783, 82.777696792, 82.949558673, 83.508922841, 83.757115676, 83.914843051, 84.067801761, 84.167003793, 84.491795055, 84.676207138, 84.797461176, 85.048513174, 85.31743068, 85.468104826, 85.584192839, 85.793370652, 86.378376148, 86.887814755, 87.076988215, 87.29379477, 87.558841731, 88.189459906, 88.681822474, 88.958612062, 89.093633613, 89.299184416, 89.457458072, 89.81429918, 89.992189951, 90.200241424, 90.558764827, 90.909224696, 91.076723584, 91.360612969, 91.549382195, 91.768541045, 92.093095109, 92.362422978, 92.728440534, 92.968600798, 93.135484586, 93.512125227, 93.541457739, 93.900895311, 94.397608426, 94.546552378, 95.0077362, 95.347642911, 95.520700093, 96.110169384, 96.579173056, 97.087215736, 97.319315911, 97.6425654, 98.043919817, 98.219700571, 98.644221752, 98.959413669, 99.055218864, 99.33465987, 99.635709985, 100.187036999, 100.470373636, 100.721818452, 101.13885527, 101.502008151, 101.579829438, 102.162832984, 102.649431653, 103.082088613, 103.172853308, 103.280575482, 103.906497463, 104.294613095, 104.838589885, 105.003941502, 105.363634529, 105.558222606, 105.633229226, 105.863056616, 105.904711951, 106.263499197, 106.658475248, 106.768153111, 106.980548714, 107.332972858, 107.652033155, 107.988911218, 108.099169384, 108.253350292, 108.47652369, 108.605350246, 108.717487114, 109.006689741, 109.09121673, 109.335211685, 110.054657079, 110.188993107, 110.465654479, 110.53071703, 110.561634229, 111.30601108, 111.490988751, 111.85551994, 112.083124523, 112.914061873, 113.05544306, 113.319876123, 113.973685115, 113.990448239, 114.081532341, 114.398558877, 115.77304705, 116.126972557, 116.78344432, 116.843528542, 117.007980322, 117.035696543, 117.291383217, 117.446935054, 118.599175228, 119.09083066, 119.645537452, 119.723223718, 119.773566937, 119.871727805, 119.980721889, 120.463670909, 120.483280294, 120.827560431, 121.38938072, 121.926571322, 121.953680074, 121.956647797, 122.239692568, 122.404241886, 122.534630835, 122.921589103, 123.270801841, 123.93386657, 124.042245016, 124.690620322), "150" = c(1.9193e-05, 1.9534e-05, 1.9671e-05, 2.0084e-05, 2.021e-05, 2.0636e-05, 2.0807e-05, 2.0835e-05, 2.0981e-05, 2.146e-05, 2.1652e-05, 2.195e-05, 2.2011e-05, 2.2235e-05, 2.2336e-05, 2.2844e-05, 2.3186e-05, 2.3862e-05, 2.4049e-05, 2.4171e-05, 2.4402e-05, 2.4434e-05, 2.4645e-05, 2.5134e-05, 2.5538e-05, 2.5564e-05, 2.577e-05, 2.62e-05, 2.7058e-05, 2.7306e-05, 2.772e-05, 2.7849e-05, 2.8072e-05, 2.8329e-05, 2.861e-05, 2.8887e-05, 2.8895e-05, 2.9126e-05, 2.9324e-05, 2.9829e-05, 2.9865e-05, 3.0045e-05, 3.0236e-05, 3.0454e-05, 3.0778e-05, 3.1326e-05, 3.1539e-05, 3.1752e-05, 3.274e-05, 3.2894e-05, 3.3271e-05, 3.3461e-05, 3.3726e-05, 3.3987e-05, 3.472e-05, 3.5436e-05, 3.6077e-05, 3.6334e-05, 3.6574e-05, 3.6889e-05, 3.7535e-05, 3.7732e-05, 3.8173e-05, 3.869e-05, 3.9021e-05, 3.9609e-05, 3.9951e-05, 4.0102e-05, 4.1255e-05, 4.1421e-05, 4.1948e-05, 4.1983e-05, 4.2623e-05, 4.2773e-05, 4.2841e-05, 4.3289e-05, 4.3387e-05, 4.4053e-05, 4.4967e-05, 4.5979e-05, 4.6536e-05, 4.7625e-05, 4.8037e-05, 4.8141e-05, 4.8561e-05, 4.8893e-05, 4.9147e-05, 4.9754e-05, 4.9843e-05, 5.0666e-05, 5.1489e-05, 5.1695e-05, 5.2081e-05, 5.2574e-05, 5.3442e-05, 5.4403e-05, 5.4541e-05, 5.5237e-05, 5.5911e-05, 5.6737e-05, 5.7154e-05, 5.7583e-05, 5.8232e-05, 5.911e-05, 5.9854e-05, 6.0645e-05, 6.1105e-05, 6.2254e-05, 6.2764e-05, 6.3324e-05, 6.5343e-05, 6.6388e-05, 6.7192e-05, 6.7646e-05, 6.8932e-05, 6.9523e-05, 7.0198e-05, 7.0929e-05, 7.1466e-05, 7.213e-05, 7.2662e-05, 7.3679e-05, 7.421e-05, 7.506e-05, 7.5529e-05, 7.7139e-05, 7.8697e-05, 8.0818e-05, 8.2196e-05, 8.3085e-05, 8.4564e-05, 8.6169e-05, 8.751e-05, 8.8953e-05, 9.0361e-05, 9.1374e-05, 9.3146e-05, 9.3997e-05, 9.4567e-05, 9.5194e-05, 9.6302e-05, 9.7876e-05, 9.8466e-05, 9.9914e-05, 0.000100784, 0.000101322, 0.000102788, 0.000104147, 0.000106005, 0.000107282, 0.000108107, 0.000108975, 0.000110487, 0.000111871, 0.000112722, 0.000113746, 0.000114692, 0.00011608, 0.000116734, 0.000117664, 0.000118927, 0.000120358, 0.000121591, 0.000123532, 0.000125331, 0.00012686, 0.000128105, 0.000130109, 0.000132031, 0.00013369, 0.000134459, 0.000136028, 0.000138122, 0.000140526, 0.000142118, 0.000143348, 0.000145554, 0.000146727, 0.000148462, 0.000149742, 0.000150622, 0.00015177, 0.000153408, 0.000155541, 0.000157515, 0.000158895, 0.000161397, 0.000162646, 0.00016443, 0.000167144, 0.000169034, 0.000170997, 0.000172983, 0.000174226, 0.000175853, 0.000177872, 0.000179625, 0.000181604, 0.000184599, 0.000187262, 0.00018852, 0.000190828, 0.000192961, 0.00019542, 0.000196697, 0.000198948, 0.00020098, 0.000203465, 0.000205849, 0.000208268, 0.000210757, 0.000213404, 0.000215794, 0.000217388, 0.00022002, 0.000222179, 0.000225238, 0.000228063, 0.000230462, 0.000232855, 0.000235018, 0.000238782, 0.000240878, 0.000243928, 0.000246828, 0.000249956, 0.000252669, 0.000255538, 0.000258651, 0.000262776, 0.0002652, 0.000269441, 0.000272517, 0.000275902, 0.000278955, 0.000282513, 0.000286983, 0.000289904, 0.00029402, 0.000297814, 0.000300545, 0.000303462, 0.000306574, 0.000309958, 0.000313408, 0.000318715, 0.000323306, 0.00032535, 0.000329429, 0.000333873, 0.00033791, 0.00034114, 0.000345414, 0.000348628, 0.000352788, 0.00035724, 0.000362122, 0.000369308, 0.000373351, 0.000377817, 0.000382768, 0.000387126, 0.000391953, 0.000396849, 0.000401235, 0.000406611, 0.000412291, 0.000416487, 0.000419929, 0.000422842, 0.000428191, 0.000432475, 0.000436144, 0.00044213, 0.000447618, 0.000452392, 0.00045636, 0.000461904, 0.000467889, 0.000472916, 0.000477638, 0.000483113, 0.000489571, 0.000494953, 0.000501393, 0.000508688, 0.0005143, 0.000520005, 0.000525976, 0.000532358, 0.000540965, 0.00054878, 0.000554964, 0.00056093, 0.00056624, 0.000573386, 0.000580353, 0.000587579, 0.000594003, 0.000601605, 0.000610537, 0.000619026, 0.000625511, 0.000630155, 0.000636432, 0.000643337, 0.000648177, 0.000654898, 0.000662225, 0.000669399, 0.000676584, 0.000682966, 0.000690274, 0.000698852, 0.000706268, 0.000714553, 0.000724433, 0.000733288, 0.000741847, 0.000749472, 0.000757811, 0.000768654, 0.00077619, 0.000784174, 0.000797267, 0.000806705, 0.000816472, 0.00082639, 0.000837006, 0.000847608, 0.000858824, 0.000867792, 0.000877246, 0.000888657, 0.00089834, 0.000908524, 0.000919027, 0.000929917, 0.000940886, 0.000952286, 0.000962011, 0.000963912, 0.00097231, 0.00098131, 0.00099253, 0.001006106, 0.001020808, 0.001031191, 0.001043435, 0.001055399, 0.001066656, 0.001078003, 0.001088791, 0.001100852, 0.001116485, 0.00112754, 0.001140746, 0.00115572, 0.001169727, 0.00118503, 0.001198622, 0.001213586, 0.001224986, 0.001238795, 0.001250751, 0.001266422, 0.001280909, 0.001295769, 0.001309211, 0.001325859, 0.001343183, 0.001361506, 0.001375751, 0.001393051, 0.00141036, 0.001424626, 0.001440359, 0.001456627, 0.001476699, 0.001494511, 0.001513041, 0.001529335, 0.001547246, 0.001564226, 0.001588438, 0.001607157, 0.001624635, 0.001641001, 0.001662892, 0.001683322, 0.001702767, 0.001722895, 0.0017433, 0.00176189, 0.001784488, 0.001806122, 0.001827149, 0.001848395, 0.001872289, 0.001895292, 0.001916636, 0.001938777, 0.001959824, 0.001983709, 0.002006206, 0.002031265, 0.002053079, 0.002075256, 0.002096427, 0.002121656, 0.002150753, 0.002172669, 0.002198683, 0.002224995, 0.00225116, 0.002277903, 0.002299134, 0.002327301, 0.002352515, 0.002381546, 0.002409102, 0.002434976, 0.002461098, 0.0024917, 0.002519169, 0.002548491, 0.002574778, 0.002601063, 0.002632185, 0.002661109, 0.002695526, 0.002725712, 0.002759828, 0.002792948, 0.002824539, 0.002855699, 0.002887665, 0.002920797, 0.002953643, 0.002985262, 0.003025827, 0.003059289, 0.003093544, 0.003122492, 0.003157946, 0.003198171, 0.003238202, 0.003279517, 0.003322865, 0.003361008, 0.003398997, 0.003437128, 0.003475622, 0.003522534, 0.003556426, 0.003600314, 0.003642897, 0.003684975, 0.003729244, 0.003773638, 0.003812298, 0.003858262, 0.003905639, 0.003951276, 0.004000282, 0.004043139, 0.004096763, 0.004141174, 0.004192723, 0.00424513, 0.004293365, 0.004342762, 0.004393417, 0.004446093, 0.004493345, 0.004543036, 0.004596672, 0.00465577, 0.004711926, 0.004765578, 0.004820924, 0.004872585, 0.004930272, 0.004991704, 0.005051696, 0.00510741, 0.005167392, 0.00521966, 0.005284319, 0.005345782, 0.005404653, 0.005465697, 0.005528437, 0.005590563, 0.005658574, 0.005729979, 0.005799646, 0.005861727, 0.005929744, 0.006000484, 0.006075155, 0.006143664, 0.006210694, 0.006291906, 0.006361045, 0.006427652, 0.006498796, 0.006567852, 0.006643361, 0.006723564, 0.006800252, 0.006881885, 0.006971335, 0.007055518, 0.007138388, 0.00722363, 0.007308893, 0.007393707, 0.007476401, 0.007560889, 0.00764911, 0.007734609, 0.007832379, 0.007925015, 0.008024576, 0.008116677, 0.008215776, 0.008311802, 0.008410011, 0.008505267, 0.00860959, 0.00872122, 0.008826544, 0.008934385, 0.009038548, 0.0091452, 0.009262766, 0.009358389, 0.009464333, 0.009571874, 0.00968462, 0.009781088, 0.009800264, 0.009913899, 0.010030528, 0.010152605, 0.010268983, 0.010379763, 0.010501031, 0.010620926, 0.010741641, 0.010863561, 0.010991892, 0.011124946, 0.011261152, 0.011388096, 0.011524197, 0.011653015, 0.011793514, 0.011924286, 0.012067768, 0.012209084, 0.012349825, 0.012487791, 0.012632293, 0.012775675, 0.012933315, 0.013081562, 0.013230175, 0.013377804, 0.013529135, 0.013682885, 0.013847089, 0.014009601, 0.014170134, 0.014326938, 0.014495826, 0.014662663, 0.014838345, 0.015012568, 0.015180777, 0.015370509, 0.015550354, 0.015723164, 0.015905868, 0.016101772, 0.016296343, 0.016481016, 0.016675623, 0.01686963, 0.017066386, 0.017269545, 0.017466252, 0.017662553, 0.017852518, 0.018071317, 0.018278422, 0.018493621, 0.018709198, 0.018942724, 0.019154161, 0.019386807, 0.019606501, 0.019827563, 0.020062558, 0.020297526, 0.020530571, 0.020785934, 0.02102465, 0.021277045, 0.021517801, 0.021765457, 0.022036606, 0.022297734, 0.022554872, 0.022821922, 0.023093035, 0.023361845, 0.02362273, 0.023897726, 0.024167289, 0.024451412, 0.02473992, 0.02502249, 0.025319004, 0.025613555, 0.025912291, 0.026206372, 0.026507749, 0.026823907, 0.027144512, 0.027457266, 0.027766267, 0.028084779, 0.02841267, 0.028740019, 0.029069963, 0.029415573, 0.029740616, 0.030081189, 0.030428629, 0.030771617, 0.031122218, 0.031488884, 0.031855667, 0.03223248, 0.032612153, 0.03299113, 0.033365557, 0.033748549, 0.034137852, 0.0345204, 0.034912558, 0.035325096, 0.035740974, 0.036154227, 0.036568503, 0.036980524, 0.037395275, 0.037823129, 0.038273427, 0.038734396, 0.039186039, 0.039647387, 0.040115879, 0.040584245, 0.041060628, 0.04153671, 0.042026336, 0.042512805, 0.043016297, 0.043513623, 0.044020073, 0.044534623, 0.045044403, 0.04557793, 0.04611233, 0.046652778, 0.047213951, 0.047771452, 0.04833759, 0.04889839, 0.049475416, 0.050054063, 0.050650879, 0.051239675, 0.051824633, 0.052434897, 0.053039201, 0.053660115, 0.054270739, 0.054899867, 0.055529376, 0.056179656, 0.056847262, 0.057506689, 0.058178509, 0.058862007, 0.059545235, 0.060256048, 0.060952426, 0.061659312, 0.062373148, 0.06310494, 0.063832408, 0.064593336, 0.065363, 0.066136469, 0.066903439, 0.067691548, 0.068460885, 0.069272333, 0.070070673, 0.070900305, 0.071735613, 0.072558102, 0.073400094, 0.074258292, 0.075118721, 0.075996066, 0.076872782, 0.077773792, 0.078689172, 0.079608134, 0.080565914, 0.081515848, 0.082477758, 0.083445334, 0.084428006, 0.085440693, 0.08641772, 0.08742783, 0.088457596, 0.089527989, 0.09060016, 0.091642089, 0.092713407, 0.093816686, 0.094915618, 0.096024909, 0.097150816, 0.098278833, 0.099187494, 0.099420311, 0.100582466, 0.101791508, 0.103004986, 0.104238096, 0.105458942, 0.10671353, 0.107990265, 0.109281144, 0.110577412, 0.111919051, 0.113229859, 0.114539162, 0.115864351, 0.117242568, 0.118649068, 0.120039215, 0.121469304, 0.122903444, 0.124340647, 0.125800706, 0.127271154, 0.128754539, 0.130248399, 0.131788609, 0.133342899, 0.134912288, 0.136511893, 0.138138454, 0.139767533, 0.141442106, 0.143129121, 0.144835517, 0.146541167, 0.148248259, 0.149993595, 0.151753862, 0.153527447, 0.155378543, 0.157203852, 0.15907916, 0.1609826, 0.162879598, 0.164837943, 0.166800259, 0.168765308, 0.170794735, 0.172827461, 0.174875354, 0.17695226, 0.179081717, 0.181183364, 0.183334191, 0.185522116, 0.187744112, 0.189985164, 0.192214979, 0.194537345, 0.196840449, 0.199165841, 0.20156766, 0.20394501, 0.206359712, 0.208804865, 0.211316948, 0.213848944, 0.216424469, 0.219003041, 0.22163557, 0.22428433, 0.226976241, 0.229722482, 0.232512107, 0.235349671, 0.238158856, 0.241016354, 0.243914491, 0.246839054, 0.249769372, 0.252757062, 0.255770887, 0.258868539, 0.262012054, 0.265175421, 0.268380125, 0.271561593, 0.274840476, 0.278136381, 0.281479014, 0.284886925, 0.288363812, 0.291865211, 0.295435179, 0.299040808, 0.30261804, 0.306282524, 0.307106446, 0.310035419, 0.31375252, 0.317579034, 0.321415111, 0.325313513, 0.329335962, 0.333376713, 0.337431078, 0.341590916, 0.345788637, 0.350066005, 0.354400109, 0.358760477, 0.3631647, 0.367616163, 0.372151259, 0.37678165, 0.381416717, 0.386112466, 0.390876073, 0.39573402, 0.400637315, 0.405558728, 0.410558776, 0.415716074, 0.41675326, 0.420926539, 0.426192632, 0.431489381, 0.436835342, 0.442309107, 0.447786878, 0.453408541, 0.459151699, 0.464972806, 0.470776258, 0.476688303, 0.482683549, 0.48876739, 0.494923197, 0.501183456, 0.507603271, 0.514089741, 0.52063015, 0.527284328, 0.533965017, 0.540747284, 0.547654126, 0.554659915, 0.561747843, 0.568962194, 0.576231779, 0.583695213, 0.591271605, 0.598856913, 0.606550178, 0.614493165, 0.622544482, 0.630603408, 0.638847842, 0.647153934, 0.650758903, 0.655644563, 0.664252633, 0.673113214, 0.682002676, 0.690925119, 0.700102624, 0.709404192, 0.718903971, 0.728493696, 0.738213392, 0.748166759, 0.75815161, 0.768379541, 0.778804325, 0.789329795, 0.800090646, 0.81101207, 0.822091389, 0.833410635, 0.844869067, 0.856544944, 0.868448969, 0.880484751, 0.892731139, 0.905266124, 0.910512581, 0.917994341, 0.930900377, 0.944004477, 0.95725869, 0.971094652, 0.985034839, 0.999274465, 1.013748179, 1.028496444, 1.043504595, 1.058766383, 1.074362437, 1.090259424, 1.106479318, 1.123159991, 1.140002372, 1.157260429, 1.174864227, 1.192910943, 1.207578175, 1.240841278, 1.259211974, 1.277645082, 1.296094854, 1.314593943, 1.332868827, 1.351269936, 1.369512745, 1.387736524, 1.405960949, 1.424102732, 1.442431967, 1.46054306, 1.478661172, 1.496975553, 1.515113864, 1.533282444, 1.55124911, 1.561859847, 1.569334058, 1.587493623, 1.605454128, 1.623517221, 1.641622116, 1.659689521, 1.677621102, 1.695592187, 1.713396299, 1.73131183, 1.749206058, 1.767204558, 1.785148605, 1.80308047, 1.821244439, 1.839091394, 1.857137512, 1.875047997, 1.893062659, 1.910909754, 1.928944302, 1.946796762, 1.964785984, 1.982866742, 2.000825882, 2.011237075, 2.018865858, 2.03696872, 2.054973477, 2.073051003, 2.090998958, 2.108964087, 2.127146655, 2.145056429, 2.163159385, 2.181209698, 2.199508475, 2.217511699, 2.235612899, 2.253841889, 2.272138178, 2.290177541, 2.308377614, 2.326563586, 2.345132829, 2.363106448, 2.381290948, 2.399713124, 2.418071714, 2.436577696, 2.454945637, 2.473480023, 2.491883653, 2.510505791, 2.52901689, 2.547629814, 2.566081841, 2.584828533, 2.603365165, 2.622088871, 2.640703422, 2.655831769, 2.65981593, 2.678520915, 2.697518612, 2.716443611, 2.735496865, 2.754403211, 2.773623831, 2.792480822, 2.811560258, 2.830807396, 2.850045562, 2.869357298, 2.888643831, 2.908001201, 2.927437339, 2.946849542, 2.966481853, 2.986332364, 3.006053046, 3.025930198, 3.045817694, 3.06561017, 3.085613199, 3.105773008, 3.126007607, 3.14158016, 3.145934267, 3.166043322, 3.186483507, 3.207028467, 3.22760423, 3.247933277, 3.268428601, 3.288863601, 3.309617496, 3.330269307, 3.351458233, 3.372486851, 3.393619671, 3.414592513, 3.435666829, 3.457183712, 3.478217298, 3.499715354, 3.521251843, 3.542747873, 3.564545085, 3.586393267, 3.608061361, 3.630009467, 3.652116667, 3.67448017, 3.697060042, 3.719304345, 3.741944503, 3.764493639, 3.787439119, 3.810593076, 3.833436763, 3.857045589, 3.88085924, 3.904050632, 3.927678843, 3.951541294, 3.975164197, 3.998545803, 4.022410205, 4.046608818, 4.070666747, 4.094966776, 4.119364576, 4.144408409, 4.169368307, 4.194275591, 4.219314565, 4.244418621, 4.26982254, 4.295831205, 4.321497494, 4.347507952, 4.373192091, 4.399472713, 4.426167696, 4.452547566, 4.479274374, 4.505847816, 4.532807886, 4.559787862, 4.586744347, 4.614203063, 4.641851944, 4.669654904, 4.697860379, 4.726506128, 4.754877485, 4.783591543, 4.812553929, 4.841015454, 4.870784077, 4.899588477, 4.929850032, 4.958820097, 4.988868012, 5.019171499, 5.049264536, 5.079991369, 5.110468345, 5.141342273, 5.171769818, 5.202206148, 5.233531981, 5.265618989, 5.297424239, 5.329230952, 5.360388887, 5.392228974, 5.424302158, 5.457522997, 5.491318085, 5.524333854, 5.557793022, 5.591523044, 5.598425631, 5.625734834, 5.658909726, 5.692757032, 5.727708263, 5.76166739, 5.796059579, 5.830977458, 5.865891724, 5.901308015, 5.937181847, 5.973204332, 6.010197381, 6.046937261, 6.083377107, 6.120733855, 6.157543942, 6.195180617, 6.2319279, 6.268986265, 6.306535109, 6.344015798, 6.382819265, 6.421005234, 6.458883677, 6.496851871, 6.535821227, 6.574697541, 6.614502046, 6.653713176, 6.692404876, 6.73201565, 6.771502178, 6.811218201, 6.851336596, 6.892001377, 6.932095888, 6.97238859, 7.012197977, 7.053538929, 7.094922724, 7.135954971, 7.176082519, 7.21771982, 7.260138193, 7.302339997, 7.344436251, 7.387617176, 7.43073194, 7.472824681, 7.515289797, 7.558262196, 7.601229875, 7.644646291, 7.687549549, 7.731370237, 7.774633592, 7.819111591, 7.865362892, 7.908788589, 7.954824546, 8.00066184, 8.044969175, 8.091133069, 8.136581712, 8.181536939, 8.227849567, 8.273726489, 8.319949825, 8.367493151, 8.4147022, 8.462173776, 8.508938083, 8.55596717, 8.603684733, 8.65010308, 8.698290082, 8.745906215, 8.794144664, 8.842579227, 8.889973626, 8.937911795, 8.985965651, 9.034541751, 9.083400256, 9.132448391, 9.183641306, 9.233959793, 9.283475445, 9.332690501, 9.383477436, 9.434459243, 9.485131109, 9.53481109, 9.587020669, 9.636661988, 9.688625334, 9.74266181, 9.795485958, 9.847715312, 9.90100803, 9.954426896, 10.007044448, 10.060935169, 10.112845372, 10.165694834, 10.221635042, 10.274407151, 10.330138998, 10.384968517, 10.439436598, 10.495150245, 10.547223369, 10.601883674, 10.657423564, 10.714481752, 10.771604933, 10.827777792, 10.885914812, 10.941468882, 10.99628954, 11.052805569, 11.109586424, 11.169039554, 11.22540992, 11.283923167, 11.341493936, 11.398869817, 11.458448471, 11.517512311, 11.578094655, 11.637737748, 11.701115376, 11.760177398, 11.817682037, 11.876779282, 11.940457563, 11.998711092, 12.061251096, 12.123778137, 12.184532726, 12.243814892, 12.302404319, 12.366713319, 12.428273553, 12.489180737, 12.552285205, 12.614765471, 12.677802435, 12.741160533, 12.809990855, 12.876094097, 12.938700239, 13.005779667, 13.066810907, 13.132736534, 13.199271635, 13.263744061, 13.32547144, 13.38391306, 13.450964184, 13.515363931, 13.581827668, 13.647839277, 13.712560158, 13.776889488, 13.840654788, 13.904795712, 13.971390706, 14.037754614, 14.107264275, 14.177320382, 14.244277134, 14.315640702, 14.384747115, 14.451313616, 14.5207973, 14.592605489, 14.664770464, 14.735624382, 14.805895681, 14.880254811, 14.945643777, 15.015262426, 15.085064045, 15.156959713, 15.227818712, 15.298104463, 15.369893791, 15.436868805, 15.507064262, 15.583067445, 15.654311193, 15.728950203, 15.80077509, 15.874988042, 15.948747045, 16.0235222, 16.095675681, 16.169648772, 16.243664433, 16.257339341, 16.317876403, 16.393160185, 16.468323053, 16.549778793, 16.626672539, 16.704644232, 16.776084483, 16.850112888, 16.930944935, 17.006474709, 17.081800912, 17.157966859, 17.229967853, 17.311836774, 17.389505987, 17.464962448, 17.546944343, 17.619973874, 17.700473539, 17.781341025, 17.858531688, 17.939067883, 18.024300308, 18.108656892, 18.191702682, 18.275086484, 18.352289545, 18.435181201, 18.524213051, 18.606939533, 18.685845248, 18.779862628, 18.863677213, 18.942022897, 19.025344441, 19.113593468, 19.197976555, 19.282599711, 19.374818987, 19.455568787, 19.533865758, 19.625977466, 19.720134555, 19.80574557, 19.893856934, 19.980698312, 20.067676503, 20.157429462, 20.244480368, 20.329013717, 20.423460187, 20.515533314, 20.600505761, 20.677854194, 20.768568819, 20.862126693, 20.958305171, 21.03848757, 21.132206496, 21.218750879, 21.311443904, 21.400140478, 21.491405387, 21.584982012, 21.674882226, 21.772470134, 21.863813054, 21.960204743, 22.051875636, 22.144432777, 22.23665683, 22.334864406, 22.426668267, 22.521643962, 22.621333141, 22.719555619, 22.814302449, 22.904381999, 23.001590312, 23.09847899, 23.201154631, 23.292505139, 23.388805432, 23.480959657, 23.576356811, 23.676602655, 23.783607639, 23.874069358, 23.967784844, 24.065441693, 24.158248717, 24.271860009, 24.370945243, 24.464432081, 24.566975008, 24.680454748, 24.785918963, 24.886283143, 24.98765474, 25.081872053, 25.182738473, 25.29146074, 25.397597801, 25.510729163, 25.608929437, 25.714580843, 25.814945869, 25.923586724, 26.02385449, 26.128717324, 26.233394097, 26.347242555, 26.467502606, 26.58260024, 26.687726885, 26.791725101, 26.904794744, 27.005105467, 27.113556901, 27.230678889, 27.349422187, 27.472205265, 27.561775946, 27.675891458, 27.785407669, 27.905471748, 28.010743662, 28.119024351, 28.255959681, 28.366090776, 28.482690233, 28.593011554, 28.716137483, 28.848379789, 28.975609339, 29.09385115, 29.211511458, 29.322036341, 29.415416667, 29.546466952, 29.65675494, 29.774657616, 29.886013247, 30.013423337, 30.14877344, 30.262237238, 30.378875971, 30.502977191, 30.628946141, 30.750722187, 30.886540971, 30.996387278, 31.120769126, 31.231314254, 31.339916013, 31.474591113, 31.590275955, 31.713695285, 31.840412468, 31.958906487, 32.102335117, 32.220223108, 32.343764908, 32.494308237, 32.609088521, 32.750298078, 32.876956888, 33.004183315, 33.131028725, 33.265847583, 33.396736384, 33.532507857, 33.655499601, 33.792053151, 33.915559787, 34.053293363, 34.177517493, 34.296060601, 34.409175231, 34.525612732, 34.651971598, 34.764349063, 34.906524935, 35.054959728, 35.168178884, 35.300789348, 35.445425755, 35.585649861, 35.736789529, 35.852639323, 35.98090706, 36.121875635, 36.263500075, 36.400733612, 36.531761255, 36.639308143, 36.777941495, 36.90182676, 37.037841575, 37.198271369, 37.22901798, 37.335559798, 37.468358337, 37.610661041, 37.769280933, 37.950721892, 38.092929641, 38.234208768, 38.383413743, 38.548374369, 38.737128435, 38.884400974, 39.007842805, 39.117816833, 39.275036867, 39.436016798, 39.569855577, 39.753562278, 39.894173615, 40.052141688, 40.197149277, 40.388271955, 40.559939015, 40.669375515, 40.797054919, 40.942912505, 41.081039362, 41.235980577, 41.440599026, 41.570372808, 41.699385289, 41.832218177, 42.036006436, 42.179679553, 42.312449292, 42.446518419, 42.554894099, 42.695581178, 42.839869293, 42.992265095, 43.184195284, 43.339267045, 43.534362779, 43.639664105, 43.847321239, 43.983286668, 44.164412317, 44.354121117, 44.486164651, 44.667488984, 44.850350056, 45.010677476, 45.189950518, 45.340804719, 45.48955214, 45.669503811, 45.804299097, 45.970491386, 46.135609929, 46.260547811, 46.413035595, 46.61358044, 46.769199621, 46.95246609, 47.131562272, 47.280695703, 47.497928232, 47.671171505, 47.889778575, 48.057502992, 48.234766832, 48.379218539, 48.565833182, 48.70567038, 48.870711034, 49.034019268, 49.177575848, 49.446025513, 49.612925262, 49.805942923, 49.982022903, 50.230642697, 50.340802047, 50.527499932, 50.771769796, 50.912891957, 51.038929197, 51.184278055, 51.401579737, 51.580680264, 51.784200598, 51.930963587, 52.136288202, 52.340244245, 52.602457265, 52.826510571, 52.986701042, 53.166320573, 53.383225657, 53.513199748, 53.649661551, 53.844702233, 53.96133613, 54.101749437, 54.293453338, 54.498870653, 54.665547263, 54.791093403, 54.981203998, 55.174070122, 55.362409273, 55.576022497, 55.753879821, 55.868892737, 56.091871014, 56.242341216, 56.407749711, 56.52812885, 56.752497145, 56.959774428, 57.162513689, 57.316468389, 57.583588663, 57.751220218, 57.915950567, 58.111399044, 58.28025624, 58.3902017, 58.497702912, 58.715699062, 58.857102961, 59.057395559, 59.192871098, 59.365282328, 59.562288977, 59.709311559, 59.842923359, 60.060075784, 60.272861935, 60.432897458, 60.631825351, 60.780589145, 60.992930951, 61.30412323, 61.450269426, 61.589072139, 61.793443891, 61.993289019, 62.253216764, 62.38098701, 62.558077175, 62.858267142, 63.074169051, 63.249609061, 63.480668105, 63.763053696, 63.915814957, 64.133541183, 64.278247957, 64.421123154, 64.649828542, 64.694016207, 64.988496983, 65.127175486, 65.377450944, 65.642996175, 65.946463587, 66.189972953, 66.520650604, 66.622843776, 66.888118239, 67.117986059, 67.309833198, 67.623881065, 67.78697905, 68.063651458, 68.228142629, 68.506904902, 68.881425478, 69.153881373, 69.403622289, 69.550640287, 69.771972477, 69.966364723, 70.13595541, 70.372163008, 70.544781289, 70.911449354, 71.200924947, 71.43720875, 71.709039094, 72.072473156, 72.323387824, 72.570032622, 72.647190917, 72.92881354, 73.066667909, 73.208541723, 73.333393021, 73.629027484, 73.731324616, 73.946356107, 74.101281763, 74.462514843, 74.787408219, 75.171897598, 75.315913989, 75.671437978, 75.950215589, 76.284551853, 76.471897841, 76.606903611, 76.831762389, 77.592199984, 78.000089549, 78.348821347, 78.656252111, 78.864176574, 79.019745478, 79.169669205, 79.281759119, 79.383652176, 79.494247908, 79.625321656, 79.898881087, 80.098771763, 80.359679107, 80.534539039, 80.682389987, 80.827975463, 81.004162573, 81.299820867, 81.618379727, 81.838967704, 82.121672746, 82.295120837, 82.490611998, 82.619174098, 82.839030097, 82.932714321, 83.265248031, 83.501864961, 84.210345804, 84.791009168, 84.975345793, 85.192444544, 85.441976295, 85.65366605, 85.930748497, 86.285808882, 86.430963019, 86.691728745, 87.184743401, 87.325629811, 87.513258378, 87.872717068, 87.935569489, 88.361792203, 88.673071467, 88.832065294, 89.104969603, 89.37763522, 89.821518529, 90.133673838, 90.580064798, 90.792604009, 91.580021887, 91.882329816, 91.930480355, 92.104084999, 92.381628141, 92.682808946, 92.906264924, 93.163011101, 93.494509284, 93.605157884, 93.980370315, 94.060966077, 94.418170663, 94.63056749, 94.685817586, 94.889794037, 95.404784032, 95.455226955, 95.586432117, 96.121613836, 96.244536792, 96.528305296, 96.894083071, 97.695922436, 97.955149386, 98.135610033, 98.277113255, 98.463041877, 98.652794592, 98.867324954, 98.976560255, 99.025320562, 99.158531431, 100.000729557, 100.117119268, 100.274169133, 100.662016725, 101.222083557, 102.397954561, 102.586469906, 102.969614352, 103.621755538, 103.683474545, 104.673544848, 105.082933377, 105.293097192, 105.495550563, 105.698727572, 106.160343002, 106.367434622, 106.435859641, 106.464424914, 106.706338317, 107.193625078, 107.414232476, 107.749421956, 108.045236582, 108.263284444, 108.756273987, 108.888150044, 110.013150046, 110.017954219, 110.307032863, 110.63880078, 110.782784916, 111.247545613, 111.5687145, 112.171325905, 112.448993891, 112.86663226, 112.929461789, 113.056439816, 113.828463166, 113.941292245, 114.067054307), "200" = c(2.0152e-05, 2.0195e-05, 2.0251e-05, 2.0756e-05, 2.0857e-05, 2.1003e-05, 2.1187e-05, 2.1222e-05, 2.1714e-05, 2.1749e-05, 2.2095e-05, 2.2305e-05, 2.2353e-05, 2.2707e-05, 2.2821e-05, 2.2887e-05, 2.291e-05, 2.3076e-05, 2.3123e-05, 2.3436e-05, 2.3631e-05, 2.3769e-05, 2.4396e-05, 2.4418e-05, 2.5444e-05, 2.5452e-05, 2.5905e-05, 2.5974e-05, 2.6347e-05, 2.6631e-05, 2.6738e-05, 2.7928e-05, 2.8417e-05, 2.8832e-05, 2.8992e-05, 3.0162e-05, 3.0194e-05, 3.1025e-05, 3.1383e-05, 3.1498e-05, 3.1703e-05, 3.2056e-05, 3.2171e-05, 3.2476e-05, 3.3081e-05, 3.3197e-05, 3.3838e-05, 3.4075e-05, 3.4515e-05, 3.4645e-05, 3.4709e-05, 3.5476e-05, 3.5522e-05, 3.5584e-05, 3.5671e-05, 3.5803e-05, 3.6725e-05, 3.6797e-05, 3.7055e-05, 3.7405e-05, 3.7929e-05, 3.794e-05, 3.8233e-05, 3.8553e-05, 3.8635e-05, 3.8886e-05, 3.9507e-05, 3.9651e-05, 4.0113e-05, 4.0593e-05, 4.0958e-05, 4.1001e-05, 4.1534e-05, 4.1861e-05, 4.2042e-05, 4.2283e-05, 4.2586e-05, 4.3188e-05, 4.3748e-05, 4.4248e-05, 4.5175e-05, 4.581e-05, 4.6778e-05, 4.7686e-05, 4.772e-05, 4.8436e-05, 4.8717e-05, 4.9119e-05, 4.9784e-05, 5.0739e-05, 5.1294e-05, 5.1575e-05, 5.2508e-05, 5.3476e-05, 5.3689e-05, 5.4245e-05, 5.5088e-05, 5.5585e-05, 5.6159e-05, 5.7476e-05, 5.7674e-05, 5.8351e-05, 5.9147e-05, 5.9311e-05, 5.9985e-05, 6.0872e-05, 6.135e-05, 6.2221e-05, 6.3786e-05, 6.437e-05, 6.4944e-05, 6.5663e-05, 6.5955e-05, 6.6551e-05, 6.8447e-05, 6.9544e-05, 7.0231e-05, 7.1388e-05, 7.2164e-05, 7.2474e-05, 7.3752e-05, 7.4192e-05, 7.4847e-05, 7.5761e-05, 7.7063e-05, 7.8179e-05, 7.9315e-05, 8.0522e-05, 8.109e-05, 8.1863e-05, 8.228e-05, 8.3117e-05, 8.3437e-05, 8.4592e-05, 8.5764e-05, 8.6621e-05, 8.7724e-05, 8.9739e-05, 9.1109e-05, 9.225e-05, 9.3883e-05, 9.5049e-05, 9.6181e-05, 9.6917e-05, 9.838e-05, 0.000100026, 0.000100993, 0.000102875, 0.000103696, 0.000105951, 0.000107044, 0.000108297, 0.000108863, 0.000110459, 0.000111379, 0.000112922, 0.000114969, 0.000116721, 0.000118643, 0.000119905, 0.000121217, 0.000122549, 0.000123914, 0.000125307, 0.000128249, 0.000129723, 0.000131493, 0.000133209, 0.000135161, 0.000137516, 0.000139302, 0.000141555, 0.000142552, 0.000144167, 0.000145892, 0.000146761, 0.000147878, 0.000149105, 0.000151329, 0.000153886, 0.000156019, 0.000157999, 0.000159349, 0.000161668, 0.000163866, 0.000166097, 0.000167718, 0.000169714, 0.000171189, 0.000173273, 0.000175445, 0.000177666, 0.00018112, 0.000183929, 0.00018615, 0.000187754, 0.000189786, 0.000192555, 0.000195453, 0.000197684, 0.000199305, 0.00020309, 0.000204732, 0.000206531, 0.000208689, 0.000210837, 0.000212767, 0.000214059, 0.000216179, 0.000219672, 0.00022283, 0.000224891, 0.000226773, 0.00022874, 0.000231305, 0.000233352, 0.000235167, 0.000238213, 0.000240639, 0.000243626, 0.000244562, 0.000246585, 0.000248729, 0.000251414, 0.000253845, 0.000257622, 0.000260112, 0.000263559, 0.000266037, 0.000268317, 0.000271823, 0.000275657, 0.000278296, 0.000281895, 0.000284013, 0.000287202, 0.000289398, 0.00029144, 0.000294874, 0.000298893, 0.000302307, 0.000305537, 0.00030931, 0.000314239, 0.000319442, 0.000323679, 0.000328593, 0.000332341, 0.000338242, 0.000343011, 0.000347015, 0.000349618, 0.000352798, 0.000356134, 0.000361119, 0.000363746, 0.000367757, 0.000374762, 0.000378783, 0.000382872, 0.000389818, 0.000394078, 0.000398286, 0.000404227, 0.000409009, 0.0004137, 0.00041777, 0.000421069, 0.000425639, 0.000432055, 0.000436464, 0.000440767, 0.000445639, 0.000449705, 0.000454075, 0.000458389, 0.000463803, 0.00047042, 0.00047582, 0.000480776, 0.000487308, 0.000493526, 0.00050066, 0.000507037, 0.00051349, 0.000520061, 0.000525868, 0.000531695, 0.000536472, 0.000541609, 0.000546112, 0.00055178, 0.000557575, 0.000565099, 0.000570097, 0.000577047, 0.000584273, 0.000590978, 0.000599832, 0.000605756, 0.000610608, 0.000616041, 0.000622285, 0.000631054, 0.0006409, 0.000648108, 0.000653885, 0.000658938, 0.000666838, 0.000674352, 0.000682052, 0.000689258, 0.000695814, 0.000704416, 0.000712785, 0.000721927, 0.000729674, 0.000738607, 0.000748466, 0.000756999, 0.000766047, 0.000775984, 0.000785425, 0.000793882, 0.00080476, 0.000814114, 0.000822803, 0.000832547, 0.000843823, 0.00085559, 0.000865363, 0.000874788, 0.000885862, 0.000893898, 0.000903594, 0.000915996, 0.0009268, 0.000938447, 0.000947114, 0.00095839, 0.000968026, 0.000970225, 0.000982565, 0.000996548, 0.001010905, 0.001023333, 0.001035679, 0.001045822, 0.001054864, 0.001067806, 0.001079842, 0.001092359, 0.001105161, 0.00111777, 0.001134195, 0.001149398, 0.001166764, 0.001183124, 0.001196782, 0.001210757, 0.0012249, 0.001240435, 0.001256217, 0.001270154, 0.001284027, 0.0012977, 0.001313485, 0.001326426, 0.001342038, 0.001358277, 0.001375004, 0.001390287, 0.001404767, 0.001421084, 0.00143983, 0.001457104, 0.001475, 0.001490372, 0.001506386, 0.001522417, 0.00153792, 0.001556429, 0.001575399, 0.001593678, 0.001610227, 0.001628641, 0.00164678, 0.001668168, 0.001686167, 0.001703027, 0.001722586, 0.001741219, 0.001759175, 0.001776948, 0.001796058, 0.001815469, 0.001833886, 0.001852294, 0.001874285, 0.001894259, 0.001916703, 0.001941734, 0.001963493, 0.001984874, 0.002006677, 0.002033581, 0.002060522, 0.002088586, 0.002113066, 0.002135653, 0.002161631, 0.002188093, 0.002214044, 0.002238638, 0.002261883, 0.002293254, 0.002320055, 0.00234269, 0.002374344, 0.002400033, 0.002424315, 0.002453836, 0.002481938, 0.002510894, 0.002540843, 0.002571919, 0.002603082, 0.002631487, 0.002659711, 0.002685945, 0.002717969, 0.002745848, 0.002775532, 0.002809023, 0.002840281, 0.002873711, 0.002906551, 0.002941505, 0.002975328, 0.003008434, 0.003039883, 0.003070062, 0.003110114, 0.003147079, 0.003184444, 0.003220356, 0.003256776, 0.003295111, 0.003334392, 0.003367012, 0.00340775, 0.003451579, 0.003495862, 0.003531699, 0.003576338, 0.003619288, 0.003659601, 0.003698404, 0.0037389, 0.00377896, 0.003822234, 0.003871374, 0.003920403, 0.003966554, 0.004014205, 0.004058663, 0.004111438, 0.004162729, 0.004214637, 0.00427027, 0.004315017, 0.00435924, 0.004414803, 0.004464875, 0.004514677, 0.004564412, 0.00461548, 0.004670035, 0.004725049, 0.00478123, 0.00483727, 0.004892926, 0.004953834, 0.005009176, 0.005071247, 0.005124712, 0.005181856, 0.005242449, 0.005303965, 0.005367324, 0.005432855, 0.005496367, 0.005554884, 0.005626369, 0.005693257, 0.00575649, 0.00582174, 0.005893646, 0.005967856, 0.006036626, 0.00610568, 0.006181656, 0.006252979, 0.006320349, 0.00639452, 0.006468834, 0.006544049, 0.006619348, 0.006689091, 0.006770738, 0.006848493, 0.00693052, 0.00701242, 0.007100973, 0.007181018, 0.007261652, 0.007343513, 0.007434226, 0.007526616, 0.007616837, 0.007704705, 0.007792129, 0.007881717, 0.007976107, 0.008070397, 0.008167588, 0.008258611, 0.008364826, 0.008460304, 0.008557559, 0.008657552, 0.008756405, 0.008861054, 0.008955078, 0.009054476, 0.009159509, 0.009272135, 0.009386257, 0.00949445, 0.009610222, 0.009723458, 0.009807336, 0.009828022, 0.009937435, 0.010048381, 0.010166545, 0.010284558, 0.010401951, 0.010522375, 0.010642478, 0.010770985, 0.010891722, 0.011024196, 0.011147975, 0.011271685, 0.011400184, 0.011540153, 0.011673022, 0.01180631, 0.01193759, 0.012076398, 0.012219746, 0.012358641, 0.012496837, 0.012635585, 0.012790576, 0.012944521, 0.013084365, 0.013231485, 0.013376689, 0.013535632, 0.013690058, 0.013858493, 0.014009623, 0.014180047, 0.01433604, 0.01451211, 0.014685894, 0.014861898, 0.015035389, 0.0152129, 0.015391306, 0.01557073, 0.015753688, 0.015941245, 0.01612115, 0.016301051, 0.016490883, 0.016688306, 0.016884193, 0.017083506, 0.017274045, 0.017478591, 0.017690242, 0.017903908, 0.018111249, 0.018315432, 0.018524671, 0.018735287, 0.018954398, 0.019174714, 0.019397448, 0.019622147, 0.019862206, 0.020094141, 0.020325743, 0.020560344, 0.020803871, 0.021045475, 0.021304979, 0.021546942, 0.021808375, 0.022061835, 0.022308614, 0.022566747, 0.022825051, 0.023086706, 0.023355036, 0.023629717, 0.023901999, 0.024188581, 0.024462932, 0.024758525, 0.025040061, 0.025321219, 0.025616552, 0.025917624, 0.026233, 0.026526237, 0.026825614, 0.02712941, 0.027434686, 0.027757417, 0.028094173, 0.028425882, 0.028774075, 0.029128629, 0.029466391, 0.029804553, 0.030157938, 0.030510576, 0.030860871, 0.031227502, 0.031571762, 0.031940437, 0.032297757, 0.032677666, 0.033072488, 0.033455835, 0.033862178, 0.034241949, 0.034646075, 0.03504759, 0.03546324, 0.035877117, 0.036282523, 0.036710618, 0.037125415, 0.037546099, 0.037985822, 0.038436932, 0.038878656, 0.039320225, 0.039775991, 0.040234974, 0.040709713, 0.04118423, 0.041651861, 0.042134437, 0.042604893, 0.043110687, 0.043603822, 0.044115631, 0.044618251, 0.045139229, 0.045669184, 0.046185303, 0.046730033, 0.04728471, 0.047853463, 0.048393509, 0.048962693, 0.049529556, 0.05010064, 0.050684503, 0.051273555, 0.051869322, 0.052477744, 0.053064155, 0.053672988, 0.054317905, 0.054944593, 0.055600013, 0.056261605, 0.056907922, 0.057551213, 0.058242772, 0.058930676, 0.059627147, 0.060314288, 0.061028704, 0.06173077, 0.062458685, 0.063177926, 0.063922052, 0.064685776, 0.065450967, 0.066235286, 0.066998341, 0.067805351, 0.068614452, 0.069431235, 0.070241207, 0.071077527, 0.071920963, 0.072781587, 0.07363388, 0.074481867, 0.075348388, 0.07624503, 0.077111516, 0.078008936, 0.078912674, 0.079837399, 0.080774757, 0.08172481, 0.082679387, 0.083637884, 0.084618326, 0.085642411, 0.086653247, 0.087672529, 0.088736265, 0.089779693, 0.090844442, 0.091919044, 0.093008688, 0.094088156, 0.095211137, 0.096318466, 0.09745383, 0.098583549, 0.099504889, 0.099735237, 0.100898675, 0.102093323, 0.103317441, 0.104529016, 0.10576916, 0.107015788, 0.108287366, 0.109582562, 0.110887949, 0.11222076, 0.113523007, 0.114867457, 0.116221325, 0.117569605, 0.118931088, 0.12031573, 0.121716779, 0.123145194, 0.124599046, 0.126039324, 0.127527683, 0.129028204, 0.130567628, 0.132117967, 0.13371356, 0.135288529, 0.136905282, 0.138538488, 0.140178528, 0.141818574, 0.143488778, 0.145193657, 0.146919497, 0.14869637, 0.150448537, 0.152257986, 0.154086556, 0.155922644, 0.157751753, 0.159641815, 0.161557997, 0.163471018, 0.165437024, 0.167393577, 0.169353639, 0.171379134, 0.173442822, 0.175518327, 0.177622315, 0.179736078, 0.181879472, 0.184044142, 0.186238731, 0.188452924, 0.190694091, 0.192970338, 0.19530606, 0.197609652, 0.199999924, 0.202437455, 0.204845307, 0.207337467, 0.209826835, 0.212347265, 0.21493979, 0.217514711, 0.220174049, 0.222852309, 0.22553909, 0.228287915, 0.230991406, 0.233760491, 0.236583887, 0.239388158, 0.242306825, 0.245224322, 0.248232965, 0.251229088, 0.254275628, 0.257358953, 0.260476046, 0.263674125, 0.266889655, 0.270138217, 0.273438233, 0.276762604, 0.280147967, 0.283594724, 0.28705879, 0.290593035, 0.294105196, 0.29768812, 0.301323445, 0.305035351, 0.30879475, 0.309606847, 0.312558807, 0.316411753, 0.320357641, 0.324276431, 0.328302277, 0.33230534, 0.336388802, 0.340570584, 0.344751858, 0.349025341, 0.353327782, 0.357661617, 0.36205913, 0.366544906, 0.37115523, 0.375810139, 0.380399454, 0.385094535, 0.389857025, 0.394711563, 0.399714862, 0.404690292, 0.409794402, 0.414954712, 0.420164393, 0.421280913, 0.425451397, 0.430850562, 0.436276693, 0.441713799, 0.447288424, 0.452893653, 0.458609363, 0.464430468, 0.470301678, 0.476272284, 0.482345067, 0.488492612, 0.494727245, 0.501115006, 0.507541463, 0.514068578, 0.520678407, 0.527348394, 0.534110416, 0.540950515, 0.547967676, 0.555115727, 0.562273951, 0.569568744, 0.576993745, 0.584523257, 0.592154612, 0.599917687, 0.607713074, 0.615596818, 0.623706214, 0.631899671, 0.640173286, 0.64868089, 0.657352787, 0.66099726, 0.666030822, 0.674861752, 0.683847573, 0.693090088, 0.702383943, 0.711907928, 0.721478, 0.731196639, 0.741090993, 0.75124593, 0.761471301, 0.771817849, 0.782359533, 0.793055399, 0.803890477, 0.814967289, 0.826350107, 0.837894249, 0.849556789, 0.861286508, 0.873357332, 0.885643214, 0.898144556, 0.910897279, 0.923839894, 0.929234229, 0.937048905, 0.950483452, 0.964185531, 0.978139774, 0.992415034, 1.006864564, 1.021632708, 1.036648802, 1.051876216, 1.067555865, 1.083410827, 1.099645017, 1.116237278, 1.133331765, 1.15072834, 1.168418329, 1.186332043, 1.204615669, 1.223261081, 1.238470801, 1.273169543, 1.292347159, 1.311529653, 1.330670059, 1.349853801, 1.369047081, 1.388213322, 1.407304319, 1.426709589, 1.445872365, 1.464786706, 1.483819304, 1.502778243, 1.521724761, 1.540787839, 1.559851693, 1.578729313, 1.59754388, 1.608681357, 1.616405935, 1.635338881, 1.654352094, 1.673298939, 1.692326088, 1.711257385, 1.730005205, 1.748899431, 1.767764188, 1.786614085, 1.805358695, 1.824121789, 1.843152312, 1.8619079, 1.880847101, 1.899812894, 1.918751915, 1.937717768, 1.956617902, 1.975558833, 1.994452053, 2.013368214, 2.032226097, 2.051114718, 2.069848936, 2.080739048, 2.088784696, 2.107671953, 2.12650614, 2.145239446, 2.164244275, 2.183152253, 2.202120195, 2.22106058, 2.240005476, 2.259004505, 2.278132671, 2.297313919, 2.316392038, 2.335571106, 2.354455635, 2.373562077, 2.392589559, 2.41152266, 2.430558357, 2.449891957, 2.469061895, 2.488182368, 2.507534587, 2.526678336, 2.545952271, 2.565375668, 2.584685816, 2.604175643, 2.623738339, 2.643232023, 2.662589544, 2.682136236, 2.70143267, 2.720770616, 2.740346503, 2.755918928, 2.759998346, 2.779483311, 2.798965618, 2.818736607, 2.838420409, 2.858065761, 2.877775454, 2.897490856, 2.917290775, 2.937155286, 2.957221247, 2.977182257, 2.997333599, 3.017186493, 3.037287378, 3.057715604, 3.077984487, 3.098247306, 3.118381399, 3.138768253, 3.159556465, 3.18009058, 3.200655011, 3.22137379, 3.24197305, 3.25804043, 3.262639247, 3.283763241, 3.304663415, 3.32566555, 3.346558535, 3.36741467, 3.388671978, 3.409820994, 3.43088824, 3.45218008, 3.473297762, 3.494787495, 3.516290418, 3.53810963, 3.559551085, 3.581429511, 3.603085532, 3.625151794, 3.647123899, 3.668906374, 3.691107691, 3.713237742, 3.735328081, 3.75767604, 3.77994893, 3.802647408, 3.82521704, 3.848071954, 3.870857346, 3.893439895, 3.91651857, 3.939617184, 3.962905574, 3.985991838, 4.009139674, 4.032727531, 4.056432769, 4.079951494, 4.10288784, 4.12682965, 4.150209061, 4.174037009, 4.197907807, 4.222134602, 4.246292684, 4.270888707, 4.29545014, 4.320382513, 4.345398157, 4.370342067, 4.39514011, 4.420623161, 4.445904355, 4.471727421, 4.497060199, 4.522838878, 4.548421695, 4.574319959, 4.600608587, 4.626870834, 4.653712759, 4.679735756, 4.70619241, 4.732740786, 4.759932979, 4.786311996, 4.813505041, 4.840804004, 4.868596264, 4.896032786, 4.923706597, 4.951279582, 4.979749495, 5.007770049, 5.036012685, 5.064494689, 5.092807286, 5.121926393, 5.150879838, 5.180136559, 5.209265099, 5.238976942, 5.267946851, 5.297243587, 5.327156439, 5.357114331, 5.387585431, 5.418358571, 5.449299075, 5.480570649, 5.511944673, 5.54290934, 5.573704772, 5.605322731, 5.637600047, 5.669068858, 5.675839907, 5.700608277, 5.73260392, 5.764722816, 5.797378221, 5.82959778, 5.862893732, 5.896275244, 5.929752182, 5.962279553, 5.995864991, 6.029664318, 6.062924119, 6.096597423, 6.131125706, 6.166001317, 6.200955215, 6.235371192, 6.270626065, 6.305504811, 6.340851391, 6.376434899, 6.412344996, 6.449029864, 6.486107952, 6.523253198, 6.559788413, 6.596155112, 6.632863894, 6.6709388, 6.70831778, 6.745440251, 6.782495124, 6.819652048, 6.857331092, 6.895137591, 6.934844883, 6.973436519, 7.011632054, 7.04980394, 7.089633232, 7.129665924, 7.169588438, 7.209837693, 7.249017909, 7.288317451, 7.328104607, 7.367692211, 7.409012509, 7.448938379, 7.489816286, 7.530968115, 7.57284129, 7.6140567, 7.656704052, 7.697701349, 7.739735933, 7.780941629, 7.82270829, 7.865690779, 7.907877445, 7.952568275, 7.994742376, 8.037989705, 8.081740621, 8.124965856, 8.168367424, 8.210160355, 8.25438353, 8.297803297, 8.342518717, 8.387127707, 8.432084638, 8.477940592, 8.522383355, 8.567098754, 8.613157284, 8.657491388, 8.701602314, 8.747571812, 8.793588573, 8.839448239, 8.886751347, 8.933370305, 8.981891184, 9.029016412, 9.076264216, 9.122778433, 9.169554978, 9.217843901, 9.263555886, 9.31116457, 9.357686101, 9.406488016, 9.456028214, 9.502560463, 9.548775686, 9.595076003, 9.644533524, 9.693789182, 9.744191433, 9.792547839, 9.841497544, 9.892343687, 9.943908302, 9.992547083, 10.044400319, 10.093748426, 10.145844024, 10.197304545, 10.246132006, 10.296753523, 10.348986287, 10.401063827, 10.453163512, 10.505665317, 10.558428636, 10.611467936, 10.666707813, 10.718070794, 10.770700849, 10.82559692, 10.878163106, 10.932044654, 10.985684152, 11.040765336, 11.098269326, 11.152187783, 11.207014192, 11.260501252, 11.317316796, 11.373772604, 11.42902536, 11.482800203, 11.542751808, 11.59960954, 11.654219015, 11.709260207, 11.767109809, 11.823914576, 11.88188905, 11.938309265, 11.997821166, 12.053238765, 12.110268293, 12.165757508, 12.221069927, 12.280189254, 12.33776211, 12.394517957, 12.451235208, 12.51147935, 12.566408926, 12.624748307, 12.685415126, 12.744857001, 12.807068632, 12.866453031, 12.927582094, 12.988538031, 13.05050561, 13.114825874, 13.172118304, 13.231295283, 13.29038397, 13.350130208, 13.410077023, 13.477513535, 13.538225812, 13.598033309, 13.66034823, 13.719205511, 13.781196889, 13.842873487, 13.904289046, 13.972053947, 14.039540021, 14.104772572, 14.166658256, 14.228151526, 14.290295808, 14.353039874, 14.421000333, 14.485505536, 14.54403443, 14.608975867, 14.680061662, 14.742774725, 14.811337142, 14.876899483, 14.942661146, 15.007737883, 15.077635102, 15.146467875, 15.212249424, 15.27897034, 15.347162724, 15.414348932, 15.482647694, 15.552910981, 15.624618481, 15.637778142, 15.690885725, 15.75629806, 15.828040478, 15.892256244, 15.954810551, 16.021052292, 16.093963135, 16.164583403, 16.231645763, 16.299280777, 16.365562343, 16.436903018, 16.508347363, 16.578960665, 16.649966029, 16.725018085, 16.804216221, 16.870065426, 16.943493816, 17.011241643, 17.089289522, 17.163599668, 17.236208084, 17.311025008, 17.377592713, 17.455784588, 17.53403016, 17.604086821, 17.679517927, 17.755454279, 17.826014784, 17.900250248, 17.975559741, 18.049033206, 18.129299825, 18.198360032, 18.276337204, 18.351191001, 18.426554538, 18.501876768, 18.581200497, 18.655835394, 18.730734179, 18.815455867, 18.889338636, 18.966014472, 19.041235862, 19.122071823, 19.210593463, 19.287561546, 19.374313423, 19.452353985, 19.528672186, 19.610160808, 19.687230584, 19.771127925, 19.853091327, 19.946342483, 20.023199611, 20.106275433, 20.187888853, 20.274479827, 20.35769825, 20.447799259, 20.532358111, 20.605743056, 20.695548806, 20.781492123, 20.87525966, 20.950534045, 21.037425855, 21.122744795, 21.208456816, 21.285534474, 21.370044605, 21.462167102, 21.547551448, 21.638179902, 21.727493456, 21.814489819, 21.903135932, 21.985888911, 22.06797323, 22.156642982, 22.245559077, 22.337715974, 22.423427456, 22.511597225, 22.606582378, 22.69782431, 22.786405057, 22.872212873, 22.984831794, 23.077492876, 23.167839209, 23.242235743, 23.325954814, 23.416286217, 23.520016054, 23.608896044, 23.69722519, 23.803888628, 23.891973105, 23.993756718, 24.091329606, 24.196557855, 24.303824291, 24.398458356, 24.516417918, 24.614080281, 24.706031712, 24.805323573, 24.901494057, 24.988314202, 25.086974529, 25.189203291, 25.280087786, 25.378563236, 25.48147597, 25.57385701, 25.662900123, 25.766864441, 25.859993815, 25.965953361, 26.063432487, 26.163996905, 26.249012205, 26.346129934, 26.438925211, 26.549605915, 26.651230491, 26.738204198, 26.8337174, 26.93987968, 27.04052921, 27.142582338, 27.246680456, 27.337721113, 27.450218977, 27.551347906, 27.651054685, 27.75640794, 27.860175723, 27.957842514, 28.051384992, 28.154748106, 28.253734934, 28.359983633, 28.469085716, 28.57108331, 28.677516257, 28.783325771, 28.892817297, 28.995230774, 29.127116011, 29.251578834, 29.368316275, 29.490621465, 29.60738801, 29.716332979, 29.821014572, 29.944634482, 30.04725117, 30.187190177, 30.293066923, 30.407675372, 30.513113821, 30.612966185, 30.737700441, 30.830818565, 30.942142421, 31.065883643, 31.175937431, 31.288231839, 31.392983607, 31.5153586, 31.631284784, 31.716651856, 31.834132984, 31.947802071, 32.061448985, 32.176930392, 32.303512831, 32.410847686, 32.50292025, 32.636924492, 32.763861065, 32.898973872, 33.001236806, 33.127903145, 33.229624167, 33.363226458, 33.481377256, 33.601445989, 33.724592287, 33.830961315, 33.951069208, 34.072363621, 34.191983416, 34.30599673, 34.330183402, 34.428532395, 34.551833472, 34.668490943, 34.79932498, 34.907983601, 35.028534935, 35.142082265, 35.254042519, 35.378747492, 35.530705147, 35.634046114, 35.744612596, 35.881138874, 35.994641489, 36.110047704, 36.208604251, 36.312424832, 36.459356544, 36.598236591, 36.684691438, 36.803298263, 36.876163358, 37.026008279, 37.151221593, 37.289313497, 37.418381679, 37.528129901, 37.666274697, 37.776143172, 37.891090769, 38.012953716, 38.161154389, 38.331631852, 38.469408609, 38.586976629, 38.700651633, 38.852013564, 39.000027495, 39.145256145, 39.285081685, 39.424288748, 39.5948626, 39.713277612, 39.863862861, 39.999702153, 40.167406189, 40.294202454, 40.457615113, 40.600570489, 40.737342816, 40.889658031, 41.066008299, 41.229108869, 41.370208548, 41.525624165, 41.653925868, 41.857860962, 42.003292783, 42.120770234, 42.230888178, 42.336096821, 42.476502075, 42.626706394, 42.750890505, 42.875050884, 43.016043544, 43.169320732, 43.297143816, 43.418964277, 43.567327816, 43.669589019, 43.853565392, 43.978112794, 44.134888078, 44.273411989, 44.386554887, 44.484391348, 44.673781362, 44.860939023, 45.031774213, 45.131048115, 45.236409394, 45.40396908, 45.553048039, 45.691537076, 45.851697364, 46.018501735, 46.160060483, 46.322406332, 46.543942739, 46.688810357, 46.905156345, 47.102586634, 47.247537997, 47.342334829, 47.486766149, 47.634615578, 47.794906132, 47.960806925, 48.129549646, 48.255667004, 48.38034197, 48.519876256, 48.636998192, 48.864887825, 49.031438511, 49.189800039, 49.325161453, 49.506207756, 49.646988261, 49.845995054, 49.984133724, 50.159393254, 50.28457472, 50.371443346, 50.531470022, 50.689921903, 50.882050164, 51.014624826, 51.204563589, 51.370609616, 51.578028238, 51.678886161, 51.874191311, 52.094546518, 52.264595752, 52.474629109, 52.613783926, 52.776005046, 52.915480874, 53.140883198, 53.295251703, 53.492554782, 53.594744044, 53.804492164, 53.966797233, 54.21420487, 54.360148551, 54.518680833, 54.736114876, 54.887544663, 55.041600667, 55.19674103, 55.326150792, 55.44262995, 55.587981405, 55.741965678, 56.023026612, 56.200026637, 56.334664589, 56.582582073, 56.755445723, 56.980989843, 57.253805121, 57.457969699, 57.631204287, 57.80173358, 58.120986706, 58.326798151, 58.545139287, 58.803236153, 58.991861273, 59.209281505, 59.400525631, 59.582660907, 59.799362899, 60.007058884, 60.129541758, 60.216412858, 60.304569443, 60.517052706, 60.745108704, 60.806345046, 61.094995267, 61.450886065, 61.614245026, 61.851932122, 61.948777827, 62.257140597, 62.460485744, 62.774182268, 62.912146719, 63.042453453, 63.529974333, 63.720216526, 63.875635081, 64.015605131, 64.202085789, 64.337223608, 64.573860305, 64.65280254, 64.88038526, 65.121500369, 65.421710576, 65.817864871, 66.047977293, 66.288594611, 66.729360472, 67.060520635, 67.383502545, 67.561517221, 67.674579419, 67.833397856, 67.883428984, 67.991305343, 68.055560036, 68.299364299, 68.49578908, 68.806136011, 69.051525167, 69.179536824, 69.591174394, 69.705969558, 69.927882707, 70.237598635, 70.403099401, 70.742158579, 70.960755258, 71.271656913, 71.537668102, 71.685674992, 71.865725227, 72.058422665, 72.408666213, 72.697134438, 72.847824895, 73.241984523, 73.78463016, 74.185402681, 74.287086063, 74.4225662, 74.57686395, 74.65658518, 74.803187577, 75.000938311, 75.335364355, 75.622968014, 75.818286388, 75.906742846, 76.071424013, 76.220693814, 76.531531278, 76.67053788, 76.975909462, 77.227155471, 77.454304673, 77.868560447, 78.040710378, 78.264838105, 78.346221059, 78.62008108, 78.975369548, 79.235135036, 79.635080147, 79.713985877, 79.8313585, 80.210185001, 80.406909521, 80.516219672, 80.781166684, 81.199409251, 81.573583697, 81.957785253, 82.351015079, 82.502513021, 82.695454079, 82.762124811, 83.225764739, 83.476522192, 83.532794547, 83.797386618, 84.009413304, 84.413236574, 84.587293557, 84.888131407, 84.955706531, 85.242989836, 85.786719351, 85.903449223, 86.102043266, 86.200920381, 86.265359007, 86.351527926, 86.926231924, 87.039947818, 87.152864509, 87.26522543, 87.281532934, 87.391328884, 87.697722469, 88.116591223, 88.322515857, 88.527017159, 88.636699835, 89.098801755, 89.317936781, 89.367733676, 89.651087149, 89.733668449, 89.870248644, 89.945881951, 90.159486118, 90.723851598, 90.996907293, 91.549074065, 91.687069832, 91.89061272, 92.035021411, 92.670151751, 92.823396559, 93.213879153, 93.997480214, 94.118452758, 94.138527566, 94.229693472, 94.336374218, 94.633727783, 94.808029443, 94.916164536, 95.089277537, 95.703442565, 95.901304245, 95.920210837, 96.457554562, 96.5041075, 97.434630918, 97.537815644, 97.55832051, 98.159334126, 98.666771517, 98.961602686, 99.043951239, 99.758603186, 100.050922605, 100.354212124, 100.631198417, 100.631564726, 100.705014003, 100.848257738, 101.042344695), "300" = c(2.2884e-05, 2.3131e-05, 2.3355e-05, 2.37e-05, 2.3933e-05, 2.4135e-05, 2.4289e-05, 2.4299e-05, 2.4382e-05, 2.4423e-05, 2.4918e-05, 2.4998e-05, 2.5047e-05, 2.5211e-05, 2.5471e-05, 2.6257e-05, 2.6293e-05, 2.7116e-05, 2.72e-05, 2.7604e-05, 2.7948e-05, 2.8078e-05, 2.8393e-05, 2.8547e-05, 2.8639e-05, 2.8864e-05, 2.9719e-05, 2.9849e-05, 3.0095e-05, 3.0943e-05, 3.1567e-05, 3.1958e-05, 3.2405e-05, 3.2653e-05, 3.2817e-05, 3.2857e-05, 3.2864e-05, 3.3649e-05, 3.4155e-05, 3.4445e-05, 3.4669e-05, 3.4776e-05, 3.6093e-05, 3.6501e-05, 3.6896e-05, 3.7188e-05, 3.7521e-05, 3.8087e-05, 3.8152e-05, 3.8796e-05, 3.9322e-05, 3.9447e-05, 3.962e-05, 3.9858e-05, 3.9877e-05, 4.0072e-05, 4.1273e-05, 4.1468e-05, 4.1988e-05, 4.2132e-05, 4.2731e-05, 4.3277e-05, 4.3514e-05, 4.4568e-05, 4.5052e-05, 4.5591e-05, 4.7707e-05, 4.8029e-05, 4.8205e-05, 4.8913e-05, 4.9764e-05, 5.0061e-05, 5.0504e-05, 5.0648e-05, 5.1223e-05, 5.1728e-05, 5.2817e-05, 5.3126e-05, 5.3462e-05, 5.4067e-05, 5.4322e-05, 5.4654e-05, 5.5184e-05, 5.5394e-05, 5.5854e-05, 5.6038e-05, 5.6903e-05, 5.7588e-05, 5.8941e-05, 5.9916e-05, 6.0427e-05, 6.1004e-05, 6.1706e-05, 6.2414e-05, 6.3536e-05, 6.4822e-05, 6.5567e-05, 6.6059e-05, 6.7023e-05, 6.8357e-05, 6.8954e-05, 6.9477e-05, 7.0199e-05, 7.1351e-05, 7.1885e-05, 7.337e-05, 7.429e-05, 7.5015e-05, 7.5327e-05, 7.5876e-05, 7.6277e-05, 7.6994e-05, 7.7438e-05, 7.8465e-05, 7.8719e-05, 7.9066e-05, 8.0349e-05, 8.1023e-05, 8.1633e-05, 8.2461e-05, 8.3319e-05, 8.4564e-05, 8.5231e-05, 8.5623e-05, 8.7237e-05, 8.8588e-05, 9.0054e-05, 9.0625e-05, 9.239e-05, 9.2897e-05, 9.3957e-05, 9.5639e-05, 9.6208e-05, 9.6963e-05, 9.8459e-05, 9.9153e-05, 0.00010009, 0.000102074, 0.000103091, 0.000104211, 0.000105345, 0.000107184, 0.000108044, 0.000109195, 0.000109939, 0.000110633, 0.000111468, 0.00011272, 0.000113938, 0.000115706, 0.000116733, 0.000117599, 0.00011876, 0.0001202, 0.000121773, 0.000123671, 0.000124761, 0.000126295, 0.0001278, 0.000128908, 0.000131722, 0.000133277, 0.000134439, 0.000135612, 0.000136925, 0.000138711, 0.000140267, 0.000141527, 0.000143236, 0.000144725, 0.000146727, 0.000148034, 0.000149756, 0.000151502, 0.000153625, 0.000156315, 0.000157827, 0.000158769, 0.000160446, 0.000162233, 0.000163264, 0.000166467, 0.000168761, 0.000170043, 0.00017151, 0.000173036, 0.000174715, 0.000175718, 0.000177873, 0.00017969, 0.000181713, 0.000183717, 0.000185216, 0.000187307, 0.000188826, 0.000190276, 0.000192852, 0.000194293, 0.000196543, 0.000198047, 0.000199629, 0.00020098, 0.000203949, 0.000206834, 0.000210817, 0.000213776, 0.000216366, 0.000218648, 0.000220034, 0.000223091, 0.000225112, 0.000227466, 0.000230114, 0.000232614, 0.00023483, 0.000237815, 0.000240823, 0.000244121, 0.000246098, 0.000248349, 0.000250647, 0.000253655, 0.000257268, 0.000260008, 0.00026352, 0.000267214, 0.000270067, 0.000273567, 0.000275872, 0.000278907, 0.000282235, 0.000284717, 0.000287769, 0.000289736, 0.00029393, 0.000297265, 0.000300602, 0.000304761, 0.000307582, 0.000309754, 0.000311984, 0.00031713, 0.000320607, 0.000324775, 0.0003282, 0.000330966, 0.000334841, 0.000339156, 0.000342518, 0.000345015, 0.000348371, 0.000353096, 0.000356352, 0.00036096, 0.000364421, 0.000367942, 0.000371279, 0.000374643, 0.000379541, 0.000383113, 0.000389129, 0.000392768, 0.000397812, 0.000403055, 0.000407721, 0.000413403, 0.000418972, 0.000425422, 0.000429509, 0.000435104, 0.000439708, 0.000445499, 0.000451308, 0.000456607, 0.000460886, 0.000466234, 0.000473684, 0.000480004, 0.000487854, 0.000495682, 0.000500607, 0.000505601, 0.000515004, 0.000520202, 0.000526251, 0.000531501, 0.000537354, 0.000543238, 0.000551059, 0.000557883, 0.000562174, 0.00056731, 0.000574159, 0.000579694, 0.000585988, 0.00059259, 0.000599635, 0.000607736, 0.000614255, 0.000620699, 0.000628682, 0.000636078, 0.000644388, 0.000652748, 0.000658721, 0.00066568, 0.00067302, 0.000681753, 0.000688882, 0.000697895, 0.000706174, 0.000715253, 0.000725785, 0.000732608, 0.000741904, 0.000749183, 0.000758342, 0.000767423, 0.000774185, 0.000782422, 0.00078941, 0.000797926, 0.000805435, 0.000814911, 0.000825945, 0.000834505, 0.000842131, 0.000852851, 0.000859576, 0.000870765, 0.000880778, 0.000889357, 0.00089726, 0.000908901, 0.000920762, 0.000931699, 0.000943385, 0.00095404, 0.000965404, 0.000979241, 0.000990876, 0.000994095, 0.001006564, 0.001018609, 0.001027188, 0.001040976, 0.001051683, 0.001061972, 0.001073225, 0.0010887, 0.0011009, 0.00111421, 0.001129473, 0.001142047, 0.001157377, 0.001171628, 0.00118332, 0.001197084, 0.001209418, 0.001223133, 0.00123737, 0.00125163, 0.001264725, 0.001279128, 0.001292941, 0.001308616, 0.001324614, 0.001341689, 0.00136051, 0.001371732, 0.001390364, 0.001405824, 0.001423307, 0.001439632, 0.001457397, 0.001475464, 0.001490993, 0.001505853, 0.001523527, 0.001540823, 0.001564722, 0.001581381, 0.001600338, 0.001618664, 0.001639953, 0.001660597, 0.001678944, 0.001698817, 0.001720121, 0.001737282, 0.001753579, 0.001770327, 0.001789645, 0.001812984, 0.001837274, 0.001859917, 0.001884732, 0.001905966, 0.001932764, 0.001952881, 0.001973089, 0.001995903, 0.002018224, 0.002040717, 0.002064365, 0.00208558, 0.002112743, 0.002138751, 0.00216388, 0.002187356, 0.002210238, 0.002235065, 0.00226045, 0.002284933, 0.002310983, 0.002333348, 0.002356228, 0.002384845, 0.002409941, 0.002439673, 0.002466961, 0.002497262, 0.002526558, 0.002553027, 0.002582408, 0.002610675, 0.002637448, 0.002664911, 0.002694394, 0.002724715, 0.002759396, 0.002796159, 0.002827489, 0.002858438, 0.002890454, 0.002925976, 0.002959639, 0.002995885, 0.003029399, 0.003064992, 0.003095156, 0.003132294, 0.003170404, 0.003209059, 0.00324478, 0.00328332, 0.003324867, 0.003361959, 0.003398393, 0.003437679, 0.003479451, 0.003519221, 0.003563449, 0.003602646, 0.003646732, 0.003687922, 0.003735917, 0.003772917, 0.003815744, 0.003861411, 0.003909421, 0.003954494, 0.003998775, 0.004041693, 0.004087238, 0.004132433, 0.004175841, 0.004227128, 0.004278099, 0.004325645, 0.004377726, 0.004426967, 0.004476168, 0.004525912, 0.004575911, 0.004628858, 0.004682209, 0.004737867, 0.004787095, 0.004841426, 0.004901056, 0.004954193, 0.005011922, 0.005072716, 0.005134275, 0.005194403, 0.005256411, 0.005319617, 0.005379437, 0.005439927, 0.005512579, 0.005575191, 0.005640975, 0.005710066, 0.005778861, 0.005843761, 0.005908897, 0.005977679, 0.006044593, 0.006111742, 0.006187055, 0.006258299, 0.006332987, 0.006407304, 0.006479196, 0.006553977, 0.006626807, 0.006699213, 0.006774113, 0.006852363, 0.006935505, 0.007009843, 0.007090118, 0.00717207, 0.007252722, 0.007339339, 0.007422485, 0.007517673, 0.007594548, 0.007683089, 0.007769718, 0.007855689, 0.007940547, 0.008029773, 0.008121652, 0.008216817, 0.008320884, 0.008417769, 0.008518291, 0.008615857, 0.008710034, 0.008795701, 0.008894559, 0.009002039, 0.009100569, 0.009205626, 0.009310164, 0.009419072, 0.009529012, 0.009639273, 0.009764297, 0.009858818, 0.009882487, 0.009990796, 0.010104986, 0.010222683, 0.010336144, 0.010454128, 0.010576047, 0.010702771, 0.010826118, 0.010951288, 0.011073043, 0.011192522, 0.011326667, 0.011455671, 0.011589508, 0.011725865, 0.011857226, 0.011992801, 0.012132987, 0.012276623, 0.012416226, 0.012560286, 0.012709681, 0.012857753, 0.013010055, 0.013164343, 0.013311002, 0.013466779, 0.013622483, 0.013781375, 0.01394753, 0.014106087, 0.01426869, 0.014431812, 0.014598149, 0.014764245, 0.01494359, 0.015119447, 0.015292754, 0.015480755, 0.015658702, 0.015848093, 0.016028955, 0.016214604, 0.016404948, 0.01659044, 0.016789895, 0.016971874, 0.017172219, 0.017369483, 0.01756594, 0.01776476, 0.017970072, 0.0181764, 0.018396022, 0.0186112, 0.018817853, 0.01904691, 0.019257984, 0.019482767, 0.019704505, 0.019941197, 0.020166911, 0.020386877, 0.02061486, 0.020853025, 0.021105038, 0.021352478, 0.021605875, 0.021847156, 0.022101921, 0.022360361, 0.022608503, 0.022872535, 0.023139083, 0.023409243, 0.023677963, 0.023945187, 0.024209316, 0.024494456, 0.024782541, 0.025065533, 0.025361358, 0.025651694, 0.025949562, 0.026248245, 0.026561564, 0.026863365, 0.027181913, 0.027513533, 0.027828884, 0.028148705, 0.028489754, 0.02881716, 0.029151592, 0.029495572, 0.029841905, 0.030190028, 0.030543288, 0.0308907, 0.031248325, 0.031592645, 0.031955563, 0.032339273, 0.032719098, 0.033114208, 0.033492237, 0.033889863, 0.034281809, 0.034674062, 0.0350732, 0.035482658, 0.035883654, 0.036302115, 0.036729249, 0.037163303, 0.037602414, 0.038038936, 0.038486281, 0.038929846, 0.039364153, 0.039813314, 0.040277227, 0.040740591, 0.041226823, 0.041705061, 0.042207152, 0.042707106, 0.043219984, 0.043731038, 0.044255215, 0.044775908, 0.045305874, 0.045825867, 0.046375403, 0.046910985, 0.04744583, 0.048002279, 0.048576381, 0.049158511, 0.049721174, 0.050299301, 0.050910126, 0.051496167, 0.052111424, 0.052720288, 0.053343951, 0.053951558, 0.054582674, 0.055207366, 0.055842413, 0.056496094, 0.057170186, 0.057817605, 0.058508558, 0.059181919, 0.059882243, 0.060570191, 0.061290516, 0.062018615, 0.062736564, 0.063467595, 0.064215166, 0.064991899, 0.065755225, 0.066525817, 0.067281527, 0.0680777, 0.06888686, 0.069687049, 0.070494694, 0.071349398, 0.072196311, 0.073045823, 0.073906182, 0.074787902, 0.07567595, 0.076564266, 0.077491619, 0.078393856, 0.079295592, 0.080211463, 0.081167442, 0.082112559, 0.083069086, 0.084055557, 0.085038768, 0.086056931, 0.087077821, 0.088104701, 0.089135903, 0.090175277, 0.091229195, 0.092322615, 0.093425288, 0.094543828, 0.095655298, 0.096777164, 0.097903863, 0.099069047, 0.100004731, 0.100245184, 0.10141756, 0.102645803, 0.103836845, 0.105032827, 0.106294331, 0.107578459, 0.108864509, 0.110143732, 0.111453941, 0.112806079, 0.114155352, 0.11549319, 0.116860374, 0.118243331, 0.119648636, 0.121062217, 0.12248221, 0.12392802, 0.125398711, 0.126876273, 0.12836925, 0.129869798, 0.13141331, 0.132998296, 0.134552259, 0.136133984, 0.137772354, 0.139413264, 0.141074391, 0.142743284, 0.144445478, 0.146156839, 0.147895466, 0.14965362, 0.151441876, 0.153215185, 0.155035395, 0.15689497, 0.158800376, 0.160702263, 0.162660559, 0.164565557, 0.166519767, 0.168544493, 0.170556042, 0.172597741, 0.174652467, 0.176757554, 0.178839487, 0.180990937, 0.183181302, 0.185363585, 0.187619958, 0.18987009, 0.192173519, 0.194494998, 0.196830445, 0.199198065, 0.201606299, 0.204049321, 0.20648426, 0.209018463, 0.211536923, 0.214107765, 0.216719452, 0.219370629, 0.222043675, 0.224714574, 0.227436291, 0.230188693, 0.232925307, 0.235724309, 0.23860618, 0.241474517, 0.244379461, 0.247333883, 0.250392838, 0.25348737, 0.256602307, 0.259772928, 0.262981681, 0.266196807, 0.269524997, 0.272823424, 0.276166406, 0.279558641, 0.283006099, 0.28650936, 0.290047235, 0.293629806, 0.297265651, 0.300869081, 0.304615043, 0.308378163, 0.312226479, 0.313049631, 0.316054735, 0.319951689, 0.323860895, 0.327871304, 0.33190799, 0.335990032, 0.340195833, 0.344472336, 0.34873973, 0.353059518, 0.35746051, 0.36190279, 0.366376347, 0.370934063, 0.375631198, 0.380302424, 0.385048967, 0.389917262, 0.394872966, 0.399788797, 0.404820419, 0.409927469, 0.415061894, 0.420281026, 0.4255773, 0.426704991, 0.43099395, 0.43641438, 0.44194655, 0.447604389, 0.453337083, 0.459119207, 0.464999107, 0.470954833, 0.476945834, 0.483082797, 0.489282505, 0.495607117, 0.501953082, 0.508375018, 0.514965853, 0.521581999, 0.528298251, 0.535120984, 0.542150735, 0.549201477, 0.556397996, 0.563684351, 0.571026715, 0.578538575, 0.586210984, 0.593960415, 0.601787089, 0.609783654, 0.617933833, 0.626093624, 0.634454753, 0.642930301, 0.651581001, 0.66031806, 0.669227855, 0.67298294, 0.678247049, 0.68743351, 0.696759829, 0.706259913, 0.715932246, 0.725669489, 0.735626385, 0.745795531, 0.756068782, 0.766370528, 0.777021999, 0.787855045, 0.798843062, 0.810109455, 0.82142437, 0.832986548, 0.844769684, 0.856708314, 0.86884834, 0.881169011, 0.893731788, 0.906395705, 0.919409264, 0.932668202, 0.94617688, 0.951786332, 0.959814021, 0.973842806, 0.988210091, 1.00283384, 1.017554719, 1.032541373, 1.047997775, 1.063843365, 1.07984955, 1.095971348, 1.112705404, 1.12974357, 1.147117673, 1.164822628, 1.182858017, 1.201362821, 1.220294947, 1.239552996, 1.259198879, 1.275166998, 1.31149343, 1.331640289, 1.35176868, 1.371980105, 1.392297169, 1.41242234, 1.432472761, 1.452492877, 1.472583093, 1.492556267, 1.512696501, 1.532823902, 1.552891859, 1.573111003, 1.593115961, 1.613088055, 1.633147083, 1.653154044, 1.6648807, 1.673202056, 1.693094867, 1.713055671, 1.7330995, 1.752995465, 1.772990925, 1.792887221, 1.812853882, 1.832868507, 1.852780775, 1.872620676, 1.892586266, 1.912697773, 1.932566827, 1.952552564, 1.972547931, 1.992564305, 2.012536338, 2.032456625, 2.052380369, 2.072251706, 2.092371885, 2.112532159, 2.132497866, 2.152377659, 2.16390912, 2.172418573, 2.19231035, 2.212045828, 2.232139446, 2.252223435, 2.27224692, 2.292427149, 2.312551575, 2.332507353, 2.352282443, 2.372252781, 2.392273001, 2.412589575, 2.432647182, 2.452896803, 2.473135053, 2.493156348, 2.513551806, 2.533484891, 2.553723887, 2.573842654, 2.59410859, 2.614650483, 2.634990628, 2.655522546, 2.675599263, 2.69607313, 2.7164701, 2.737067178, 2.757262296, 2.777578268, 2.798103125, 2.818801015, 2.839381149, 2.860120597, 2.876418531, 2.880610489, 2.90103486, 2.921459904, 2.941875159, 2.962471785, 2.983169746, 3.003813323, 3.024643378, 3.045468049, 3.066580373, 3.087611924, 3.108672449, 3.12945314, 3.15044228, 3.171696143, 3.192751679, 3.213865262, 3.235045311, 3.256183498, 3.277262076, 3.298478077, 3.319684269, 3.341070224, 3.362176633, 3.383593746, 3.400318582, 3.405057377, 3.426570051, 3.448257818, 3.46978818, 3.491430998, 3.513196014, 3.534827663, 3.556401098, 3.57831645, 3.600127341, 3.621853197, 3.643698306, 3.665874478, 3.688058215, 3.710322612, 3.732388906, 3.754717555, 3.776965827, 3.799575035, 3.822123945, 3.844612025, 3.867034188, 3.889420657, 3.912245583, 3.935020487, 3.957603467, 3.980493503, 4.003670914, 4.026445517, 4.049438721, 4.072446924, 4.095600441, 4.118563999, 4.142166648, 4.165512679, 4.189095562, 4.212728349, 4.23620956, 4.260106671, 4.283688411, 4.307682061, 4.33133387, 4.355552715, 4.37993191, 4.404277037, 4.42816594, 4.452413817, 4.476339314, 4.50129219, 4.525865142, 4.550494775, 4.575245757, 4.60007012, 4.624972707, 4.650006526, 4.675147181, 4.700308264, 4.725653376, 4.75054382, 4.776164419, 4.80175657, 4.827162329, 4.853034498, 4.878746682, 4.904812962, 4.930867119, 4.956751432, 4.982778582, 5.00920553, 5.035519548, 5.062934137, 5.089272012, 5.115982646, 5.143421169, 5.170304813, 5.197062788, 5.224594751, 5.251507722, 5.278767275, 5.306336873, 5.334225347, 5.362252448, 5.390520993, 5.419026581, 5.447126439, 5.47538812, 5.503807018, 5.532825085, 5.56160233, 5.5905954, 5.619464218, 5.648823163, 5.678217164, 5.707520468, 5.737494701, 5.767033105, 5.773171013, 5.796614658, 5.826552881, 5.857034652, 5.886835259, 5.916920754, 5.947858832, 5.978536113, 6.009248697, 6.039979014, 6.071464334, 6.102191066, 6.133335233, 6.165288995, 6.196793807, 6.228723225, 6.26110458, 6.292632433, 6.324416484, 6.356887339, 6.389218908, 6.42220263, 6.455184718, 6.487829257, 6.520499801, 6.552964742, 6.586071232, 6.618720719, 6.652413226, 6.686385495, 6.721083387, 6.75452151, 6.789059867, 6.822933793, 6.857885145, 6.893080317, 6.927663071, 6.962584099, 6.997710407, 7.032677571, 7.068134322, 7.102923578, 7.137943975, 7.17435133, 7.209661884, 7.246316206, 7.282646, 7.318911158, 7.355924293, 7.39295461, 7.429704585, 7.466602868, 7.50307988, 7.540250382, 7.578173067, 7.615977925, 7.654212232, 7.691476772, 7.729345627, 7.767586599, 7.805249617, 7.843685646, 7.881245454, 7.921295401, 7.961131074, 8.000097379, 8.039150074, 8.078895235, 8.118974796, 8.158438498, 8.198694638, 8.238796506, 8.278685087, 8.318045299, 8.359020349, 8.401817986, 8.441602996, 8.482768233, 8.524718928, 8.565549915, 8.605374274, 8.648580619, 8.689435855, 8.732699111, 8.773036651, 8.813583404, 8.856678932, 8.899891478, 8.940637122, 8.982612798, 9.02582245, 9.069356064, 9.113220583, 9.156287625, 9.200880806, 9.244813879, 9.289094036, 9.333565294, 9.379798999, 9.42202912, 9.46784803, 9.513356519, 9.558033751, 9.603423299, 9.649849209, 9.696920592, 9.742835268, 9.788279745, 9.832744869, 9.878486419, 9.925089239, 9.972066845, 10.015913298, 10.062697817, 10.108487383, 10.15376449, 10.200421563, 10.247881746, 10.295251584, 10.34164177, 10.390086462, 10.436160343, 10.484757971, 10.531102255, 10.57897784, 10.627984315, 10.674716037, 10.719885184, 10.76938425, 10.815904075, 10.863547193, 10.912839118, 10.963782523, 11.013942819, 11.060873851, 11.109156779, 11.157178853, 11.206253009, 11.257222385, 11.308065643, 11.358022625, 11.407106249, 11.455304806, 11.506053432, 11.558281701, 11.60819275, 11.658339793, 11.711264435, 11.764601853, 11.816722092, 11.87010925, 11.919647778, 11.971702815, 12.023919863, 12.075936841, 12.127955799, 12.181751407, 12.234864866, 12.286810036, 12.34220727, 12.394998422, 12.447296541, 12.499279203, 12.556467612, 12.607011051, 12.661487338, 12.714888278, 12.767481186, 12.817276531, 12.870694961, 12.925563833, 12.981304556, 13.037271232, 13.091493957, 13.150249762, 13.206170589, 13.259619461, 13.316337618, 13.374181723, 13.427834689, 13.482205753, 13.539103878, 13.593870735, 13.65072701, 13.711485116, 13.769411521, 13.826543674, 13.884591261, 13.942374711, 14.000455841, 14.057824186, 14.117124959, 14.175702202, 14.239623067, 14.294270122, 14.353205359, 14.411195964, 14.468068479, 14.530781807, 14.593025823, 14.656614826, 14.669063662, 14.718251291, 14.778116081, 14.835727353, 14.896122073, 14.956486932, 15.01586936, 15.080661886, 15.142197481, 15.203720295, 15.26272313, 15.325734174, 15.389165506, 15.449676712, 15.511510388, 15.572855753, 15.634006198, 15.696549319, 15.752855, 15.813128427, 15.881758874, 15.947078106, 16.009525793, 16.070382479, 16.13212618, 16.198920464, 16.265888842, 16.331714017, 16.399673828, 16.462141049, 16.526716014, 16.596730395, 16.653888603, 16.720984636, 16.792000409, 16.858953481, 16.92702052, 16.999528993, 17.062534164, 17.123910464, 17.191244221, 17.258486761, 17.321998718, 17.38637966, 17.457287481, 17.518099354, 17.582847661, 17.64692211, 17.709896789, 17.771620979, 17.844799405, 17.913349711, 17.979433886, 18.049893237, 18.119689345, 18.194530444, 18.262985323, 18.33421336, 18.398423939, 18.467445541, 18.540778106, 18.612348107, 18.678522604, 18.748297035, 18.827027957, 18.895636558, 18.967551076, 19.047419761, 19.118693324, 19.190125579, 19.258209116, 19.322916635, 19.398321218, 19.466864881, 19.536001991, 19.602412585, 19.676774064, 19.754746312, 19.826999198, 19.898049326, 19.978958833, 20.050406773, 20.122084341, 20.194290897, 20.269911089, 20.337739439, 20.418808526, 20.486328997, 20.56261013, 20.643243349, 20.726926451, 20.806164193, 20.873064192, 20.948301164, 21.034662126, 21.112215405, 21.190175651, 21.263888333, 21.3460939, 21.426119335, 21.49015411, 21.569122445, 21.654765138, 21.740202246, 21.817383991, 21.888878364, 21.970201883, 22.043760147, 22.124022015, 22.208716751, 22.295243074, 22.37006097, 22.453346046, 22.554223715, 22.632260032, 22.720541767, 22.817376838, 22.903178272, 22.996204937, 23.080838345, 23.166444549, 23.245451451, 23.32259807, 23.408628043, 23.497007248, 23.578679092, 23.660718733, 23.743037818, 23.8210651, 23.906196806, 23.984371399, 24.058602524, 24.13570984, 24.218701278, 24.29812912, 24.383499752, 24.459330573, 24.547368911, 24.628875781, 24.730341726, 24.829504801, 24.925024647, 25.014406232, 25.100089095, 25.185825667, 25.282681132, 25.35468651, 25.431775711, 25.505977219, 25.595640725, 25.671859477, 25.767118647, 25.862499607, 25.963674815, 26.053909409, 26.152043635, 26.232431236, 26.335996279, 26.428579951, 26.52597517, 26.613990875, 26.715463927, 26.810783758, 26.903927953, 27.005817517, 27.113552244, 27.197190195, 27.277107205, 27.346873909, 27.448091104, 27.554982786, 27.6422186, 27.723810674, 27.827960244, 27.926587899, 28.035485501, 28.132372959, 28.223678618, 28.340178576, 28.416000177, 28.536696751, 28.634478436, 28.725512556, 28.822603204, 28.914669592, 29.008964582, 29.094529658, 29.20625135, 29.305283843, 29.398990346, 29.511065042, 29.631475124, 29.739783621, 29.827191749, 29.922442699, 30.04162369, 30.141401384, 30.245681953, 30.331124292, 30.448209597, 30.541510408, 30.561369793, 30.672494475, 30.780929241, 30.909545208, 31.022431991, 31.158054935, 31.270188111, 31.373148986, 31.491160056, 31.604744387, 31.722657746, 31.847421679, 31.953091328, 32.068279632, 32.185033623, 32.304317783, 32.402845448, 32.51111865, 32.598703332, 32.702851245, 32.810461891, 32.909719877, 32.99324121, 33.094815686, 33.205366211, 33.315510962, 33.405459753, 33.510547189, 33.626006964, 33.746066866, 33.850221994, 33.980389097, 34.079604979, 34.196702756, 34.289971842, 34.393202827, 34.522701797, 34.629195852, 34.725371084, 34.820880227, 34.92083893, 35.023972748, 35.147083372, 35.283099164, 35.401258843, 35.51011167, 35.633796132, 35.734464182, 35.818907767, 35.922135123, 36.054370322, 36.173090531, 36.280918154, 36.417641567, 36.551753433, 36.666460168, 36.785063385, 36.938363596, 37.061891623, 37.16103913, 37.300831818, 37.4202161, 37.512344966, 37.613073215, 37.724507087, 37.887649375, 38.013977621, 38.15150249, 38.28289798, 38.408784731, 38.547000908, 38.65250222, 38.769868093, 38.88994737, 38.99008586, 39.137688057, 39.26365927, 39.368133747, 39.530168008, 39.655982471, 39.776192766, 39.883373149, 39.99432811, 40.137362005, 40.224960187, 40.33940252, 40.470296439, 40.621003695, 40.716953042, 40.854855309, 40.967537447, 41.069795652, 41.152016721, 41.271414581, 41.394090366, 41.468170713, 41.552694137, 41.646984682, 41.835584569, 41.979000808, 42.10420279, 42.211351514, 42.328428348, 42.504966444, 42.607923222, 42.733855874, 42.873267528, 42.998585255, 43.110998886, 43.262738407, 43.448140976, 43.574210749, 43.721159414, 43.86289527, 43.971714625, 44.165019858, 44.278524602, 44.375225855, 44.499807374, 44.590270621, 44.696001541, 44.824895358, 44.950785832, 45.144741466, 45.230270016, 45.331596071, 45.459664598, 45.553099511, 45.69349694, 45.901872225, 46.01332241, 46.175265911, 46.348729669, 46.437005533, 46.550351476, 46.703628155, 46.872419655, 46.999707057, 47.232543913, 47.436191476, 47.572207175, 47.664101465, 47.896300734, 48.089819717, 48.255729188, 48.3483684, 48.436822277, 48.618436121, 48.797606752, 49.032024927, 49.188466421, 49.323349681, 49.414212204, 49.502111061, 49.623631739, 49.865684217, 49.958856076, 50.138635129, 50.272425894, 50.419378852, 50.538209175, 50.617749622, 50.748168135, 50.820726566, 50.939628194, 51.068685018, 51.373324868, 51.64642702, 51.874655062, 52.042578188, 52.178030628, 52.304513572, 52.434147205, 52.543074649, 52.626831808, 52.754036525, 52.811614965, 53.00385667, 53.164094381, 53.339990969, 53.646210198, 53.748578508, 54.019036976, 54.163453505, 54.300288136, 54.474736258, 54.766912287, 55.094810321, 55.173244652, 55.264211753, 55.43145331, 55.676022359, 55.84439681, 56.027592039, 56.285613036, 56.454019976, 56.676770555, 56.824388307, 57.01108887, 57.215661803, 57.435419951, 57.577975984, 57.864305005, 58.169868483, 58.236392886, 58.367642191, 58.527080163, 58.667064935, 58.825557464, 58.958943457, 58.989507119, 59.089437269, 59.357501461, 59.614224581, 59.686204551, 59.80546501, 60.050999409, 60.437658238, 60.663621891, 60.852227437, 60.968359186, 61.125960679, 61.343114946, 61.539419401, 61.752846393, 62.192378273, 62.494208182, 62.666415659, 62.827642987, 62.898918404, 63.058045705, 63.267572807, 63.34982421, 63.414396141, 63.533776221, 63.692219485, 63.848773336, 64.170091501, 64.429318134, 64.710950121, 64.852851386, 64.962947774, 65.143039879, 65.332186156, 65.459118751, 65.578890164, 65.67080561, 65.823783573, 65.996102493, 66.180813901, 66.310363582, 66.482963336, 66.807704547, 66.959651074, 67.240388793, 67.416324357, 67.654921544, 67.818154819, 68.017443634, 68.119851161, 68.378947474, 68.44002366, 68.596258966, 68.619847288, 68.678903626, 69.040362459, 69.197496661, 69.504011389, 69.548852898, 69.815462445, 69.841128832, 70.098281227, 70.203767363, 70.310404639, 70.62535785, 70.931867587, 71.056631738, 71.103693932, 71.190278919, 71.41457454, 71.575424281, 72.126466677, 72.374119111, 72.388187928, 72.835804505, 73.264824979, 73.34026563, 73.591888979, 73.661133291, 73.809734179, 73.86115672, 73.936565439, 74.272126831, 74.513585214, 74.775096778, 74.850932568, 75.31252534, 75.424842618, 75.528873428, 75.584956827, 75.595110519, 75.608130155, 75.658669119, 76.154230117, 76.187842257, 76.249646813, 76.268395596, 76.364943498, 76.394125555, 76.598522787, 77.031511229, 77.103355725, 77.131211483, 77.358088615, 77.480792612, 77.718040932, 77.719374848, 78.077622539, 78.549874316, 78.612048024, 78.867694625, 79.292918126, 79.303189021, 79.370574168, 79.612957854, 79.763449682, 79.885949272, 80.023758765, 80.11709534, 80.274853576, 80.612018386, 80.62324931, 80.631394152, 80.995763814, 81.103803545, 81.184236131, 81.250025678, 81.425645816, 81.534539473, 81.698623699, 82.31976964), "500" = c(1.7727e-05, 1.7783e-05, 1.7991e-05, 1.8408e-05, 1.8545e-05, 1.8714e-05, 1.8763e-05, 1.8792e-05, 1.8891e-05, 1.8948e-05, 1.8991e-05, 1.9625e-05, 1.9958e-05, 2.0019e-05, 2.0322e-05, 2.0513e-05, 2.0749e-05, 2.116e-05, 2.1339e-05, 2.1426e-05, 2.2285e-05, 2.2341e-05, 2.2722e-05, 2.2838e-05, 2.3696e-05, 2.3734e-05, 2.4212e-05, 2.4384e-05, 2.4771e-05, 2.4802e-05, 2.5052e-05, 2.5173e-05, 2.551e-05, 2.5752e-05, 2.6148e-05, 2.6267e-05, 2.6272e-05, 2.6388e-05, 2.7364e-05, 2.7789e-05, 2.7864e-05, 2.8547e-05, 2.8818e-05, 2.924e-05, 2.9504e-05, 2.9683e-05, 3.0157e-05, 3.0701e-05, 3.0823e-05, 3.1171e-05, 3.149e-05, 3.1672e-05, 3.2433e-05, 3.3203e-05, 3.367e-05, 3.4681e-05, 3.5084e-05, 3.5279e-05, 3.5363e-05, 3.5969e-05, 3.662e-05, 3.6758e-05, 3.6845e-05, 3.7058e-05, 3.7293e-05, 3.744e-05, 3.7536e-05, 3.8423e-05, 3.9167e-05, 4.0534e-05, 4.1733e-05, 4.1938e-05, 4.2154e-05, 4.2597e-05, 4.3026e-05, 4.3405e-05, 4.3973e-05, 4.4851e-05, 4.5284e-05, 4.6293e-05, 4.7064e-05, 4.7453e-05, 4.7972e-05, 4.9222e-05, 4.992e-05, 5.0718e-05, 5.1045e-05, 5.16e-05, 5.2104e-05, 5.2664e-05, 5.2941e-05, 5.4143e-05, 5.4529e-05, 5.4793e-05, 5.6915e-05, 5.7641e-05, 5.9264e-05, 5.9791e-05, 6.0639e-05, 6.1945e-05, 6.3041e-05, 6.3524e-05, 6.4227e-05, 6.4942e-05, 6.5779e-05, 6.645e-05, 6.7968e-05, 6.8493e-05, 6.9813e-05, 7.0478e-05, 7.1215e-05, 7.175e-05, 7.229e-05, 7.4107e-05, 7.527e-05, 7.6396e-05, 7.6833e-05, 7.8032e-05, 7.8746e-05, 7.97e-05, 8.0277e-05, 8.1361e-05, 8.2358e-05, 8.3554e-05, 8.4799e-05, 8.5159e-05, 8.6095e-05, 8.6799e-05, 8.7798e-05, 8.8394e-05, 8.8718e-05, 8.9298e-05, 9.042e-05, 9.1361e-05, 9.4037e-05, 9.5389e-05, 9.6244e-05, 9.709e-05, 9.7981e-05, 9.9118e-05, 0.000100306, 0.000101361, 0.000102976, 0.000103808, 0.000105161, 0.00010596, 0.000107509, 0.000109236, 0.000110472, 0.000111353, 0.000112327, 0.000113264, 0.000114781, 0.00011574, 0.000116749, 0.000117981, 0.000119903, 0.000120851, 0.000122887, 0.000123768, 0.000124762, 0.000126462, 0.000127462, 0.000128524, 0.000129949, 0.00013171, 0.000133386, 0.000135788, 0.000137465, 0.000138891, 0.000140846, 0.000141898, 0.000143416, 0.000144303, 0.000146069, 0.000147818, 0.000149558, 0.000151178, 0.000152496, 0.000154012, 0.000155818, 0.000158094, 0.000159168, 0.000161254, 0.00016305, 0.000164538, 0.000167199, 0.000169274, 0.000170696, 0.000173576, 0.000175257, 0.00017653, 0.000178935, 0.000180739, 0.000183356, 0.00018655, 0.000189811, 0.00019121, 0.00019278, 0.000195043, 0.000196566, 0.000200963, 0.000202047, 0.000204421, 0.00020753, 0.000208746, 0.000211526, 0.000213674, 0.000216373, 0.000218032, 0.000220208, 0.000223549, 0.000227275, 0.000230777, 0.000232466, 0.000234382, 0.000237106, 0.000239708, 0.00024261, 0.000245166, 0.000247327, 0.000251654, 0.000254534, 0.000257794, 0.00026056, 0.000264745, 0.0002672, 0.000270403, 0.000272799, 0.000275633, 0.000277761, 0.000279295, 0.000281783, 0.000285206, 0.000288242, 0.000291333, 0.000295802, 0.000300068, 0.000303487, 0.000307137, 0.000310975, 0.000312997, 0.000316359, 0.000321214, 0.000324845, 0.000330302, 0.000333369, 0.000336605, 0.000340501, 0.000345066, 0.000349918, 0.000354898, 0.000358925, 0.00036488, 0.000369245, 0.000372564, 0.000374768, 0.00038048, 0.000384701, 0.000389068, 0.000393812, 0.000397423, 0.000402353, 0.000407619, 0.000411857, 0.000417505, 0.000421575, 0.000426067, 0.000428931, 0.000435315, 0.000438808, 0.000444196, 0.000448275, 0.000451998, 0.000457034, 0.000462493, 0.000465263, 0.000470802, 0.000475549, 0.000478862, 0.000484596, 0.000490522, 0.000495598, 0.000503378, 0.000509144, 0.000516116, 0.000521923, 0.00052719, 0.000533543, 0.000540771, 0.000545602, 0.000553064, 0.000558977, 0.000567465, 0.000573377, 0.000582895, 0.000588935, 0.000595258, 0.000601478, 0.000609005, 0.000615293, 0.000621284, 0.000628816, 0.000636894, 0.000643942, 0.000651241, 0.000657426, 0.0006627, 0.000671226, 0.000681911, 0.000688554, 0.000695512, 0.000703149, 0.000711624, 0.000719066, 0.000727415, 0.000735671, 0.000744275, 0.000754932, 0.000766157, 0.000776249, 0.000787796, 0.000797596, 0.000806906, 0.000816061, 0.000824969, 0.000832518, 0.000844409, 0.000855563, 0.000863515, 0.000873225, 0.000879768, 0.000891763, 0.000902706, 0.000912635, 0.000924044, 0.0009318, 0.000943607, 0.000953494, 0.000963669, 0.000975029, 0.00097888, 0.000987691, 0.000997279, 0.001009691, 0.001019756, 0.001030717, 0.001041081, 0.001054215, 0.001065344, 0.001073662, 0.001088098, 0.001102496, 0.00111247, 0.001129093, 0.001140409, 0.00115381, 0.001167433, 0.001183115, 0.001198521, 0.0012154, 0.001229553, 0.001243345, 0.001257961, 0.001274782, 0.001288804, 0.001300539, 0.001314108, 0.001330962, 0.001346265, 0.001362809, 0.001383477, 0.001398966, 0.001418319, 0.001433089, 0.001451006, 0.001466043, 0.001482515, 0.001495569, 0.00151223, 0.001524874, 0.001548381, 0.00156931, 0.001586793, 0.001604019, 0.001622668, 0.001642967, 0.001661422, 0.001680567, 0.001703788, 0.001722511, 0.001743123, 0.001762335, 0.00177988, 0.001799287, 0.00182004, 0.001840221, 0.00186165, 0.001883112, 0.001904484, 0.001928344, 0.001948684, 0.001972608, 0.00199577, 0.002018736, 0.002044888, 0.002071021, 0.002097235, 0.002122945, 0.002149876, 0.00217529, 0.00219909, 0.0022239, 0.002246988, 0.002270185, 0.002298586, 0.002326894, 0.002352991, 0.00237824, 0.002406758, 0.002435488, 0.002466303, 0.00249548, 0.002521254, 0.002549546, 0.002580839, 0.002614884, 0.002648396, 0.002678341, 0.002711376, 0.002746241, 0.002784082, 0.002816699, 0.002849323, 0.002881222, 0.002913566, 0.002948418, 0.002980681, 0.003016866, 0.003053166, 0.003089022, 0.003124675, 0.003162876, 0.003201588, 0.003238599, 0.003272894, 0.003310682, 0.003348302, 0.003387331, 0.003432126, 0.003472907, 0.003514139, 0.003549837, 0.003589247, 0.003629955, 0.003670133, 0.00371799, 0.003763303, 0.003810067, 0.003855004, 0.003897008, 0.003948839, 0.003995898, 0.004046852, 0.004091308, 0.004140213, 0.004188211, 0.004235087, 0.0042824, 0.004332227, 0.004380904, 0.004434517, 0.004485258, 0.004538118, 0.004589974, 0.004644285, 0.00469734, 0.004751781, 0.004805988, 0.004866046, 0.004926999, 0.004978297, 0.005041672, 0.005100242, 0.005159896, 0.005225132, 0.005285516, 0.005344045, 0.005406639, 0.005471548, 0.005541083, 0.00560061, 0.005668671, 0.005731306, 0.00580118, 0.005869786, 0.005939337, 0.006007329, 0.00607617, 0.006146536, 0.006209105, 0.006281796, 0.006353016, 0.006422175, 0.006491868, 0.006563836, 0.006640692, 0.006718572, 0.006794301, 0.006873586, 0.006951689, 0.007030237, 0.007112833, 0.007191698, 0.007270097, 0.007357195, 0.007442439, 0.007528627, 0.007612709, 0.00769685, 0.007785474, 0.007873259, 0.007970638, 0.008061777, 0.008151188, 0.008242842, 0.008347416, 0.00844203, 0.008540573, 0.008637446, 0.008741672, 0.008839618, 0.008941671, 0.009042671, 0.009149377, 0.009253212, 0.009360084, 0.009467898, 0.009579029, 0.009697314, 0.009812891, 0.009902731, 0.009924934, 0.01004341, 0.010160839, 0.010280894, 0.010394195, 0.010515152, 0.010632054, 0.010753145, 0.010870971, 0.010999679, 0.011122119, 0.011252893, 0.011377273, 0.011506134, 0.011629036, 0.011766531, 0.011907155, 0.012044695, 0.012186392, 0.012327229, 0.012473083, 0.012618368, 0.012766531, 0.012905646, 0.013051729, 0.013210558, 0.013359191, 0.013521362, 0.013677249, 0.013836351, 0.014001354, 0.014149048, 0.014311886, 0.014482396, 0.014644934, 0.014807731, 0.014995878, 0.015171166, 0.015352825, 0.015522532, 0.015688935, 0.015869923, 0.016056611, 0.016248947, 0.016442098, 0.01662586, 0.016823216, 0.017015342, 0.017208924, 0.017408074, 0.017612464, 0.017815905, 0.018003737, 0.018202284, 0.018421603, 0.018639085, 0.018860198, 0.019077347, 0.01929289, 0.019513928, 0.01975137, 0.019971156, 0.020207952, 0.020447182, 0.020700311, 0.020943615, 0.02117714, 0.021416261, 0.021660473, 0.021910526, 0.02215964, 0.022395157, 0.022661611, 0.022926701, 0.023203637, 0.02346564, 0.023729936, 0.024006155, 0.024291853, 0.024577178, 0.024848353, 0.025139984, 0.025432202, 0.025721293, 0.02600402, 0.026319233, 0.026633027, 0.026952569, 0.027274568, 0.027589022, 0.027906081, 0.02824184, 0.028566374, 0.02890281, 0.02924324, 0.02959762, 0.029932227, 0.030284202, 0.030638711, 0.030977415, 0.031331497, 0.031685632, 0.032065728, 0.032432391, 0.032813811, 0.033181451, 0.033573165, 0.033965966, 0.03437743, 0.034776785, 0.035181456, 0.035594747, 0.036013743, 0.036428654, 0.036848414, 0.037281858, 0.037721108, 0.038181028, 0.038635977, 0.039093152, 0.039554408, 0.040006857, 0.040464257, 0.040936093, 0.041404087, 0.041885207, 0.042374164, 0.042873764, 0.043373339, 0.043877803, 0.044392459, 0.044899095, 0.045430021, 0.045957049, 0.046490207, 0.047044507, 0.047599772, 0.048150603, 0.048730087, 0.049312599, 0.049893273, 0.050488539, 0.05109333, 0.051712332, 0.052324527, 0.052938859, 0.053557827, 0.0541861, 0.054819561, 0.055446066, 0.056108742, 0.056791013, 0.057457735, 0.058122283, 0.058799883, 0.059506015, 0.060200977, 0.060922853, 0.061632516, 0.062347456, 0.063090069, 0.063823191, 0.064580302, 0.065328658, 0.066074961, 0.066852687, 0.067647855, 0.068449441, 0.069262015, 0.070069705, 0.070876522, 0.071726028, 0.072559297, 0.073413516, 0.07428699, 0.075155442, 0.076050621, 0.076933707, 0.077828158, 0.078765439, 0.079672288, 0.080609223, 0.081546131, 0.08253084, 0.083477668, 0.084465374, 0.085459994, 0.086449478, 0.087470002, 0.088489321, 0.089550016, 0.090627782, 0.091695974, 0.09278169, 0.093862415, 0.094973727, 0.096097182, 0.097245312, 0.098400938, 0.09955397, 0.10051167, 0.100745279, 0.101958465, 0.103162363, 0.104368375, 0.105607529, 0.106876297, 0.108135732, 0.109392875, 0.11069744, 0.11201332, 0.113378493, 0.114721644, 0.11611093, 0.117496588, 0.118880059, 0.120303768, 0.121769391, 0.123199732, 0.124663139, 0.126122397, 0.127592563, 0.129114619, 0.130645527, 0.132206987, 0.133751847, 0.135387498, 0.136984598, 0.138612526, 0.140265034, 0.141921283, 0.143626405, 0.145378635, 0.14712739, 0.14889396, 0.150706048, 0.152507023, 0.154329804, 0.156187798, 0.158083891, 0.159982902, 0.161909059, 0.163852207, 0.165804151, 0.167805186, 0.169810891, 0.17187395, 0.173939071, 0.176051551, 0.178177183, 0.180351197, 0.182557626, 0.184751815, 0.186997434, 0.189234347, 0.191526259, 0.193831608, 0.196205497, 0.198628468, 0.201049966, 0.203517331, 0.206033258, 0.208503211, 0.210995201, 0.213512453, 0.216114634, 0.218737409, 0.221400069, 0.224038969, 0.226769501, 0.229529793, 0.232310671, 0.235138335, 0.238031694, 0.240927908, 0.243917304, 0.246852235, 0.249891455, 0.252910707, 0.256028504, 0.259177299, 0.262383481, 0.265629218, 0.26890343, 0.272199737, 0.275541387, 0.27895663, 0.282327857, 0.285856507, 0.289370675, 0.292986132, 0.296578276, 0.300261682, 0.303932607, 0.307691835, 0.311513211, 0.315425705, 0.316281525, 0.319351896, 0.323307816, 0.327279764, 0.331357641, 0.335570856, 0.339814632, 0.344091159, 0.348403509, 0.352784598, 0.357158199, 0.361660983, 0.366263062, 0.370920253, 0.375566717, 0.380351133, 0.385108638, 0.389986574, 0.394946129, 0.399996546, 0.405054319, 0.410180469, 0.415356909, 0.420615826, 0.425897041, 0.431344766, 0.432469727, 0.436910902, 0.442509538, 0.448184789, 0.453840651, 0.459686868, 0.465585783, 0.47151114, 0.477522262, 0.483715693, 0.49003185, 0.496443416, 0.502848726, 0.509325627, 0.515945604, 0.522660364, 0.529545806, 0.536434074, 0.543505098, 0.550634729, 0.55792048, 0.565277486, 0.572798936, 0.580420835, 0.588091292, 0.595956787, 0.603838857, 0.611901322, 0.620025291, 0.628340015, 0.63683342, 0.645415402, 0.654079783, 0.662941319, 0.672020268, 0.681219062, 0.685067114, 0.690465978, 0.699845077, 0.709394843, 0.719185127, 0.729067247, 0.739295123, 0.749548319, 0.759836407, 0.770347176, 0.781127874, 0.792128259, 0.803228249, 0.814530822, 0.826018006, 0.837758601, 0.849710799, 0.861850189, 0.874202187, 0.886800598, 0.899520663, 0.912621469, 0.925867319, 0.939349693, 0.953139238, 0.967307531, 0.973184782, 0.981605903, 0.996244465, 1.011054819, 1.026177918, 1.041528957, 1.05722549, 1.073136443, 1.089461743, 1.106013386, 1.123035164, 1.140331321, 1.158204911, 1.176268558, 1.194937424, 1.213789512, 1.233148437, 1.252814013, 1.272931499, 1.293507888, 1.310094831, 1.347914446, 1.368997397, 1.390106943, 1.411101797, 1.432213187, 1.453163783, 1.47421191, 1.495157288, 1.516250281, 1.537146438, 1.558357387, 1.57950644, 1.600501685, 1.621441631, 1.642367315, 1.663305906, 1.684128763, 1.705056276, 1.717465687, 1.726162603, 1.74728048, 1.768372316, 1.789367163, 1.810414388, 1.831338973, 1.85227706, 1.873159203, 1.894217334, 1.915215721, 1.936245586, 1.957203048, 1.978355776, 1.999505854, 2.020627059, 2.041761792, 2.06265371, 2.083650581, 2.10471774, 2.125650899, 2.146618044, 2.167699471, 2.188736133, 2.209611668, 2.230571658, 2.242686644, 2.251617637, 2.272585791, 2.29368983, 2.314549013, 2.335665081, 2.356690225, 2.377848502, 2.398749402, 2.419806603, 2.440856588, 2.462116242, 2.483173685, 2.504314658, 2.52525356, 2.546400504, 2.567483312, 2.588685547, 2.609810849, 2.630787309, 2.651753099, 2.672849518, 2.693943654, 2.715066824, 2.73646266, 2.757480569, 2.778825597, 2.80001159, 2.821362841, 2.842669667, 2.86391437, 2.885392251, 2.906841936, 2.92819327, 2.949725164, 2.97098111, 2.988200105, 2.992545883, 3.014003201, 3.035548395, 3.057013277, 3.078532186, 3.100233985, 3.121954919, 3.143485934, 3.165000948, 3.186550741, 3.208172768, 3.229827686, 3.25175922, 3.273709208, 3.295475884, 3.317362359, 3.339312972, 3.361041203, 3.383190761, 3.40489858, 3.42662666, 3.44855929, 3.47039153, 3.492419221, 3.514241966, 3.531215809, 3.535946369, 3.558254201, 3.580300952, 3.602516069, 3.624872315, 3.646915918, 3.669513878, 3.691438172, 3.713888148, 3.736308469, 3.758725662, 3.781208553, 3.804112593, 3.826337032, 3.848694925, 3.871019349, 3.893840141, 3.916139817, 3.938762623, 3.961724382, 3.984293544, 4.006963148, 4.029931461, 4.052749686, 4.075579188, 4.09861402, 4.121853873, 4.144771479, 4.167942103, 4.191517284, 4.215020148, 4.238252855, 4.261309056, 4.285037719, 4.308323692, 4.331724901, 4.355058651, 4.37860298, 4.402100123, 4.425842672, 4.44972818, 4.473444734, 4.49736209, 4.521020312, 4.544760554, 4.568468034, 4.592352166, 4.616238479, 4.640188739, 4.664437949, 4.688588414, 4.712683916, 4.736755919, 4.761350155, 4.786060392, 4.810970362, 4.835776919, 4.859837818, 4.884432505, 4.909407267, 4.934400349, 4.959371413, 4.984335233, 5.009227017, 5.034557744, 5.059380904, 5.084720389, 5.110443662, 5.135385611, 5.16036355, 5.186579623, 5.212076284, 5.237707223, 5.263375099, 5.288670427, 5.314354765, 5.339865038, 5.366196621, 5.391960743, 5.418436531, 5.444866418, 5.47113315, 5.497361402, 5.524189925, 5.551064221, 5.578033251, 5.604529297, 5.631532451, 5.658526091, 5.684958518, 5.712399376, 5.739941203, 5.767304476, 5.794484434, 5.822064341, 5.849358308, 5.855076347, 5.877687309, 5.905566023, 5.934614022, 5.961634481, 5.989596649, 6.017720069, 6.045757496, 6.07406089, 6.102386187, 6.130747145, 6.15893939, 6.187267972, 6.216107016, 6.245327291, 6.274139284, 6.303702664, 6.332928671, 6.363132702, 6.391828563, 6.420994407, 6.450010405, 6.479365359, 6.50925137, 6.538856277, 6.569730675, 6.600015843, 6.630340794, 6.660902819, 6.691815416, 6.722511051, 6.754263652, 6.785016193, 6.815966283, 6.846684449, 6.877745805, 6.90880202, 6.939908808, 6.971921128, 7.003502936, 7.034776354, 7.0664353, 7.098534171, 7.130539917, 7.162295333, 7.194101964, 7.22596642, 7.258190147, 7.291164917, 7.324773521, 7.356925707, 7.389530297, 7.423474228, 7.455760261, 7.488576038, 7.522141716, 7.555018531, 7.588339528, 7.62145348, 7.654909128, 7.689943998, 7.724621817, 7.758015029, 7.793238566, 7.826815383, 7.861585672, 7.896190576, 7.930342295, 7.9644243, 7.999166692, 8.034824165, 8.070220332, 8.105397817, 8.140242774, 8.174818448, 8.211098741, 8.245201036, 8.282044821, 8.317873829, 8.353479786, 8.389041124, 8.425041782, 8.460407839, 8.497160261, 8.533744848, 8.568664918, 8.605523838, 8.642962345, 8.679795476, 8.716859898, 8.754538942, 8.792981718, 8.830394793, 8.869133627, 8.906127958, 8.9433922, 8.980354944, 9.018389543, 9.056671516, 9.096085726, 9.134819557, 9.17421137, 9.214075491, 9.253618707, 9.292498096, 9.332026869, 9.370493219, 9.409274537, 9.449021459, 9.48971517, 9.5306034, 9.572122758, 9.613081636, 9.656210351, 9.697383253, 9.736981218, 9.77607962, 9.816362029, 9.857432734, 9.898872538, 9.939590093, 9.981122592, 10.020767572, 10.059825075, 10.101330796, 10.143877454, 10.184840735, 10.226754963, 10.269772967, 10.313101036, 10.353581143, 10.396429669, 10.439252639, 10.481105333, 10.522000081, 10.564038924, 10.606199912, 10.650076642, 10.692380731, 10.735774294, 10.778293955, 10.819785717, 10.862496117, 10.905647546, 10.948875753, 10.991933952, 11.03695833, 11.079989033, 11.123080228, 11.168795573, 11.212338286, 11.258279597, 11.303666586, 11.345954491, 11.390983152, 11.435836584, 11.481614036, 11.528660714, 11.570434238, 11.615462125, 11.65868236, 11.700316931, 11.744658725, 11.790121964, 11.835762221, 11.880502608, 11.926107928, 11.973496249, 12.017983645, 12.066532372, 12.115241279, 12.161493044, 12.210600208, 12.25707086, 12.302841703, 12.353692517, 12.403390373, 12.448809576, 12.497752698, 12.546367687, 12.595283535, 12.644112372, 12.691040632, 12.740738166, 12.790027422, 12.836530034, 12.883923934, 12.930781988, 12.977968361, 13.029062074, 13.080349176, 13.131906022, 13.181067834, 13.225047163, 13.274595722, 13.326100112, 13.375513197, 13.424074524, 13.473910138, 13.522662432, 13.571467304, 13.583278605, 13.62153765, 13.670268387, 13.720353151, 13.773984815, 13.827040037, 13.872791782, 13.923674013, 13.975229157, 14.024485967, 14.073718061, 14.125786107, 14.172298065, 14.223621964, 14.275997998, 14.330267293, 14.384277573, 14.437095555, 14.490727094, 14.540463983, 14.595616561, 14.647229974, 14.698224272, 14.74847984, 14.801944669, 14.858099413, 14.909906967, 14.964985317, 15.017907707, 15.073853655, 15.125821167, 15.174416744, 15.22850578, 15.288246736, 15.339712563, 15.391103097, 15.44410959, 15.504738324, 15.562980915, 15.621180943, 15.67439692, 15.72229515, 15.774534974, 15.833379409, 15.882758006, 15.938258414, 15.991902054, 16.045356894, 16.106466633, 16.164227727, 16.220779299, 16.280192709, 16.333173018, 16.388827573, 16.446902081, 16.503364759, 16.561872339, 16.618912203, 16.672553605, 16.733541168, 16.787504836, 16.845175649, 16.906495412, 16.962409815, 17.02389628, 17.078121974, 17.131804732, 17.190566478, 17.247522058, 17.303279808, 17.356264183, 17.41694397, 17.480291157, 17.532844013, 17.593195859, 17.653760281, 17.70745985, 17.76297287, 17.820953431, 17.881277186, 17.946674701, 18.004377169, 18.06469833, 18.121995639, 18.172840451, 18.236411729, 18.290531417, 18.348568169, 18.415394253, 18.477686102, 18.539721805, 18.600419414, 18.662010917, 18.72757394, 18.782296987, 18.842686061, 18.905403082, 18.97856359, 19.03715941, 19.097098854, 19.162605704, 19.233789819, 19.30814108, 19.374235742, 19.443868777, 19.51253113, 19.569157473, 19.639216503, 19.701676626, 19.768399772, 19.830234003, 19.88925016, 19.951571823, 20.013798989, 20.068233249, 20.128331443, 20.18606867, 20.255140598, 20.315737773, 20.378135268, 20.450182369, 20.512643432, 20.576309952, 20.636682586, 20.700241558, 20.75846262, 20.83050942, 20.900457817, 20.974882106, 21.043983107, 21.119410686, 21.184047531, 21.24865178, 21.311978073, 21.376039868, 21.454420766, 21.518505355, 21.587484445, 21.667522128, 21.745187798, 21.811795858, 21.874716156, 21.931866281, 21.99884695, 22.058709273, 22.126284313, 22.204105741, 22.266784574, 22.346906418, 22.417370775, 22.493837653, 22.567513284, 22.624410352, 22.692659159, 22.764590049, 22.833074459, 22.911132845, 22.989957666, 23.05569752, 23.144314228, 23.216522006, 23.288392784, 23.369594627, 23.444583857, 23.52681675, 23.587631319, 23.653194219, 23.734973995, 23.801097841, 23.884243953, 23.960228782, 24.04626963, 24.118637908, 24.203486417, 24.266963229, 24.3436674, 24.431085037, 24.504590379, 24.584128823, 24.659874118, 24.730169447, 24.808478872, 24.893258874, 24.967208034, 25.034847083, 25.106807758, 25.180460379, 25.254989514, 25.338176016, 25.412309077, 25.479314445, 25.545270102, 25.626355523, 25.699051545, 25.783172, 25.850817367, 25.926617522, 26.01115069, 26.104713704, 26.183670074, 26.251953279, 26.270434251, 26.335101792, 26.414426189, 26.4840813, 26.557051121, 26.620754386, 26.706483838, 26.7961142, 26.859980836, 26.930232214, 27.003527583, 27.079970372, 27.143575919, 27.238863898, 27.325145504, 27.409137649, 27.488697787, 27.587225983, 27.650702359, 27.734933876, 27.827287772, 27.917506841, 27.985401173, 28.050168707, 28.1170351, 28.197831346, 28.29219971, 28.360285523, 28.448750307, 28.50844264, 28.569487245, 28.64150682, 28.738339009, 28.836134989, 28.907258971, 28.978370957, 29.053181598, 29.142181168, 29.244159508, 29.358124722, 29.444160923, 29.522786587, 29.622356858, 29.711525936, 29.805643696, 29.901196465, 29.984323467, 30.082080128, 30.141589931, 30.226820702, 30.332886053, 30.426340064, 30.525366339, 30.604117914, 30.694364542, 30.75502441, 30.822756083, 30.903805249, 30.974394139, 31.071296947, 31.141872347, 31.239979795, 31.31830467, 31.415000168, 31.51458897, 31.60070835, 31.705531702, 31.802114948, 31.885111835, 31.973019286, 32.079611786, 32.180116783, 32.266831118, 32.346506654, 32.433487956, 32.510794328, 32.583070835, 32.66186898, 32.76474811, 32.841674688, 32.947540911, 33.043801247, 33.134557086, 33.202298943, 33.294066152, 33.399245851, 33.471695598, 33.550967609, 33.642942406, 33.711564341, 33.803878449, 33.915664742, 34.038237794, 34.117399315, 34.20305049, 34.300131372, 34.411720584, 34.497866655, 34.575927078, 34.718556114, 34.814612629, 34.939670601, 35.01887465, 35.121716343, 35.210082838, 35.316131351, 35.443828943, 35.503893216, 35.597413682, 35.708495817, 35.805683747, 35.92966752, 36.032208999, 36.112871172, 36.221446679, 36.306179814, 36.392085493, 36.455710302, 36.550528386, 36.661331131, 36.774441435, 36.896481046, 36.995915162, 37.114205277, 37.307936677, 37.372325907, 37.468541607, 37.59589792, 37.692726939, 37.780751253, 37.852353514, 37.937066126, 38.037629249, 38.122702748, 38.227123795, 38.315172541, 38.432670613, 38.504429711, 38.637043623, 38.743988896, 38.846835626, 38.938346458, 39.04925242, 39.12090335, 39.259339913, 39.43272336, 39.571169039, 39.688484404, 39.811952402, 39.88747621, 39.978514296, 40.152381637, 40.35420855, 40.47737408, 40.629437242, 40.71406671, 40.802638002, 40.900231613, 41.013359021, 41.066760418, 41.221772922, 41.254800113, 41.336641019, 41.413266897, 41.532232229, 41.659154225, 41.832218643, 41.989340964, 42.156357208, 42.350528262, 42.557426724, 42.716287116, 42.842791642, 42.962978638, 43.088424316, 43.170713335, 43.252338646, 43.392347329, 43.623411776, 43.742352433, 43.839051544, 43.963934149, 44.070506128, 44.210742642, 44.349104483, 44.51938569, 44.570202015, 44.7407275, 44.823576049, 44.922529232, 45.058292382, 45.246381369, 45.366841376, 45.499271901, 45.643248931, 45.74817614, 45.873836129, 46.054139531, 46.18166215, 46.265343449, 46.352181395, 46.493917035, 46.545156851, 46.663235357, 46.765975967, 46.906295072, 47.037135557, 47.221724244, 47.351247662, 47.454489265, 47.740961432, 47.848232088, 47.878701173, 47.963836445, 48.008463222, 48.090772223, 48.203768141, 48.359235538, 48.494209921, 48.570769658, 48.709369295, 48.828085676, 48.947716414, 49.020031566, 49.223130906, 49.326867849, 49.517625629, 49.605716455, 49.797397589, 49.870684792, 50.020020269, 50.097160278, 50.244484583, 50.353299699, 50.504834441, 50.627467307, 50.72745666, 50.920703428, 51.00395578, 51.041832635, 51.134321084, 51.159901503, 51.216717344, 51.39030106, 51.551228399, 51.662520596, 51.884516052, 51.92966626, 52.148738385, 52.263186595, 52.336500125, 52.394326305, 52.488747648, 52.532897541, 52.604258799, 52.691128236, 53.05332628, 53.14078459, 53.225779987, 53.281008836, 53.414404677, 53.441322584, 53.681770521, 53.694230978, 53.843162277, 53.963210871, 54.31860899, 54.473101598, 54.618985084, 54.877298374, 54.889409298, 55.02445277, 55.122625352, 55.24297253, 55.279995439, 55.457580906, 55.664956501, 55.784405531, 55.939632838, 56.065305511, 56.251033535, 56.442475283, 56.78838921, 56.889339906, 56.99019936, 57.229974196, 57.302226227, 57.463457122, 57.848818639, 57.861634863, 58.247427407, 58.457916107, 58.627570224, 58.699933805, 58.885187424, 59.141793196, 59.393869028, 59.436952332, 59.456462918, 59.810941211, 59.818702583, 59.859622556, 59.979651423, 60.091443656, 60.193932725, 60.312181312, 60.690692628, 60.862491777, 61.016853065, 61.493252421, 61.608483439, 61.615160437, 61.85277233, 61.861245408, 61.878085226, 61.953124292, 62.005839737, 62.115374149, 62.124593348, 62.526706878, 62.576074343, 62.801782775, 62.8111522, 63.695240466, 63.73759467, 63.764742436, 63.914770902, 64.002200845, 64.17089253, 64.222479267, 64.278562144, 64.309101302, 64.46963618, 64.622212181, 65.106949353, 65.151571662, 65.279203719, 65.312775935, 65.474624735, 65.500287029, 65.548105079), "800" = c(1.8108e-05, 1.832e-05, 1.8396e-05, 1.9144e-05, 1.9624e-05, 1.9675e-05, 1.9719e-05, 1.9796e-05, 1.9973e-05, 2.016e-05, 2.0678e-05, 2.0689e-05, 2.0749e-05, 2.0854e-05, 2.097e-05, 2.1135e-05, 2.1507e-05, 2.2497e-05, 2.2568e-05, 2.2834e-05, 2.286e-05, 2.2917e-05, 2.3389e-05, 2.363e-05, 2.4641e-05, 2.5145e-05, 2.5413e-05, 2.6076e-05, 2.6558e-05, 2.6929e-05, 2.6958e-05, 2.7089e-05, 2.7236e-05, 2.7562e-05, 2.7962e-05, 2.8094e-05, 2.8294e-05, 2.8501e-05, 2.9344e-05, 2.9468e-05, 2.9696e-05, 3.0048e-05, 3.0703e-05, 3.1276e-05, 3.1572e-05, 3.2661e-05, 3.2903e-05, 3.3799e-05, 3.4179e-05, 3.4695e-05, 3.5333e-05, 3.5783e-05, 3.5933e-05, 3.6643e-05, 3.672e-05, 3.721e-05, 3.7707e-05, 3.7969e-05, 3.8077e-05, 3.8672e-05, 3.918e-05, 3.955e-05, 4.0456e-05, 4.1666e-05, 4.2088e-05, 4.2217e-05, 4.3073e-05, 4.3228e-05, 4.3629e-05, 4.3808e-05, 4.4718e-05, 4.5046e-05, 4.5476e-05, 4.615e-05, 4.6254e-05, 4.6668e-05, 4.6919e-05, 4.7581e-05, 4.797e-05, 4.8509e-05, 4.8735e-05, 4.9749e-05, 5.033e-05, 5.0938e-05, 5.2181e-05, 5.2254e-05, 5.2694e-05, 5.3504e-05, 5.382e-05, 5.4814e-05, 5.5509e-05, 5.5957e-05, 5.6232e-05, 5.6933e-05, 5.7824e-05, 5.8666e-05, 5.9708e-05, 5.9804e-05, 6.0264e-05, 6.1252e-05, 6.1559e-05, 6.3101e-05, 6.3653e-05, 6.3879e-05, 6.4122e-05, 6.5234e-05, 6.5777e-05, 6.6376e-05, 6.7282e-05, 6.7513e-05, 6.804e-05, 6.894e-05, 6.9292e-05, 6.9698e-05, 7.0611e-05, 7.1508e-05, 7.2262e-05, 7.3036e-05, 7.3685e-05, 7.4491e-05, 7.6459e-05, 7.7285e-05, 7.8008e-05, 7.9224e-05, 8.0211e-05, 8.1334e-05, 8.2146e-05, 8.2705e-05, 8.3716e-05, 8.4527e-05, 8.5316e-05, 8.5801e-05, 8.6968e-05, 8.7896e-05, 8.8317e-05, 8.9019e-05, 8.9775e-05, 9.0345e-05, 9.178e-05, 9.2925e-05, 9.4182e-05, 9.563e-05, 9.6442e-05, 9.7195e-05, 9.8317e-05, 0.000100427, 0.000101681, 0.000103117, 0.000104871, 0.000106612, 0.000107576, 0.000108377, 0.000110008, 0.000111909, 0.000113122, 0.000113767, 0.000115216, 0.000116688, 0.000119062, 0.000120503, 0.000121683, 0.000123859, 0.000125188, 0.000127855, 0.000129711, 0.000130975, 0.00013207, 0.000133419, 0.000134469, 0.000135597, 0.000136166, 0.000138857, 0.000140575, 0.000142381, 0.000143987, 0.00014497, 0.000147178, 0.000149426, 0.000152749, 0.000154177, 0.000155289, 0.00015752, 0.000159316, 0.000160825, 0.000162776, 0.000163847, 0.000165209, 0.000167432, 0.000169541, 0.000170984, 0.000173275, 0.000174144, 0.000176129, 0.000177875, 0.000180616, 0.000182766, 0.000184611, 0.000185813, 0.000187442, 0.000191185, 0.000192918, 0.00019445, 0.000198585, 0.000200485, 0.000203394, 0.000205631, 0.000207426, 0.000209267, 0.000210978, 0.000213445, 0.000216995, 0.000219402, 0.000223152, 0.000225723, 0.000229215, 0.000232169, 0.000233247, 0.000236712, 0.000239604, 0.000241182, 0.000242707, 0.000247053, 0.000249365, 0.000252222, 0.000254428, 0.000259007, 0.000261546, 0.000265616, 0.000268184, 0.000270317, 0.000272599, 0.000275709, 0.000279524, 0.000281582, 0.000286284, 0.000290296, 0.000294075, 0.000298009, 0.000301891, 0.000304032, 0.000306879, 0.000309991, 0.000313723, 0.000317039, 0.00031954, 0.000323694, 0.000326621, 0.000330602, 0.000334408, 0.000337638, 0.000341859, 0.000345932, 0.000349398, 0.000353956, 0.000358282, 0.000361813, 0.00036561, 0.000369921, 0.000374151, 0.000377868, 0.000381661, 0.000384815, 0.000389587, 0.000394591, 0.000399601, 0.000404665, 0.000406739, 0.000414729, 0.000419794, 0.000424569, 0.00042887, 0.000434022, 0.000438365, 0.000442833, 0.000447544, 0.000451709, 0.000457116, 0.000464003, 0.000472329, 0.000477253, 0.000483172, 0.000487043, 0.000492364, 0.000496786, 0.000500445, 0.000507175, 0.000513619, 0.000519309, 0.000526175, 0.000532921, 0.00054041, 0.000546011, 0.00055221, 0.000560436, 0.000566658, 0.000572262, 0.000579151, 0.000589154, 0.000594311, 0.000602149, 0.00060875, 0.000613302, 0.000621274, 0.000629165, 0.000636811, 0.000645304, 0.000655765, 0.000664242, 0.000671972, 0.00068389, 0.000692002, 0.000701345, 0.000708359, 0.000718033, 0.000724585, 0.000732792, 0.000744117, 0.000753018, 0.000759807, 0.00076674, 0.000774994, 0.000784532, 0.00079085, 0.000800376, 0.00081235, 0.000820168, 0.000829896, 0.000840501, 0.000848969, 0.000860798, 0.000872561, 0.00088513, 0.000894354, 0.000904182, 0.000913724, 0.000925379, 0.000935995, 0.000949317, 0.000961676, 0.000970516, 0.000977623, 0.000979744, 0.000989724, 0.001001614, 0.001014322, 0.001026698, 0.001040247, 0.001052061, 0.001065608, 0.001076677, 0.001088945, 0.001099753, 0.00111236, 0.00112602, 0.001139526, 0.001151324, 0.001165954, 0.001179366, 0.001193053, 0.001207212, 0.001220908, 0.001233998, 0.001247813, 0.001259462, 0.001274147, 0.001291047, 0.001305615, 0.001326261, 0.001341772, 0.001359816, 0.001376192, 0.001393094, 0.001408549, 0.001425503, 0.001440151, 0.001457609, 0.001475398, 0.001492933, 0.001506534, 0.001519532, 0.001538918, 0.001559533, 0.001579349, 0.001597292, 0.001618932, 0.001637961, 0.001656966, 0.001676365, 0.001702013, 0.001722216, 0.001742225, 0.001762931, 0.001784901, 0.001804889, 0.001827589, 0.001852849, 0.001876463, 0.001898146, 0.001918747, 0.001935088, 0.001958096, 0.001980329, 0.00200222, 0.00202425, 0.00204841, 0.002068816, 0.002090524, 0.002115207, 0.002141229, 0.002169187, 0.002191191, 0.002214917, 0.002245719, 0.002274631, 0.002295635, 0.002325634, 0.002355626, 0.002383255, 0.002410676, 0.00243704, 0.002467735, 0.002491641, 0.002517627, 0.0025505, 0.002576188, 0.002608096, 0.002642165, 0.002674015, 0.002702292, 0.002732567, 0.002764067, 0.002795308, 0.002829219, 0.002863027, 0.002895166, 0.002929261, 0.002967645, 0.003002384, 0.003036496, 0.003073059, 0.003107634, 0.003144398, 0.003178909, 0.003208575, 0.003242681, 0.003277743, 0.003318352, 0.00336073, 0.003402726, 0.003444134, 0.003483601, 0.003532343, 0.003570043, 0.003608339, 0.003647884, 0.003691381, 0.003736881, 0.003778408, 0.003818663, 0.003859688, 0.003912182, 0.00395865, 0.004000996, 0.004045923, 0.004092064, 0.004137124, 0.004182144, 0.004228332, 0.004277583, 0.004331734, 0.004379976, 0.004430171, 0.004479488, 0.004535438, 0.004584301, 0.004636742, 0.004691653, 0.004746295, 0.004801342, 0.004856894, 0.004912587, 0.004963274, 0.005022943, 0.005073144, 0.005136062, 0.005191773, 0.00525092, 0.005311847, 0.005370738, 0.005434212, 0.00549046, 0.005548888, 0.005607325, 0.005672382, 0.005742418, 0.005803947, 0.005871165, 0.005935847, 0.006000986, 0.006067272, 0.0061338, 0.006207709, 0.006279292, 0.006351454, 0.006422648, 0.006501579, 0.006582876, 0.006660207, 0.00673653, 0.006821572, 0.006888887, 0.0069739, 0.007056781, 0.007144438, 0.007223588, 0.00730703, 0.007389568, 0.007474561, 0.007561729, 0.007650837, 0.007741739, 0.007828452, 0.007918015, 0.008005355, 0.008099896, 0.008192255, 0.008281328, 0.008372608, 0.00846794, 0.008558765, 0.008656178, 0.008757307, 0.008858086, 0.008953954, 0.009052753, 0.009161917, 0.009263644, 0.009373948, 0.009474421, 0.009591261, 0.009702701, 0.009792787, 0.009818312, 0.009930949, 0.010042691, 0.010164239, 0.010280746, 0.010395481, 0.010525292, 0.010649418, 0.010779804, 0.010908005, 0.011043979, 0.011169642, 0.011300875, 0.011428678, 0.01156349, 0.011694678, 0.011832287, 0.011969795, 0.012110226, 0.012251462, 0.012387477, 0.012518108, 0.012671865, 0.012826036, 0.012973635, 0.013130342, 0.013283597, 0.013440022, 0.01360439, 0.013760411, 0.013923431, 0.014081029, 0.014245442, 0.014416161, 0.01457826, 0.014754165, 0.014924356, 0.015088553, 0.015271326, 0.015452731, 0.015629196, 0.015814648, 0.016001195, 0.016200431, 0.01638547, 0.016575873, 0.016778334, 0.016954494, 0.017142099, 0.01733968, 0.017549735, 0.017751063, 0.017973412, 0.018176172, 0.018393707, 0.018602969, 0.018823097, 0.019048975, 0.019273237, 0.019510431, 0.019745228, 0.01998926, 0.020228996, 0.0204622, 0.020694007, 0.020946242, 0.021186846, 0.021431987, 0.021692925, 0.021943025, 0.022209498, 0.022457031, 0.022717787, 0.022990181, 0.023243914, 0.023509625, 0.023778184, 0.02405661, 0.024337971, 0.02462817, 0.024925066, 0.025226504, 0.025532113, 0.025815674, 0.026102691, 0.026395319, 0.026703785, 0.027024305, 0.027345658, 0.02766503, 0.027988823, 0.028327582, 0.028648035, 0.02898199, 0.029332886, 0.02966028, 0.030008881, 0.030353873, 0.030729176, 0.031109381, 0.031456613, 0.031824369, 0.032197953, 0.032573675, 0.032957024, 0.033346346, 0.033736774, 0.034138531, 0.034542956, 0.03495637, 0.035343223, 0.035765313, 0.03617857, 0.03660814, 0.03705231, 0.037493673, 0.037920611, 0.038357022, 0.038806771, 0.039273388, 0.039734846, 0.040201606, 0.040669582, 0.041144628, 0.041628665, 0.042117831, 0.042620894, 0.043107105, 0.043611714, 0.044127726, 0.044647068, 0.045159922, 0.045697025, 0.046232414, 0.046787859, 0.047336319, 0.047910045, 0.048472522, 0.049045535, 0.04961829, 0.050188653, 0.050781205, 0.051371682, 0.051958667, 0.052560485, 0.053157208, 0.053784047, 0.054401754, 0.055039863, 0.055683523, 0.056340133, 0.056988735, 0.057674032, 0.058335417, 0.059035447, 0.059731487, 0.060437231, 0.061176011, 0.06191328, 0.062628485, 0.063356821, 0.064118005, 0.064883587, 0.065643543, 0.066408781, 0.067174457, 0.067991015, 0.068786106, 0.069566743, 0.070378622, 0.071204927, 0.072033051, 0.072875721, 0.07372602, 0.074583551, 0.075461948, 0.076361995, 0.077274478, 0.078191769, 0.079114021, 0.080062624, 0.081009828, 0.081974995, 0.082947265, 0.083918924, 0.084915699, 0.085918491, 0.086928743, 0.087943248, 0.088993768, 0.090038415, 0.091113914, 0.092218, 0.093307093, 0.094422688, 0.095551754, 0.096649326, 0.097782304, 0.098937227, 0.100115653, 0.101048376, 0.101307812, 0.102494369, 0.1037042, 0.104923486, 0.106172414, 0.107427997, 0.108698138, 0.110001988, 0.111340683, 0.112658782, 0.113995053, 0.115336216, 0.116694659, 0.118118401, 0.119523936, 0.120941027, 0.122379923, 0.123819951, 0.125303213, 0.126821494, 0.128347878, 0.129885104, 0.131440671, 0.132978582, 0.134599778, 0.136215115, 0.137794612, 0.139436715, 0.141105203, 0.142804532, 0.144526466, 0.146214136, 0.147958903, 0.149741984, 0.151530833, 0.15336566, 0.155163613, 0.157016521, 0.158868552, 0.160792145, 0.162714485, 0.164671886, 0.166646145, 0.168630729, 0.170703353, 0.172792116, 0.174873016, 0.176963984, 0.179110571, 0.181315566, 0.183515092, 0.185726194, 0.188021871, 0.190322232, 0.192640421, 0.19495786, 0.197309518, 0.199713576, 0.202114335, 0.204579527, 0.207080497, 0.209612438, 0.212155977, 0.214732538, 0.217358358, 0.220040548, 0.222716697, 0.225434366, 0.228170479, 0.231004873, 0.233821809, 0.236720136, 0.239585921, 0.242494919, 0.245462352, 0.248480352, 0.251547379, 0.254610327, 0.257741324, 0.260949404, 0.264214352, 0.267510763, 0.270806504, 0.274152609, 0.277573353, 0.280999371, 0.284476376, 0.287994992, 0.291562999, 0.295135517, 0.298820319, 0.302558213, 0.306363944, 0.310169944, 0.314092376, 0.3180282, 0.318890956, 0.32200888, 0.326014434, 0.330087841, 0.334235764, 0.338459875, 0.342727294, 0.347067653, 0.351428731, 0.355880393, 0.360341673, 0.364869518, 0.369500262, 0.37416318, 0.378884155, 0.383725073, 0.388595963, 0.393526562, 0.398547983, 0.403568214, 0.408710896, 0.413957026, 0.41922217, 0.424651641, 0.430072781, 0.435600229, 0.436757538, 0.441213263, 0.446831337, 0.452617616, 0.458408819, 0.464283539, 0.470285112, 0.47640661, 0.482600709, 0.488787522, 0.49518907, 0.501746378, 0.508290286, 0.514950107, 0.521684445, 0.528476558, 0.535428602, 0.542469421, 0.549705308, 0.556891228, 0.564324529, 0.571779583, 0.579467637, 0.587176989, 0.595026504, 0.603004876, 0.611128117, 0.6193244, 0.627717641, 0.636232539, 0.644906586, 0.653706549, 0.662528296, 0.671576809, 0.680701405, 0.690086357, 0.694004473, 0.69944969, 0.709065118, 0.718900923, 0.728758413, 0.738838957, 0.749184966, 0.759532517, 0.770134785, 0.780902552, 0.791884247, 0.803124252, 0.814489642, 0.826041483, 0.837762763, 0.84976287, 0.861946318, 0.874396857, 0.887080374, 0.899935036, 0.913093745, 0.926455431, 0.939986234, 0.953786185, 0.967854623, 0.982139981, 0.988193427, 0.996825298, 1.011711845, 1.02702396, 1.042537755, 1.058201888, 1.074338919, 1.090819039, 1.107663844, 1.124848338, 1.14226482, 1.160044683, 1.178094985, 1.196547831, 1.215469747, 1.234757703, 1.254634033, 1.274891981, 1.295589479, 1.316700371, 1.333782333, 1.372994957, 1.394821015, 1.416636762, 1.438428962, 1.460200089, 1.481965746, 1.50369274, 1.525399384, 1.547155643, 1.568714789, 1.590392348, 1.612251521, 1.634063273, 1.655584121, 1.676895085, 1.698664999, 1.720202876, 1.741906686, 1.754665772, 1.763545591, 1.785236764, 1.806954113, 1.828602279, 1.850329003, 1.871837154, 1.893563791, 1.915127728, 1.936964918, 1.958612247, 1.980136181, 2.001858447, 2.023513867, 2.045235974, 2.06707015, 2.088687657, 2.110313033, 2.131991984, 2.153524848, 2.175215898, 2.197060081, 2.218741616, 2.240308538, 2.261896548, 2.283666524, 2.296175731, 2.30535786, 2.326939706, 2.348653975, 2.370430815, 2.392040905, 2.413767585, 2.435410771, 2.457044695, 2.47867437, 2.500372555, 2.52227528, 2.543978378, 2.565502109, 2.587474726, 2.609180821, 2.630815164, 2.652680153, 2.674499417, 2.696595938, 2.718683058, 2.740331503, 2.762086462, 2.783871637, 2.805822846, 2.827518584, 2.849265991, 2.871023123, 2.893029713, 2.915057368, 2.937215711, 2.959295763, 2.981130328, 3.003084664, 3.024909345, 3.046897759, 3.064464725, 3.068971026, 3.090868132, 3.112926038, 3.134989693, 3.156965588, 3.178994416, 3.201099009, 3.223279233, 3.245555342, 3.267541281, 3.289692158, 3.311788871, 3.334260136, 3.35611272, 3.378358191, 3.400863368, 3.423584979, 3.445840127, 3.468116323, 3.490487348, 3.512890167, 3.535305032, 3.557583522, 3.579708416, 3.602167999, 3.619825877, 3.624819086, 3.647336494, 3.669680173, 3.692299416, 3.715068244, 3.737650974, 3.760296772, 3.782868989, 3.805465848, 3.828207357, 3.850773217, 3.873221273, 3.895823367, 3.918678669, 3.941419403, 3.964431871, 3.987249539, 4.010359009, 4.03298838, 4.056081296, 4.079003624, 4.102179579, 4.125303019, 4.148478035, 4.17157967, 4.194600932, 4.218092082, 4.24074436, 4.264094204, 4.28717423, 4.310509599, 4.33386984, 4.356967534, 4.380425162, 4.404044097, 4.427364438, 4.450800779, 4.474120262, 4.49730338, 4.521150499, 4.54466589, 4.568351003, 4.592155495, 4.615847797, 4.639989116, 4.663767199, 4.687144315, 4.711414035, 4.735128193, 4.759080324, 4.78286261, 4.807224263, 4.831742455, 4.85569812, 4.879627193, 4.90334507, 4.927441509, 4.951769228, 4.975977835, 4.999644346, 5.024419232, 5.048871616, 5.073091037, 5.09757208, 5.121709321, 5.14614229, 5.170942596, 5.195478018, 5.219581501, 5.244322736, 5.269353497, 5.294191165, 5.319461167, 5.344489715, 5.369232467, 5.394327734, 5.419256991, 5.444394473, 5.469689482, 5.494506301, 5.519489544, 5.544702065, 5.570352523, 5.595817186, 5.62140891, 5.646649051, 5.671793134, 5.697329263, 5.723386411, 5.749350788, 5.774754696, 5.800297354, 5.826521679, 5.852360489, 5.878674019, 5.905077496, 5.910348911, 5.930509312, 5.957051415, 5.98333971, 6.009551309, 6.035893154, 6.062489134, 6.089126735, 6.114872779, 6.141972301, 6.168937708, 6.195663328, 6.22220395, 6.249469512, 6.276307237, 6.302700829, 6.330289012, 6.357714325, 6.385093266, 6.412467752, 6.439947853, 6.467201243, 6.494652689, 6.521721953, 6.54907584, 6.576828228, 6.604711725, 6.632759785, 6.660917527, 6.689375631, 6.717816486, 6.74530722, 6.772730996, 6.801666723, 6.829443032, 6.856946695, 6.885360548, 6.913156828, 6.941017305, 6.969340402, 6.997456742, 7.025778765, 7.054696768, 7.083324019, 7.112767305, 7.141062553, 7.170902413, 7.199866438, 7.229471894, 7.258822494, 7.288514211, 7.318767771, 7.348609663, 7.378122354, 7.408658191, 7.437776549, 7.467831767, 7.498244227, 7.527977713, 7.558506706, 7.588436157, 7.619641555, 7.649396855, 7.679964952, 7.710925124, 7.741734279, 7.7725748, 7.803554081, 7.834514967, 7.864899732, 7.89616467, 7.926294361, 7.957419801, 7.98859122, 8.020154464, 8.052567831, 8.084358009, 8.115935483, 8.14782649, 8.180149037, 8.212061158, 8.244184485, 8.276755098, 8.3099166, 8.341836219, 8.37438684, 8.407256912, 8.43912728, 8.472042891, 8.504287242, 8.537592244, 8.57004224, 8.603559413, 8.636653255, 8.669472022, 8.702802377, 8.734485979, 8.768579129, 8.802501687, 8.837033137, 8.870907869, 8.905364036, 8.938025232, 8.972116286, 9.00591527, 9.038633911, 9.073549689, 9.106730349, 9.141133812, 9.174955509, 9.207592591, 9.2428251, 9.276629991, 9.313259575, 9.34823584, 9.384128109, 9.419099334, 9.45444328, 9.489584143, 9.526758802, 9.562030677, 9.597933929, 9.63373006, 9.669388973, 9.70711455, 9.741911104, 9.778164019, 9.815022592, 9.850666055, 9.88870009, 9.926389778, 9.963429807, 10.001473054, 10.038160685, 10.074074842, 10.112379939, 10.149215506, 10.187473751, 10.225279753, 10.261614537, 10.299430913, 10.335877306, 10.373854932, 10.411977733, 10.449300796, 10.488413042, 10.527804705, 10.567651451, 10.605574309, 10.643183162, 10.681341446, 10.718378229, 10.756382355, 10.792354992, 10.831035834, 10.868930443, 10.907964126, 10.947173318, 10.985660616, 11.024217434, 11.063032525, 11.10229286, 11.140853011, 11.178351131, 11.22024378, 11.258902695, 11.298264951, 11.337875901, 11.37661399, 11.416590545, 11.454861221, 11.496000824, 11.537514197, 11.581211312, 11.623268996, 11.663948689, 11.706096768, 11.748514494, 11.792010995, 11.834943807, 11.876059294, 11.916506532, 11.955151802, 11.997388925, 12.041376746, 12.084687764, 12.124194152, 12.16641462, 12.208229005, 12.250020452, 12.29059982, 12.331288497, 12.375993038, 12.421178336, 12.462423531, 12.505840785, 12.545602273, 12.589586276, 12.633449543, 12.676704991, 12.717104919, 12.725854311, 12.75890621, 12.803185347, 12.846956477, 12.887408763, 12.929812105, 12.971812837, 13.015551264, 13.060954452, 13.106038922, 13.151885831, 13.193875878, 13.237134797, 13.278221789, 13.320536591, 13.366575277, 13.410801623, 13.45496763, 13.496338774, 13.542961165, 13.58458004, 13.627782799, 13.674459065, 13.716921076, 13.759896874, 13.804015471, 13.851231021, 13.896276299, 13.940961286, 13.986928241, 14.035430493, 14.081194249, 14.129254566, 14.176111684, 14.221503808, 14.267092254, 14.314898236, 14.362639031, 14.409911786, 14.452472161, 14.497740436, 14.542122294, 14.594361677, 14.640527642, 14.691247907, 14.736736195, 14.782023045, 14.832014555, 14.879037821, 14.927184602, 14.977321402, 15.024492177, 15.069597555, 15.119366026, 15.161165553, 15.211341219, 15.259074064, 15.302391861, 15.352365361, 15.400399388, 15.447420586, 15.492569492, 15.539097329, 15.58838544, 15.632300432, 15.679648173, 15.728780683, 15.774769702, 15.824090939, 15.870693864, 15.924530329, 15.967222928, 16.009774691, 16.056217705, 16.102911108, 16.155005563, 16.203652214, 16.253634626, 16.295566466, 16.343661707, 16.393340959, 16.44511896, 16.491442576, 16.546682521, 16.591800865, 16.641616897, 16.692129676, 16.739689538, 16.788103433, 16.834781376, 16.887591915, 16.931813383, 16.980173526, 17.034829267, 17.083965351, 17.135272684, 17.188500071, 17.243255006, 17.29417484, 17.346945416, 17.400098777, 17.449644279, 17.501720105, 17.551649032, 17.600055747, 17.647426189, 17.69543555, 17.749869156, 17.795323133, 17.847595062, 17.898790653, 17.956214286, 18.01115285, 18.064615095, 18.116348827, 18.16394281, 18.217933226, 18.263657535, 18.315622825, 18.370950686, 18.422942096, 18.472909716, 18.528761796, 18.577302679, 18.637939458, 18.695552125, 18.759171578, 18.81774598, 18.876230283, 18.937783236, 18.993063313, 19.040266823, 19.092256301, 19.149795034, 19.209554731, 19.264430527, 19.313724315, 19.357701428, 19.406127567, 19.463191644, 19.52133347, 19.579825648, 19.640923149, 19.697188355, 19.761363227, 19.822823887, 19.876953892, 19.930755551, 19.987698781, 20.037497436, 20.094849913, 20.14896556, 20.202652529, 20.264412313, 20.316432528, 20.372814708, 20.429050237, 20.47681634, 20.531778211, 20.597783217, 20.666471564, 20.728648807, 20.790179206, 20.842658594, 20.898482727, 20.962772654, 21.020528264, 21.076664713, 21.128133629, 21.185860871, 21.249637596, 21.306166413, 21.362811664, 21.414222384, 21.467465404, 21.519393215, 21.579028076, 21.639013578, 21.695241609, 21.767743848, 21.827242271, 21.886920308, 21.95096918, 22.00969199, 22.062642141, 22.126136839, 22.19103889, 22.249706856, 22.295384083, 22.364282587, 22.439398618, 22.493700543, 22.560468994, 22.62263336, 22.694660699, 22.7420245, 22.80334857, 22.855124314, 22.910316784, 22.966593882, 23.033088862, 23.0452269, 23.091748471, 23.166073271, 23.232216126, 23.294416456, 23.345878605, 23.41367427, 23.468059293, 23.530098872, 23.595487177, 23.66347892, 23.74853224, 23.819304687, 23.873000301, 23.938952286, 24.003030372, 24.072414024, 24.130564893, 24.187879658, 24.25154512, 24.320598799, 24.382505003, 24.442988977, 24.505268597, 24.567868164, 24.631170475, 24.699895516, 24.78510592, 24.86591731, 24.921784862, 24.98374251, 25.051813078, 25.134747962, 25.208454897, 25.275166473, 25.344752598, 25.402011779, 25.477893291, 25.554215985, 25.620394572, 25.698030184, 25.761623634, 25.836094536, 25.897512447, 25.980537471, 26.051301578, 26.131137646, 26.202714189, 26.249335805, 26.312246527, 26.397654798, 26.455109912, 26.534302697, 26.602916479, 26.669901001, 26.736490368, 26.806411053, 26.850931162, 26.910845544, 26.972826549, 27.051265075, 27.11172063, 27.181539607, 27.27364599, 27.343412698, 27.40546154, 27.489530994, 27.56861724, 27.640403329, 27.730895, 27.797928966, 27.883414912, 27.94506799, 28.012349941, 28.09960182, 28.155387677, 28.23331797, 28.296527751, 28.352296255, 28.456367063, 28.527384844, 28.597007976, 28.675998508, 28.743987091, 28.80178406, 28.876418169, 28.950411292, 28.99403289, 29.051851402, 29.124272964, 29.245633421, 29.349149693, 29.444303806, 29.511113935, 29.611513901, 29.67755941, 29.746734713, 29.804303738, 29.874004298, 29.966400304, 30.059481443, 30.140053858, 30.184113425, 30.258498249, 30.340569874, 30.420237966, 30.480111712, 30.549361206, 30.618338708, 30.689686869, 30.762670329, 30.841300845, 30.908766087, 30.984724386, 31.052509444, 31.114375697, 31.219550543, 31.288565322, 31.346592583, 31.442325491, 31.482920075, 31.553446233, 31.616470247, 31.712488548, 31.791879367, 31.849514313, 31.97490921, 32.10155949, 32.154727796, 32.231557119, 32.383551428, 32.471192428, 32.586380662, 32.642090416, 32.705419645, 32.813395036, 32.872394207, 32.938501103, 33.042691646, 33.163711299, 33.24697904, 33.303407551, 33.474981596, 33.571890086, 33.650330948, 33.716918506, 33.768241166, 33.849034892, 33.957902318, 34.025784107, 34.070600872, 34.183715771, 34.264850362, 34.341165386, 34.434633124, 34.582848795, 34.657164257, 34.737874012, 34.827295923, 34.904711207, 34.952295742, 35.030753716, 35.146030754, 35.265470551, 35.349261821, 35.436586401, 35.564698067, 35.667962894, 35.726979466, 35.823395676, 35.92861265, 36.030279817, 36.111076989, 36.170226009, 36.199100707, 36.268422088, 36.377488674, 36.563444028, 36.742560773, 36.793771459, 36.850738069, 36.981404542, 37.046067509, 37.092048614, 37.133464965, 37.18904043, 37.309450236, 37.356742994, 37.472487112, 37.506258231, 37.632882335, 37.70357095, 37.736828432, 37.870604853, 37.949787892, 38.06584847, 38.154829758, 38.32445379, 38.374990472, 38.454050623, 38.598467851, 38.668630389, 38.7334744, 38.870016804, 38.916918721, 38.999574278, 39.079043013, 39.197953322, 39.235828801, 39.396273357, 39.465553658, 39.534940076, 39.660850353, 39.782139399, 39.989529223, 40.059966861, 40.107695657, 40.160339447, 40.276015789, 40.385203358, 40.44822256, 40.595801493, 40.665969696, 40.771707141, 40.928050141, 41.017773512, 41.185954769, 41.42925149, 41.574446943, 41.731435934, 41.899682242, 41.956198236, 42.074206027, 42.171638415, 42.256334602, 42.292547066, 42.521986971, 42.60767022, 42.664273845, 42.746931481, 42.815791799, 42.891293505, 42.950703299, 43.207802475, 43.214876245, 43.300852981, 43.459519246, 43.502907387, 43.781792882, 43.822128321, 43.942330435, 44.059662646, 44.133502799, 44.149116692, 44.301077012, 44.365302902, 44.386362378, 44.489949113, 44.55944061, 44.713072737, 44.878588431, 44.92563949, 45.019942391, 45.108952638, 45.205374922, 45.293909669, 45.329287779, 45.389673565, 45.535430403, 45.627405108, 45.672522552, 45.739260765, 45.795798236, 46.001535182, 46.010393616, 46.121151083, 46.190330809, 46.341347053, 46.44261159, 46.656854104, 46.744221017, 46.868678435, 46.915702756, 47.018661733, 47.220469877, 47.319856561, 47.502775266, 47.643372978, 47.767388086, 47.922447917, 47.952912452, 47.979743308, 48.005041858, 48.060764028, 48.325449277, 48.455066789, 48.473588376, 48.55238717, 48.619539962, 48.833069078, 49.049552803, 49.070927322, 49.101367705, 49.172867767, 49.248725595, 49.371124641, 49.426604591, 49.548992728, 49.559695873, 49.778622107, 49.906652592, 49.944490387, 50.035364068, 50.097438934, 50.153143545, 50.38655689, 50.410027116, 50.673020494, 50.67533773, 50.900979455, 50.905508289, 51.033639904, 51.119953645, 51.13204761, 51.150539009, 51.154429444, 51.315629172, 51.437513261, 51.471856818, 51.479165645, 51.75249531, 51.766494222, 51.770644281, 51.872552385, 51.876477651, 51.90135813, 51.908601717, 52.103223498, 52.345996749, 52.462643816, 52.582863613), "1000" = c(1.6312e-05, 1.644e-05, 1.647e-05, 1.6674e-05, 1.6743e-05, 1.6977e-05, 1.7228e-05, 1.7329e-05, 1.7638e-05, 1.7974e-05, 1.8197e-05, 1.8746e-05, 1.8783e-05, 1.905e-05, 1.927e-05, 1.9461e-05, 1.9515e-05, 1.9863e-05, 2.0116e-05, 2.0179e-05, 2.0503e-05, 2.0533e-05, 2.0772e-05, 2.0887e-05, 2.1047e-05, 2.1216e-05, 2.1416e-05, 2.1418e-05, 2.1862e-05, 2.1917e-05, 2.2223e-05, 2.2508e-05, 2.2846e-05, 2.3222e-05, 2.3339e-05, 2.3582e-05, 2.3817e-05, 2.4236e-05, 2.4525e-05, 2.5227e-05, 2.5525e-05, 2.6144e-05, 2.6169e-05, 2.6234e-05, 2.6955e-05, 2.7632e-05, 2.8096e-05, 2.8169e-05, 2.8283e-05, 2.8429e-05, 2.8713e-05, 2.889e-05, 2.922e-05, 2.9624e-05, 2.9838e-05, 3.0416e-05, 3.0454e-05, 3.0558e-05, 3.088e-05, 3.1198e-05, 3.2373e-05, 3.2802e-05, 3.2976e-05, 3.3957e-05, 3.4327e-05, 3.4469e-05, 3.5139e-05, 3.6114e-05, 3.6902e-05, 3.7256e-05, 3.7708e-05, 3.8891e-05, 3.9062e-05, 3.9165e-05, 3.9583e-05, 4.0109e-05, 4.1788e-05, 4.185e-05, 4.2854e-05, 4.3933e-05, 4.4399e-05, 4.5153e-05, 4.567e-05, 4.6811e-05, 4.7028e-05, 4.7715e-05, 4.8564e-05, 4.9524e-05, 5.0345e-05, 5.053e-05, 5.126e-05, 5.1717e-05, 5.2136e-05, 5.2523e-05, 5.2825e-05, 5.3416e-05, 5.3669e-05, 5.4506e-05, 5.6348e-05, 5.7044e-05, 5.7398e-05, 5.7864e-05, 5.9048e-05, 6.0472e-05, 6.2245e-05, 6.3413e-05, 6.4438e-05, 6.4985e-05, 6.6368e-05, 6.7011e-05, 6.7513e-05, 6.7929e-05, 6.8446e-05, 6.8835e-05, 6.9521e-05, 7.0948e-05, 7.1758e-05, 7.2395e-05, 7.2739e-05, 7.4286e-05, 7.4579e-05, 7.6272e-05, 7.7155e-05, 7.7744e-05, 7.8642e-05, 7.9375e-05, 8.0247e-05, 8.0743e-05, 8.2005e-05, 8.2848e-05, 8.5527e-05, 8.6065e-05, 8.6858e-05, 8.8609e-05, 9.0163e-05, 9.0922e-05, 9.2047e-05, 9.3653e-05, 9.4397e-05, 9.5128e-05, 9.6806e-05, 9.7936e-05, 9.9832e-05, 0.000101571, 0.000102541, 0.000104264, 0.000104886, 0.000106043, 0.000107462, 0.000109222, 0.000110983, 0.000112697, 0.000114182, 0.000115536, 0.000116601, 0.000117609, 0.000118624, 0.000120398, 0.000121823, 0.000122793, 0.000124321, 0.000126299, 0.00012731, 0.000128523, 0.000132089, 0.000133564, 0.000135094, 0.000136167, 0.000138445, 0.000139985, 0.000142129, 0.000142907, 0.000144816, 0.00014634, 0.000147675, 0.000149561, 0.000150785, 0.00015186, 0.000154185, 0.000156315, 0.000158553, 0.000160683, 0.000161923, 0.000164841, 0.000166549, 0.000168104, 0.000170054, 0.000171438, 0.000172805, 0.000174759, 0.000176986, 0.000178736, 0.000179794, 0.000181653, 0.000184086, 0.00018668, 0.000189816, 0.000191988, 0.000196232, 0.000198917, 0.000201589, 0.000203, 0.000205967, 0.000207175, 0.000210615, 0.000213466, 0.00021681, 0.000218531, 0.000221539, 0.000223381, 0.000225831, 0.000227881, 0.000229873, 0.000231014, 0.000232763, 0.000235779, 0.000239526, 0.000243188, 0.000245393, 0.000249045, 0.000250883, 0.000254105, 0.000256315, 0.000258669, 0.000260829, 0.000263684, 0.000266301, 0.000268689, 0.000272292, 0.000274302, 0.000278139, 0.00028187, 0.000285539, 0.000288423, 0.000291796, 0.000294797, 0.000297778, 0.000301864, 0.000305821, 0.000309287, 0.000314164, 0.000319084, 0.000321902, 0.000325967, 0.000329153, 0.000332331, 0.000338077, 0.000342615, 0.000346067, 0.000349778, 0.000353261, 0.000357927, 0.000362417, 0.000367195, 0.000372311, 0.00037543, 0.000379832, 0.0003845, 0.000388531, 0.000392055, 0.000396226, 0.000402597, 0.000407659, 0.000411709, 0.00041536, 0.000420398, 0.000423654, 0.00042964, 0.000433551, 0.000438541, 0.000444973, 0.000450061, 0.0004554, 0.000460996, 0.000466087, 0.000472405, 0.000476519, 0.000480512, 0.000486301, 0.000491034, 0.000495934, 0.000500231, 0.00050675, 0.000512878, 0.000519226, 0.000523323, 0.000530297, 0.000535991, 0.000542461, 0.000550206, 0.000557399, 0.000564143, 0.00057216, 0.000578983, 0.000586364, 0.000591898, 0.000601467, 0.000606201, 0.00061237, 0.000619963, 0.000625941, 0.000631178, 0.000638871, 0.000648336, 0.000655038, 0.000661822, 0.000668375, 0.00067671, 0.00068532, 0.000695343, 0.000704513, 0.000711184, 0.000720437, 0.000727704, 0.000735472, 0.000741399, 0.00075041, 0.000759214, 0.000769272, 0.000776441, 0.00078614, 0.000793975, 0.0008037, 0.000811974, 0.000821817, 0.000832984, 0.000843377, 0.000854464, 0.000864285, 0.000875329, 0.000886851, 0.000896071, 0.00090722, 0.000918224, 0.000927451, 0.000939116, 0.000951215, 0.00096511, 0.00097602, 0.000987317, 0.000992705, 0.000996286, 0.001008338, 0.001021191, 0.001034468, 0.001049273, 0.00106206, 0.001074138, 0.001085459, 0.001098149, 0.001107303, 0.00112047, 0.001132658, 0.001147899, 0.00116219, 0.001176528, 0.001190353, 0.001203562, 0.00121733, 0.001229309, 0.001242388, 0.001258713, 0.001272572, 0.001287334, 0.001300453, 0.001318328, 0.00133364, 0.00134739, 0.001362986, 0.001378303, 0.001394097, 0.001409779, 0.001424474, 0.001436654, 0.001456329, 0.001472804, 0.001492685, 0.00150902, 0.001528264, 0.001544577, 0.001561531, 0.001579571, 0.001597537, 0.001615152, 0.00163201, 0.00165072, 0.001670949, 0.001690924, 0.001711522, 0.001733907, 0.001757841, 0.001776273, 0.001796075, 0.001814397, 0.00183428, 0.001857965, 0.001880405, 0.00190128, 0.001921294, 0.001947219, 0.001967032, 0.001989096, 0.002012908, 0.002037015, 0.002061155, 0.002083816, 0.002110998, 0.00213535, 0.002159071, 0.002184693, 0.002209068, 0.002234292, 0.002253956, 0.002282698, 0.002309833, 0.002334319, 0.002357889, 0.002390175, 0.002419171, 0.002449895, 0.002484027, 0.002512985, 0.002539188, 0.002567327, 0.002599104, 0.002625685, 0.002654757, 0.002687361, 0.002721435, 0.002750738, 0.002781123, 0.00281374, 0.002848015, 0.002876956, 0.002910757, 0.002943386, 0.002972684, 0.003005049, 0.003036254, 0.003072399, 0.003106905, 0.003139473, 0.003180708, 0.003216593, 0.003251694, 0.00328922, 0.003324338, 0.003363825, 0.003402236, 0.00344843, 0.003486122, 0.00352752, 0.00356777, 0.003612031, 0.003651362, 0.003697179, 0.003737882, 0.003782545, 0.003826533, 0.003872156, 0.003911701, 0.003955457, 0.004000382, 0.004052469, 0.004101301, 0.004147184, 0.004194697, 0.004241262, 0.004288369, 0.004339907, 0.004394051, 0.004451137, 0.004500002, 0.004554236, 0.004611872, 0.004667355, 0.004719711, 0.004774229, 0.004830268, 0.004882428, 0.004934882, 0.004986101, 0.005040784, 0.005101632, 0.005163274, 0.005226704, 0.005289257, 0.005350263, 0.005412445, 0.005472033, 0.005535276, 0.005601136, 0.005664036, 0.005733066, 0.005796037, 0.005857299, 0.005925267, 0.005992233, 0.006057501, 0.006128742, 0.006200535, 0.00627214, 0.006350154, 0.006423195, 0.00650077, 0.006574996, 0.006654124, 0.006735702, 0.006818731, 0.006899771, 0.006975454, 0.00706479, 0.007142061, 0.007225058, 0.007306496, 0.007394657, 0.007482558, 0.007569182, 0.007663119, 0.007747601, 0.007838251, 0.007930101, 0.008028204, 0.008120433, 0.008209601, 0.00830478, 0.008398734, 0.008492907, 0.008583607, 0.008678857, 0.008776772, 0.00887826, 0.008976361, 0.009082932, 0.00918953, 0.009297953, 0.009403762, 0.00951546, 0.00962302, 0.009729068, 0.00985019, 0.009938467, 0.009963858, 0.010080097, 0.010196991, 0.010315722, 0.010437322, 0.010558435, 0.01067879, 0.010805449, 0.010931729, 0.011062274, 0.011190088, 0.011317069, 0.011448161, 0.011581015, 0.011707462, 0.011841585, 0.011978857, 0.012119373, 0.012265109, 0.012399984, 0.012549156, 0.012693127, 0.012849814, 0.012996515, 0.013137335, 0.01329749, 0.013448354, 0.013601525, 0.013761724, 0.013920555, 0.014072876, 0.014240021, 0.014403816, 0.014567664, 0.014728817, 0.014894604, 0.015081531, 0.015263896, 0.015435175, 0.015619, 0.015798071, 0.015983946, 0.016166942, 0.016354234, 0.016542838, 0.016742492, 0.016938717, 0.017140492, 0.017322702, 0.017528381, 0.017731995, 0.017945509, 0.018155505, 0.018362455, 0.018574234, 0.018788044, 0.019001751, 0.019224177, 0.019447634, 0.019674075, 0.019904513, 0.020128669, 0.02036849, 0.020602089, 0.020845288, 0.021083103, 0.021341087, 0.021606942, 0.02185917, 0.022116756, 0.022365938, 0.022619579, 0.022883257, 0.023154996, 0.023424856, 0.023705743, 0.023970958, 0.024239252, 0.024530042, 0.024822481, 0.025115603, 0.025416476, 0.025707636, 0.025995277, 0.026301741, 0.026605072, 0.026911905, 0.027208605, 0.027535344, 0.027866076, 0.028189197, 0.028517451, 0.028844138, 0.029162815, 0.029507343, 0.029847452, 0.030188175, 0.030552486, 0.030904678, 0.031260369, 0.031621503, 0.031997861, 0.032365085, 0.032743534, 0.033130562, 0.033511586, 0.033896154, 0.03428318, 0.034673362, 0.035074117, 0.035481828, 0.035901596, 0.036323236, 0.036747672, 0.037170823, 0.037596198, 0.038031219, 0.038474384, 0.038922554, 0.039373353, 0.039826642, 0.040305016, 0.040783597, 0.041260709, 0.041734888, 0.042215804, 0.042709929, 0.043205385, 0.043723684, 0.044229306, 0.044764879, 0.045288526, 0.045807235, 0.046347416, 0.046893041, 0.047438224, 0.047986797, 0.048551677, 0.049135507, 0.049711363, 0.050304856, 0.050893895, 0.051488141, 0.052089747, 0.052703854, 0.053315786, 0.053921535, 0.054559202, 0.055200639, 0.055848837, 0.056495907, 0.05716728, 0.057833962, 0.058512883, 0.059204573, 0.059889857, 0.060607973, 0.06133239, 0.062059847, 0.062770234, 0.063506946, 0.064246986, 0.065011796, 0.06577357, 0.066537431, 0.067323184, 0.06811618, 0.068945459, 0.069738331, 0.070542392, 0.071383827, 0.072231818, 0.073067665, 0.073910188, 0.074775834, 0.07564831, 0.076543624, 0.077445829, 0.078333793, 0.079267801, 0.080207804, 0.081141087, 0.082081099, 0.083057134, 0.084027762, 0.085001996, 0.086017223, 0.087022444, 0.088056712, 0.089076272, 0.090103167, 0.091156724, 0.092257701, 0.093338566, 0.094434656, 0.095570373, 0.096688792, 0.097851494, 0.099020154, 0.100191692, 0.101163763, 0.101415416, 0.102602831, 0.103798926, 0.105032367, 0.106287662, 0.107541063, 0.108817988, 0.110123263, 0.111425787, 0.112732208, 0.114079945, 0.115440362, 0.116800969, 0.118200238, 0.119645, 0.121068128, 0.122512388, 0.123958737, 0.125446403, 0.126983672, 0.12848765, 0.130038502, 0.131603678, 0.133165836, 0.134766794, 0.136383996, 0.138004527, 0.139633688, 0.141321555, 0.143010054, 0.144734604, 0.146455281, 0.148231021, 0.150044491, 0.151828251, 0.153645438, 0.155529055, 0.157368526, 0.1592547, 0.161163296, 0.163114058, 0.165064881, 0.167039453, 0.169054731, 0.171096338, 0.173168302, 0.175246152, 0.177406369, 0.17956127, 0.181723467, 0.183923976, 0.186165027, 0.18841876, 0.190704806, 0.19300599, 0.195331898, 0.197707201, 0.200057176, 0.202489887, 0.204969748, 0.207439332, 0.209979971, 0.212534015, 0.215126422, 0.217755023, 0.22047028, 0.223175171, 0.22591625, 0.228689334, 0.231503425, 0.23431686, 0.237214253, 0.2401602, 0.243121327, 0.246073868, 0.249101831, 0.252171456, 0.255278951, 0.258449509, 0.261665598, 0.264919887, 0.268150942, 0.271437256, 0.2747773, 0.278127265, 0.281602839, 0.285078214, 0.288629535, 0.292188197, 0.295801906, 0.299460458, 0.303187012, 0.306952415, 0.310778175, 0.314615373, 0.318526547, 0.319391535, 0.322502796, 0.326514952, 0.330634042, 0.334767868, 0.338927465, 0.343205062, 0.347521278, 0.351909804, 0.356342385, 0.360828888, 0.365307429, 0.36993438, 0.374551907, 0.379327255, 0.384178358, 0.389107735, 0.394045564, 0.399105969, 0.404230304, 0.409379319, 0.414662539, 0.419995231, 0.425450578, 0.430911307, 0.436456937, 0.437615246, 0.442092421, 0.447826878, 0.453632263, 0.459529452, 0.465422591, 0.471439955, 0.47754601, 0.483760741, 0.49006621, 0.496398345, 0.502918361, 0.509555152, 0.516174805, 0.522977637, 0.529930519, 0.536941101, 0.54408714, 0.551390037, 0.558725267, 0.566251425, 0.57374889, 0.5814305, 0.589190401, 0.597110067, 0.605107377, 0.613254266, 0.621583327, 0.629977381, 0.638501498, 0.647191006, 0.65595497, 0.664786222, 0.673917879, 0.683151218, 0.692483457, 0.696518101, 0.702038189, 0.711705741, 0.721610776, 0.731603549, 0.741825002, 0.752232523, 0.762713078, 0.773405938, 0.784205173, 0.795335233, 0.806620319, 0.818131141, 0.829799025, 0.841666249, 0.853779324, 0.866075962, 0.878600542, 0.891328845, 0.904274874, 0.917378928, 0.930803915, 0.94455141, 0.958456037, 0.972623094, 0.987104577, 0.99314629, 1.001812975, 1.01691887, 1.032348947, 1.047859953, 1.063786567, 1.08001581, 1.09657264, 1.113410803, 1.130508826, 1.148104394, 1.166092127, 1.184445502, 1.203225395, 1.222341669, 1.241948911, 1.262011906, 1.282463931, 1.303269674, 1.324761133, 1.342007596, 1.381450318, 1.403350107, 1.425306837, 1.44726098, 1.469218581, 1.491196044, 1.513276475, 1.535148555, 1.557164387, 1.579044306, 1.601124753, 1.623145177, 1.645172885, 1.667020036, 1.689003743, 1.711132561, 1.733117404, 1.755037494, 1.767859466, 1.77698794, 1.798886022, 1.820761967, 1.842642564, 1.864718114, 1.88662657, 1.90849452, 1.930405264, 1.952220589, 1.974017393, 1.996077254, 2.017880381, 2.039922185, 2.061815909, 2.083682992, 2.105623458, 2.127365745, 2.149302662, 2.171221874, 2.193164848, 2.21493192, 2.236955197, 2.258806181, 2.280827719, 2.302735882, 2.31534215, 2.324688816, 2.346518515, 2.368345464, 2.390457315, 2.412179597, 2.434075443, 2.456055356, 2.47829615, 2.50033377, 2.522200333, 2.544005171, 2.565965716, 2.587791351, 2.609814701, 2.631795293, 2.65378552, 2.675802654, 2.697890565, 2.719957575, 2.741996776, 2.763942291, 2.785929406, 2.80807351, 2.830118388, 2.85222842, 2.874075665, 2.896210325, 2.918613929, 2.940564556, 2.962705842, 2.984830845, 3.006948737, 3.029012669, 3.051155607, 3.07336328, 3.090875751, 3.095503691, 3.117590874, 3.139834597, 3.162073002, 3.184466779, 3.206732896, 3.229126133, 3.251258901, 3.273561703, 3.29574991, 3.318123497, 3.34059375, 3.363101849, 3.385509475, 3.407832171, 3.430196479, 3.452781199, 3.475314469, 3.497716682, 3.520377954, 3.542955073, 3.565545511, 3.588139882, 3.610482081, 3.632800716, 3.650665528, 3.655632408, 3.678456659, 3.700802962, 3.723495471, 3.746058732, 3.768542701, 3.791009321, 3.813900852, 3.836555967, 3.858993532, 3.881552822, 3.904346293, 3.927200933, 3.949912422, 3.972997432, 3.996029608, 4.018559064, 4.041393333, 4.063960596, 4.087033708, 4.10992077, 4.13283096, 4.155741067, 4.178809835, 4.201955179, 4.225076531, 4.248137716, 4.271372459, 4.294395154, 4.31747589, 4.340521801, 4.363612499, 4.386557532, 4.410614546, 4.433308059, 4.456820951, 4.480201637, 4.503570282, 4.527187057, 4.550587572, 4.574134052, 4.59757869, 4.621097051, 4.644777781, 4.668363965, 4.691949488, 4.715557694, 4.739515576, 4.763549974, 4.787596715, 4.811309669, 4.835349139, 4.858943758, 4.882638631, 4.906884217, 4.930929673, 4.954526937, 4.978604575, 5.003078373, 5.027341109, 5.051369195, 5.075340662, 5.098896084, 5.123327827, 5.147451055, 5.171851258, 5.196368173, 5.22094711, 5.245418908, 5.269953524, 5.294354622, 5.318892329, 5.343509472, 5.367827934, 5.392977825, 5.41749897, 5.442197972, 5.46674117, 5.491904602, 5.516915798, 5.542095453, 5.567133072, 5.592015004, 5.616814346, 5.641716692, 5.666517881, 5.691090944, 5.715876204, 5.740863986, 5.766308822, 5.791065492, 5.816448033, 5.842224299, 5.86760117, 5.893271137, 5.918958721, 5.924174688, 5.944442716, 5.970448858, 5.996124254, 6.022119111, 6.04827654, 6.073725873, 6.099687936, 6.125625996, 6.15159956, 6.177687388, 6.204139422, 6.230543958, 6.25690007, 6.28318625, 6.309109672, 6.335937217, 6.362262184, 6.388887237, 6.415254831, 6.442435908, 6.469557337, 6.496755921, 6.523602328, 6.550244472, 6.577177998, 6.603394374, 6.630080975, 6.657184174, 6.685051127, 6.713158673, 6.74104784, 6.769586584, 6.797006468, 6.824661071, 6.85204315, 6.879454005, 6.906781187, 6.933559623, 6.960884329, 6.988637939, 7.016729342, 7.044111353, 7.071895703, 7.099697415, 7.128711236, 7.157187681, 7.185487091, 7.21468549, 7.2430048, 7.271447633, 7.299947401, 7.328367793, 7.357676668, 7.386730149, 7.414428089, 7.443828794, 7.472587879, 7.501271287, 7.529826035, 7.558076623, 7.586919756, 7.616411262, 7.646167108, 7.675254484, 7.704245051, 7.73404699, 7.763033106, 7.791895415, 7.821608159, 7.85155544, 7.880827692, 7.911011264, 7.941041698, 7.971913037, 8.000580507, 8.030317394, 8.060547982, 8.09151538, 8.122528216, 8.153044815, 8.183552811, 8.214168239, 8.244714092, 8.275561326, 8.306715645, 8.337471038, 8.369523645, 8.400546315, 8.432096576, 8.463275251, 8.494602666, 8.525526158, 8.556840703, 8.58808139, 8.61895343, 8.652534318, 8.684256491, 8.716639044, 8.749239076, 8.780252549, 8.813026563, 8.845398471, 8.877754166, 8.910062665, 8.941728544, 8.973269754, 9.006118382, 9.038056541, 9.072003252, 9.10486416, 9.138348391, 9.171536678, 9.203759441, 9.236561255, 9.270373856, 9.303296365, 9.334896459, 9.367687404, 9.401974417, 9.435158794, 9.468638725, 9.502661148, 9.536962044, 9.570708303, 9.603986519, 9.639081701, 9.67161251, 9.704322808, 9.738456543, 9.773003982, 9.807984587, 9.840148232, 9.874826499, 9.910390079, 9.944614601, 9.97831588, 10.011866014, 10.047685301, 10.083194165, 10.117057014, 10.152753854, 10.188438458, 10.223056627, 10.257172314, 10.293545732, 10.329797296, 10.367142684, 10.402753157, 10.438100101, 10.473479098, 10.508264303, 10.545557584, 10.580596315, 10.61796389, 10.655041257, 10.692499468, 10.730316352, 10.768020086, 10.80416667, 10.840860016, 10.87767198, 10.911250151, 10.947266938, 10.98428319, 11.021973181, 11.058980232, 11.096938896, 11.134558529, 11.17211958, 11.207814904, 11.244113238, 11.282030707, 11.320026208, 11.358941359, 11.396487258, 11.433896285, 11.472263436, 11.51028198, 11.546431698, 11.58531806, 11.621405676, 11.660764072, 11.700734147, 11.738697624, 11.777316648, 11.817984446, 11.855700651, 11.893314497, 11.930670495, 11.967166257, 12.004040225, 12.042088351, 12.083275053, 12.122218718, 12.161701036, 12.202464871, 12.24241818, 12.279053387, 12.31937152, 12.358787939, 12.365952866, 12.396032059, 12.432859562, 12.471765897, 12.513941119, 12.55455533, 12.592817897, 12.634259198, 12.674930012, 12.715201437, 12.757572913, 12.799445583, 12.840173712, 12.878353274, 12.920316005, 12.963688681, 13.005699496, 13.045974356, 13.090219017, 13.131869928, 13.173516151, 13.21447029, 13.256058634, 13.297801496, 13.337866713, 13.379226231, 13.418165598, 13.459054944, 13.503523051, 13.545801542, 13.589993354, 13.634415456, 13.673229894, 13.717166069, 13.760833667, 13.802549102, 13.845978793, 13.88229718, 13.926969094, 13.969741347, 14.020584773, 14.063497021, 14.106421511, 14.152376559, 14.192885937, 14.233765885, 14.277472304, 14.321183454, 14.360570142, 14.403758951, 14.448598585, 14.491167136, 14.535904218, 14.582947861, 14.625599789, 14.6725745, 14.718997839, 14.761394561, 14.805949596, 14.85064888, 14.900978513, 14.947169113, 14.988678489, 15.032559008, 15.079656832, 15.122400472, 15.165768732, 15.209963169, 15.253789963, 15.300347227, 15.34828837, 15.397736458, 15.446802477, 15.494129035, 15.541429672, 15.587533448, 15.630930492, 15.676975481, 15.7252804, 15.775569316, 15.817490142, 15.86337522, 15.910028822, 15.963110171, 16.009430943, 16.054258848, 16.107653575, 16.156613747, 16.199784742, 16.243867644, 16.287299954, 16.32696824, 16.374416464, 16.417341641, 16.466423906, 16.516651137, 16.566030678, 16.615128131, 16.660956649, 16.709823586, 16.751559968, 16.802611257, 16.851206243, 16.897381217, 16.945059797, 16.996349675, 17.047885504, 17.094325939, 17.145028236, 17.188949613, 17.23784932, 17.283040773, 17.335368552, 17.380830137, 17.432191617, 17.477342334, 17.522343222, 17.571868284, 17.626732386, 17.681486563, 17.731360134, 17.782254118, 17.831406757, 17.889086359, 17.946475557, 17.993779179, 18.041402291, 18.084195459, 18.13442774, 18.189057834, 18.230369028, 18.279297048, 18.332710638, 18.380173091, 18.433078423, 18.482581177, 18.534257243, 18.581851907, 18.630773355, 18.683385332, 18.736107211, 18.781480004, 18.830952675, 18.886293742, 18.934812728, 18.982849997, 19.029241319, 19.076808466, 19.134419092, 19.183730616, 19.237711915, 19.290681491, 19.339504392, 19.388826492, 19.443137431, 19.505296464, 19.555609928, 19.602510563, 19.654802599, 19.702613394, 19.749852122, 19.814617419, 19.874099968, 19.926560304, 19.977392071, 20.036302582, 20.08310231, 20.135710948, 20.191863305, 20.233985632, 20.295280106, 20.352643337, 20.412442544, 20.46905577, 20.530274006, 20.574552244, 20.623417583, 20.671652792, 20.71322837, 20.765396009, 20.829647709, 20.894267599, 20.948652775, 21.006803202, 21.065032762, 21.124631625, 21.177418975, 21.233856595, 21.284287337, 21.338137149, 21.391839824, 21.441121951, 21.498313528, 21.559519357, 21.617162637, 21.670632555, 21.726960279, 21.786469651, 21.848778285, 21.900742194, 21.962362608, 21.979373779, 22.01871292, 22.076232651, 22.136137723, 22.187333124, 22.254325159, 22.319807377, 22.36891191, 22.418047158, 22.463989396, 22.525807572, 22.587040357, 22.636714195, 22.696197237, 22.760031787, 22.826483125, 22.890958094, 22.954007825, 23.028399359, 23.081953225, 23.129389299, 23.188274871, 23.242092034, 23.305993814, 23.358684395, 23.424059202, 23.497833855, 23.554383565, 23.606629555, 23.661403119, 23.701969899, 23.780384594, 23.825702793, 23.877373878, 23.966125205, 24.017205302, 24.072975967, 24.124798126, 24.181005572, 24.246681188, 24.310037016, 24.367107045, 24.414851706, 24.458241738, 24.516092786, 24.576605709, 24.632139396, 24.696667518, 24.774270312, 24.822107577, 24.887105766, 24.936559127, 25.002189082, 25.067648224, 25.129798395, 25.181038414, 25.261466633, 25.328060622, 25.388807424, 25.452826854, 25.53190444, 25.597638426, 25.647577119, 25.729393405, 25.786076209, 25.874358524, 25.934108501, 25.996712748, 26.079586813, 26.153257474, 26.22619229, 26.334111008, 26.405668767, 26.461895992, 26.509088203, 26.566222856, 26.631079676, 26.709727496, 26.757476917, 26.82093597, 26.915255947, 26.958772112, 27.029781186, 27.123676888, 27.177861957, 27.24512325, 27.324220533, 27.373956212, 27.429742243, 27.517243075, 27.580190188, 27.669490052, 27.74731634, 27.806532893, 27.880325086, 27.938234397, 28.005807934, 28.078041358, 28.151126036, 28.233114182, 28.303061944, 28.362724087, 28.482449421, 28.543715886, 28.60891968, 28.684275342, 28.73812249, 28.790255745, 28.856823006, 28.948268523, 29.020813405, 29.105311365, 29.188942712, 29.264382098, 29.323187336, 29.419749977, 29.506224844, 29.590684595, 29.69251785, 29.762355789, 29.839526191, 29.911719723, 29.995192806, 30.034259432, 30.112406705, 30.166103964, 30.223056562, 30.281651634, 30.35005984, 30.416712998, 30.445453602, 30.518265699, 30.593615195, 30.645713067, 30.713217323, 30.804048252, 30.883023345, 31.003901638, 31.046771587, 31.122816878, 31.212532814, 31.298723674, 31.398619952, 31.440883872, 31.496929889, 31.592603628, 31.674449132, 31.752243274, 31.838803832, 31.910619642, 32.001721433, 32.072615429, 32.155554162, 32.226116959, 32.309959846, 32.363491875, 32.426054232, 32.524080404, 32.618500142, 32.66250955, 32.715304773, 32.766154792, 32.827417813, 32.923754107, 32.999298518, 33.056013895, 33.120438294, 33.183914486, 33.311475832, 33.380090976, 33.466218296, 33.524467037, 33.62453113, 33.730024043, 33.770387513, 33.803389335, 33.905473534, 33.962510923, 34.078107742, 34.170846129, 34.285455625, 34.340582899, 34.389445861, 34.438864935, 34.492961414, 34.547874308, 34.597981374, 34.685305069, 34.806943399, 34.845843342, 34.924446147, 34.99883105, 35.051775912, 35.168066969, 35.250212765, 35.358180427, 35.42194198, 35.450930676, 35.516288905, 35.614936573, 35.69816928, 35.760848373, 35.866269756, 35.959431873, 35.998217411, 36.083350983, 36.194064776, 36.305490025, 36.392964604, 36.435024894, 36.527155146, 36.627361762, 36.78730605, 36.943207047, 37.016190187, 37.106458608, 37.289090809, 37.37285272, 37.472465338, 37.518364903, 37.604077247, 37.645353034, 37.739465181, 37.798799306, 37.848797149, 38.017653285, 38.151153304, 38.270592145, 38.365140749, 38.396555631, 38.432455967, 38.548397827, 38.608158481, 38.764807265, 38.842300142, 38.868837425, 38.970094398, 39.123902739, 39.218598347, 39.277001895, 39.458020038, 39.527098458, 39.608606341, 39.68270487, 39.730388971, 39.858581072, 39.890642873, 39.981130037, 40.077966017, 40.147605449, 40.246266652, 40.389344258, 40.430330598, 40.479263556, 40.564555212, 40.617019975, 40.665790342, 40.759113925, 40.798994373, 40.9040053, 41.008785187, 41.114338928, 41.160073066, 41.201166377, 41.390401437, 41.570880301, 41.610134677, 41.670708795, 41.753299649, 41.808900843, 41.870709326, 42.027367466, 42.12826367, 42.166004591, 42.217055121, 42.311566581, 42.447228452, 42.556030326, 42.638700674, 42.77392623, 42.866600211, 43.049651544, 43.154833455, 43.217707662, 43.433421485, 43.509396471, 43.527760411, 43.621500364, 43.716025118, 43.837033557, 43.867298104, 44.086940006, 44.217152338, 44.337085035, 44.528633326, 44.58608817, 44.607529512, 44.685977954, 44.874825374, 44.905100576, 45.049288074, 45.063115702, 45.330354437, 45.377069644, 45.4762267, 45.477203394, 45.572780757, 45.625621463, 45.627282795, 45.753797945, 45.938842484, 46.03263932, 46.238160653, 46.543987971, 46.638833574, 46.680236943, 46.768101045, 46.779913475, 47.026021624, 47.055793392, 47.126439548, 47.579149862, 47.678981573, 47.75136798, 47.896502887, 47.908145028, 48.149598767, 48.208613037, 48.235845538, 48.310254024, 48.381232158, 48.413822693, 48.496609846, 48.592803436, 48.671243351, 48.744190707, 48.954761599, 48.998392745, 49.182614385, 49.198992275, 49.306254907), "1400" = c(1.7831e-05, 1.7941e-05, 1.8217e-05, 1.8611e-05, 1.8815e-05, 1.9081e-05, 1.9443e-05, 1.96e-05, 1.9702e-05, 1.9744e-05, 2.0181e-05, 2.0782e-05, 2.1256e-05, 2.1813e-05, 2.1882e-05, 2.3072e-05, 2.3142e-05, 2.418e-05, 2.4194e-05, 2.4341e-05, 2.4595e-05, 2.469e-05, 2.505e-05, 2.5082e-05, 2.546e-05, 2.5485e-05, 2.589e-05, 2.6002e-05, 2.6895e-05, 2.7061e-05, 2.7209e-05, 2.7959e-05, 2.8171e-05, 2.889e-05, 2.9398e-05, 2.968e-05, 2.9736e-05, 2.9963e-05, 3.0318e-05, 3.0687e-05, 3.0803e-05, 3.0845e-05, 3.1211e-05, 3.1812e-05, 3.2497e-05, 3.3099e-05, 3.388e-05, 3.4184e-05, 3.439e-05, 3.4522e-05, 3.4616e-05, 3.4846e-05, 3.5136e-05, 3.5875e-05, 3.6194e-05, 3.6733e-05, 3.6959e-05, 3.7536e-05, 3.7682e-05, 3.8127e-05, 3.8683e-05, 3.8843e-05, 3.9177e-05, 4.0012e-05, 4.1324e-05, 4.162e-05, 4.2317e-05, 4.2611e-05, 4.298e-05, 4.425e-05, 4.4502e-05, 4.4771e-05, 4.5106e-05, 4.5176e-05, 4.5575e-05, 4.6577e-05, 4.7041e-05, 4.7372e-05, 4.7525e-05, 4.8702e-05, 4.9524e-05, 4.9639e-05, 5.0106e-05, 5.0529e-05, 5.162e-05, 5.2778e-05, 5.3461e-05, 5.3734e-05, 5.4112e-05, 5.452e-05, 5.4948e-05, 5.547e-05, 5.6164e-05, 5.7591e-05, 5.8096e-05, 5.8566e-05, 5.9551e-05, 6.0805e-05, 6.1691e-05, 6.3108e-05, 6.4071e-05, 6.4929e-05, 6.5518e-05, 6.579e-05, 6.6076e-05, 6.7158e-05, 6.8531e-05, 7.0002e-05, 7.0515e-05, 7.081e-05, 7.0956e-05, 7.2237e-05, 7.2873e-05, 7.325e-05, 7.4685e-05, 7.5447e-05, 7.6158e-05, 7.7859e-05, 7.826e-05, 7.9464e-05, 7.9752e-05, 8.0332e-05, 8.0767e-05, 8.1917e-05, 8.2542e-05, 8.3134e-05, 8.3512e-05, 8.5169e-05, 8.5927e-05, 8.6353e-05, 8.7009e-05, 8.8044e-05, 8.8568e-05, 9.0191e-05, 9.1324e-05, 9.285e-05, 9.4366e-05, 9.5558e-05, 9.7074e-05, 9.7727e-05, 9.821e-05, 9.8713e-05, 9.9614e-05, 0.000100618, 0.000101704, 0.000102758, 0.000105049, 0.000105632, 0.000107586, 0.000109623, 0.000110474, 0.000112455, 0.000113752, 0.000116114, 0.000116857, 0.000119142, 0.000120064, 0.000123142, 0.000124947, 0.000127396, 0.000128653, 0.000129438, 0.000131851, 0.000132872, 0.000134863, 0.000136806, 0.000138167, 0.000141421, 0.000142609, 0.000143408, 0.000143968, 0.000145835, 0.000147066, 0.000148516, 0.000149553, 0.000151104, 0.000153825, 0.000156206, 0.000158041, 0.000159788, 0.000161304, 0.000162707, 0.000164898, 0.000166645, 0.000168446, 0.000170277, 0.000173114, 0.00017648, 0.000179495, 0.000182183, 0.000184009, 0.000187362, 0.000189811, 0.000192369, 0.00019459, 0.000197003, 0.000199655, 0.000201571, 0.000204675, 0.000207682, 0.000209182, 0.000212542, 0.000214426, 0.000215959, 0.000218297, 0.000221451, 0.000224371, 0.000225789, 0.000228894, 0.000231119, 0.00023454, 0.000237453, 0.000239955, 0.000242609, 0.000244545, 0.000247264, 0.00024904, 0.000252116, 0.000255853, 0.000258731, 0.00026079, 0.000263787, 0.000267283, 0.000270197, 0.000273633, 0.00027623, 0.000278359, 0.000281389, 0.000284484, 0.000288605, 0.000290886, 0.000293991, 0.000295431, 0.000299053, 0.00030227, 0.000304083, 0.000307362, 0.00031111, 0.000313991, 0.000317257, 0.000323222, 0.00032635, 0.000330884, 0.000335135, 0.000339207, 0.00034301, 0.00034574, 0.000349936, 0.000353446, 0.000357657, 0.000360733, 0.000366342, 0.000372668, 0.000375599, 0.000379071, 0.000384658, 0.000390366, 0.000396037, 0.000400398, 0.000407257, 0.000411043, 0.000413765, 0.000418226, 0.000422363, 0.00042617, 0.000433043, 0.000439303, 0.00044362, 0.000447518, 0.000451236, 0.000456108, 0.00046104, 0.000466301, 0.000470775, 0.000474497, 0.000480046, 0.000484521, 0.000490241, 0.000496422, 0.000502424, 0.000508108, 0.000515968, 0.000521293, 0.000527903, 0.000533974, 0.000539036, 0.000545418, 0.000553459, 0.000558079, 0.000564669, 0.000574388, 0.000580491, 0.000585254, 0.000590991, 0.00059658, 0.000603943, 0.00061044, 0.000616904, 0.000623054, 0.000630443, 0.000637127, 0.000644168, 0.000650663, 0.000658346, 0.000667783, 0.00067755, 0.00068299, 0.000690122, 0.000699591, 0.000707532, 0.000715653, 0.000724076, 0.000734332, 0.000742258, 0.000750528, 0.000757049, 0.00076384, 0.000773382, 0.000780601, 0.00078977, 0.000798184, 0.000804483, 0.000812235, 0.00082303, 0.000833368, 0.000844874, 0.000853381, 0.000863205, 0.000874652, 0.000883953, 0.000892882, 0.000901772, 0.000910768, 0.000921226, 0.000931078, 0.000943045, 0.000952734, 0.000962416, 0.000974802, 0.000984826, 0.000995642, 0.000998921, 0.001008043, 0.001020199, 0.001034847, 0.00104597, 0.001055822, 0.001064725, 0.00107654, 0.001088604, 0.001097583, 0.001108285, 0.001121048, 0.001136141, 0.001151544, 0.001164786, 0.00118078, 0.001195526, 0.001211035, 0.001227548, 0.00124237, 0.001254335, 0.001267827, 0.001282371, 0.001296894, 0.001309091, 0.001323164, 0.001338848, 0.001352798, 0.00137056, 0.001385016, 0.001398836, 0.001417044, 0.001431063, 0.001442989, 0.001460997, 0.001478356, 0.001497073, 0.00151401, 0.001530961, 0.001548813, 0.001568046, 0.001584921, 0.001603088, 0.001621672, 0.001638888, 0.001657925, 0.001680497, 0.001701322, 0.001721314, 0.001738647, 0.001760024, 0.001782289, 0.001801516, 0.001826175, 0.001846628, 0.001868996, 0.001893854, 0.00191508, 0.001936219, 0.001958154, 0.00198371, 0.002003217, 0.002025618, 0.002047152, 0.002069159, 0.002095042, 0.002120312, 0.002147799, 0.002175127, 0.002200075, 0.00222602, 0.002249754, 0.002275208, 0.002304546, 0.002332326, 0.002357866, 0.002384247, 0.002417239, 0.002445682, 0.002476115, 0.002506389, 0.002532678, 0.002562547, 0.002595661, 0.002626736, 0.002659281, 0.002691783, 0.002724389, 0.002758257, 0.002791711, 0.00282071, 0.002859123, 0.002897628, 0.002926212, 0.00295774, 0.002990777, 0.003027862, 0.003060847, 0.003099443, 0.00313426, 0.003167127, 0.003202866, 0.003237372, 0.003275173, 0.00331299, 0.00335026, 0.003387998, 0.003428177, 0.003470508, 0.003511506, 0.003553344, 0.003596898, 0.003635832, 0.003673839, 0.003716018, 0.003756955, 0.003800313, 0.003841522, 0.00388542, 0.003935598, 0.003981581, 0.004024964, 0.004064957, 0.004113363, 0.004161181, 0.004208517, 0.004258415, 0.004304457, 0.004359035, 0.004410823, 0.004457618, 0.004510807, 0.004564723, 0.004617506, 0.004667974, 0.004723028, 0.004776119, 0.004834308, 0.004889308, 0.004950506, 0.005009818, 0.005067709, 0.005128123, 0.005185226, 0.005245835, 0.005302674, 0.005362389, 0.005424943, 0.005483777, 0.005541555, 0.005601424, 0.005666328, 0.005731092, 0.005801125, 0.005876458, 0.005941965, 0.006009386, 0.006086423, 0.006156047, 0.006228982, 0.006302115, 0.006370551, 0.006444773, 0.006521206, 0.006598042, 0.006672904, 0.006752486, 0.00683559, 0.006907087, 0.006989825, 0.007066569, 0.007152042, 0.007232803, 0.007314167, 0.007393841, 0.007482537, 0.007568143, 0.00765811, 0.007745968, 0.007843669, 0.007936871, 0.008028197, 0.008115132, 0.008206672, 0.008304237, 0.008393474, 0.008493117, 0.008587774, 0.008684196, 0.008779884, 0.00888822, 0.008986635, 0.009093139, 0.009192889, 0.009299264, 0.009410611, 0.009519162, 0.00962003, 0.009732876, 0.009846762, 0.009935242, 0.009959522, 0.010078135, 0.01019167, 0.010312979, 0.010431056, 0.01055075, 0.010676978, 0.010804804, 0.010927679, 0.01104412, 0.01117174, 0.011304265, 0.011430419, 0.011556717, 0.011697134, 0.01183672, 0.011974694, 0.012116802, 0.012250956, 0.012401834, 0.012542011, 0.01269006, 0.012843861, 0.012995813, 0.01314788, 0.013299445, 0.013456905, 0.013604029, 0.013757391, 0.01391732, 0.014084718, 0.014249747, 0.014414406, 0.014593065, 0.01476755, 0.014933354, 0.015110561, 0.015289492, 0.015458509, 0.015633904, 0.015820811, 0.016001214, 0.016192583, 0.016365278, 0.016550122, 0.016742875, 0.016947451, 0.017140397, 0.017349719, 0.017553093, 0.017752365, 0.017956966, 0.018168062, 0.018371116, 0.018586213, 0.01882177, 0.019040949, 0.019251906, 0.019480295, 0.019704174, 0.019919995, 0.020151233, 0.020383799, 0.020631969, 0.020872085, 0.021114005, 0.021358482, 0.02161534, 0.021863279, 0.022110226, 0.022373713, 0.022631341, 0.022892308, 0.023157784, 0.023428334, 0.02369859, 0.023981441, 0.024274234, 0.024554533, 0.024837347, 0.025120866, 0.025422795, 0.025705822, 0.026006082, 0.026321311, 0.026630889, 0.026934877, 0.027246731, 0.027570721, 0.027888284, 0.028223972, 0.028565219, 0.028903063, 0.029243131, 0.029570553, 0.029900441, 0.030252719, 0.03060993, 0.030972154, 0.03133065, 0.031703092, 0.032068587, 0.032427498, 0.03278975, 0.03317027, 0.033561696, 0.033947039, 0.034347081, 0.034740006, 0.035135155, 0.035548408, 0.035967298, 0.036380853, 0.036803288, 0.037226308, 0.037657969, 0.038095012, 0.038543889, 0.038996519, 0.039460793, 0.039916708, 0.04038132, 0.040838207, 0.041312822, 0.041814392, 0.042291559, 0.04278887, 0.043273413, 0.04376992, 0.044276841, 0.044803905, 0.045312161, 0.045842142, 0.046377646, 0.04691486, 0.047467617, 0.048015043, 0.048582693, 0.049150278, 0.049732473, 0.050325174, 0.050902754, 0.051485506, 0.0520896, 0.052710511, 0.053330976, 0.053972506, 0.05459866, 0.055220276, 0.055879048, 0.056521209, 0.05718659, 0.057874583, 0.058567676, 0.059254534, 0.059952051, 0.060656017, 0.06136021, 0.062082199, 0.062818063, 0.063557802, 0.064309565, 0.065091908, 0.065840773, 0.066652898, 0.067429578, 0.068233059, 0.069043032, 0.069853244, 0.070669721, 0.07150363, 0.072314971, 0.073130794, 0.073997433, 0.074873937, 0.075756467, 0.076632126, 0.077541539, 0.078460833, 0.079395226, 0.080327735, 0.081270587, 0.082254817, 0.083209335, 0.084198798, 0.085207439, 0.086215355, 0.087245837, 0.088272613, 0.089307031, 0.090386991, 0.091442429, 0.092510079, 0.093633603, 0.09472008, 0.095843288, 0.096987019, 0.098131129, 0.099279874, 0.100476453, 0.101438849, 0.101690879, 0.102904875, 0.104162496, 0.105416044, 0.106667509, 0.107949782, 0.109232626, 0.110555224, 0.111883944, 0.113203209, 0.114562951, 0.115906331, 0.117306447, 0.118708657, 0.120104133, 0.121521496, 0.122966218, 0.124445082, 0.125936753, 0.127436368, 0.128964483, 0.130504319, 0.132096003, 0.1336863, 0.135276481, 0.136911111, 0.138554579, 0.140242268, 0.141938269, 0.143639853, 0.145413528, 0.147140853, 0.148903696, 0.150692133, 0.152512442, 0.154342111, 0.156183991, 0.158064246, 0.159948347, 0.16186326, 0.163799273, 0.165739463, 0.167723915, 0.169755963, 0.171802685, 0.173862164, 0.175960583, 0.178094205, 0.180250519, 0.182441674, 0.184684602, 0.186948612, 0.189254457, 0.191544006, 0.193859013, 0.196253067, 0.19865819, 0.201092421, 0.203518097, 0.20598771, 0.208486394, 0.211028033, 0.213629583, 0.216283244, 0.218866183, 0.221575107, 0.224254748, 0.227006951, 0.229787496, 0.23258628, 0.235442661, 0.238352108, 0.241268666, 0.244216287, 0.247228453, 0.250191699, 0.253247737, 0.256316727, 0.259516443, 0.262718883, 0.265919953, 0.269178395, 0.272523273, 0.27587615, 0.279282925, 0.282749436, 0.286185158, 0.289741431, 0.293385233, 0.297030959, 0.30075067, 0.304507308, 0.308322805, 0.312162702, 0.31602327, 0.319949115, 0.32082789, 0.323919928, 0.32800637, 0.332108143, 0.336335469, 0.340551434, 0.344855098, 0.349146596, 0.353522555, 0.357995419, 0.362504701, 0.367054137, 0.371761268, 0.376467704, 0.381234707, 0.386070036, 0.390982324, 0.395960356, 0.401035034, 0.406216225, 0.411399878, 0.416630596, 0.42204557, 0.427474799, 0.432953557, 0.43850481, 0.439637128, 0.444120589, 0.449814512, 0.455618014, 0.461540739, 0.467553056, 0.473607745, 0.479753686, 0.485990488, 0.492335079, 0.498836804, 0.505396717, 0.51210224, 0.518858833, 0.525725111, 0.532669852, 0.539722327, 0.546858099, 0.554081562, 0.56141069, 0.568903591, 0.57650255, 0.584234115, 0.592035779, 0.599906348, 0.608005073, 0.616195718, 0.624589331, 0.633122478, 0.641746731, 0.650495154, 0.659399327, 0.668324764, 0.677460417, 0.686782765, 0.696259463, 0.700301934, 0.705899259, 0.715675488, 0.725611088, 0.735722033, 0.746057065, 0.756582727, 0.767193548, 0.777981781, 0.78904289, 0.800194613, 0.811567615, 0.823100716, 0.834898847, 0.84695932, 0.8591844, 0.871573539, 0.884180699, 0.8970998, 0.910189396, 0.923553666, 0.93717811, 0.951042684, 0.965058713, 0.979335098, 0.99403733, 1.000124592, 1.009045808, 1.024271013, 1.039680589, 1.055458033, 1.071505688, 1.087802123, 1.104611766, 1.121633766, 1.138937738, 1.156798675, 1.174973474, 1.193468466, 1.212365717, 1.231729056, 1.251584591, 1.271916935, 1.292545093, 1.313585597, 1.335042505, 1.352472153, 1.392405154, 1.414543673, 1.43686263, 1.45897607, 1.48107273, 1.50350833, 1.525800085, 1.547909482, 1.570169267, 1.5923381, 1.614664762, 1.636791955, 1.65900005, 1.681098133, 1.70317778, 1.725288768, 1.747378227, 1.76976488, 1.782778916, 1.791981715, 1.814180111, 1.836370847, 1.858529791, 1.880726916, 1.902889968, 1.925097569, 1.94722753, 1.969424357, 1.991706858, 2.014070828, 2.036361554, 2.058676466, 2.080699189, 2.103094261, 2.125066539, 2.147066555, 2.169353535, 2.191574977, 2.213638703, 2.235763161, 2.257934161, 2.28023901, 2.302584566, 2.324761302, 2.337511352, 2.346815031, 2.368966758, 2.391271784, 2.413409591, 2.435552978, 2.457650243, 2.479793129, 2.501849394, 2.524336938, 2.546429655, 2.568607336, 2.590855205, 2.613209996, 2.635270247, 2.657583863, 2.67977755, 2.701883395, 2.724197234, 2.746577633, 2.76894576, 2.791476991, 2.813944478, 2.836100422, 2.858443026, 2.880696097, 2.903153652, 2.925446298, 2.947913348, 2.970358702, 2.992546444, 3.014920703, 3.037222479, 3.059384704, 3.081885344, 3.104212545, 3.1221715, 3.126934893, 3.14919205, 3.17146431, 3.193885139, 3.216585498, 3.23910276, 3.26139601, 3.28373027, 3.306140629, 3.328819697, 3.351293439, 3.373959545, 3.396266108, 3.419012072, 3.441824954, 3.464493648, 3.4870455, 3.509724987, 3.532051506, 3.554771465, 3.577219109, 3.599880612, 3.62264978, 3.645040802, 3.667428476, 3.685154909, 3.690176794, 3.71259837, 3.735831218, 3.75826397, 3.781220472, 3.803975884, 3.826641724, 3.849586616, 3.872566093, 3.895255119, 3.918110252, 3.940907203, 3.963847592, 3.986845659, 4.009553881, 4.032554549, 4.056075874, 4.079107147, 4.101923222, 4.1248161, 4.147673198, 4.170725359, 4.193650891, 4.216625512, 4.239771311, 4.262962181, 4.28593134, 4.309075923, 4.331887794, 4.354919716, 4.377852362, 4.401203027, 4.424622265, 4.447788967, 4.471319732, 4.494491303, 4.517762387, 4.540916493, 4.56437975, 4.587635475, 4.611013723, 4.634591771, 4.657716703, 4.681172443, 4.704258512, 4.727680408, 4.751662216, 4.775630949, 4.799375101, 4.822920346, 4.847012334, 4.870776346, 4.894275208, 4.917799179, 4.941433236, 4.965508646, 4.98943228, 5.013190794, 5.037299313, 5.06129845, 5.085314705, 5.109730231, 5.134200811, 5.157868971, 5.181704814, 5.205492551, 5.229504309, 5.253819511, 5.277649258, 5.301522574, 5.325311026, 5.349664055, 5.37413671, 5.398981341, 5.422677412, 5.447084989, 5.471267717, 5.496017379, 5.520919705, 5.544971916, 5.569645408, 5.594307293, 5.619380631, 5.643598633, 5.668194373, 5.691832144, 5.71632921, 5.740995436, 5.765339322, 5.789863149, 5.814550383, 5.839177576, 5.863681455, 5.888341346, 5.913130635, 5.9381396, 5.943094981, 5.963447465, 5.989105859, 6.013914392, 6.039148704, 6.064388766, 6.089931626, 6.114906488, 6.14063807, 6.166133609, 6.191432074, 6.216686792, 6.24158708, 6.267433495, 6.292019684, 6.317895135, 6.342935502, 6.368706992, 6.39413743, 6.419749472, 6.444950483, 6.470879433, 6.495966135, 6.521601399, 6.547428989, 6.573293606, 6.599667493, 6.625018651, 6.651138818, 6.67751432, 6.704021371, 6.730062821, 6.755603606, 6.781644804, 6.807974411, 6.834200405, 6.860836025, 6.887162462, 6.913342178, 6.940281284, 6.966891035, 6.993895708, 7.020603287, 7.047296804, 7.072358263, 7.099091796, 7.126616926, 7.152335727, 7.178526477, 7.204126957, 7.230336709, 7.256502058, 7.283533298, 7.311191138, 7.339081494, 7.366224283, 7.392941032, 7.420503728, 7.448082361, 7.475081667, 7.50212611, 7.530232715, 7.557857142, 7.585262992, 7.613434275, 7.641245297, 7.669204983, 7.69679902, 7.724253894, 7.753040358, 7.781479345, 7.810388643, 7.838479852, 7.866158738, 7.894403754, 7.92263794, 7.951301026, 7.979898607, 8.008146978, 8.035820435, 8.063988604, 8.092353605, 8.121015088, 8.149615563, 8.177256764, 8.206719413, 8.236145812, 8.265354014, 8.294641915, 8.323236457, 8.351906726, 8.381429761, 8.41020102, 8.438678018, 8.468692193, 8.498535515, 8.528851288, 8.558452306, 8.587794727, 8.617652046, 8.647928708, 8.677810688, 8.706882254, 8.738057133, 8.766542253, 8.795352902, 8.825000791, 8.853604781, 8.882366887, 8.912259335, 8.941359824, 8.971910441, 9.003040639, 9.0325685, 9.063552796, 9.095102748, 9.124930782, 9.155233753, 9.185071473, 9.215697931, 9.247358748, 9.277479873, 9.308741793, 9.340122526, 9.371546338, 9.403223964, 9.434258225, 9.465002121, 9.496099392, 9.530055097, 9.562239177, 9.594208415, 9.625496374, 9.656909142, 9.687405356, 9.719912779, 9.751652745, 9.782886456, 9.815346534, 9.845713223, 9.878469807, 9.909888992, 9.94171453, 9.974679569, 10.00941817, 10.040476713, 10.072877677, 10.106066174, 10.138047889, 10.171349801, 10.203834184, 10.23558378, 10.269715313, 10.302368255, 10.334858227, 10.368856342, 10.401547277, 10.43280348, 10.465735795, 10.497516923, 10.532617352, 10.566311433, 10.599801776, 10.632991956, 10.664670284, 10.697973848, 10.731601236, 10.763472955, 10.796222722, 10.82739145, 10.860815763, 10.893553973, 10.924512156, 10.956755399, 10.990583987, 11.025800065, 11.06099685, 11.096347767, 11.130434196, 11.163067337, 11.199134945, 11.234011985, 11.269368734, 11.304387845, 11.341446697, 11.37820082, 11.41201887, 11.445561399, 11.476793513, 11.510878799, 11.548182173, 11.583837822, 11.619457603, 11.65383984, 11.690209306, 11.724295129, 11.759833087, 11.794034973, 11.829217053, 11.862524217, 11.899156462, 11.906123285, 11.933209308, 11.967090838, 12.001851064, 12.037296007, 12.073697583, 12.109156117, 12.144370649, 12.182131016, 12.21941042, 12.253657567, 12.291568426, 12.329046714, 12.367405548, 12.408098049, 12.445229501, 12.482853644, 12.519304572, 12.55913932, 12.596134817, 12.632016299, 12.671528505, 12.705914465, 12.739578814, 12.774686387, 12.81630976, 12.854116714, 12.893962317, 12.929851152, 12.969139888, 13.007732794, 13.046307261, 13.08559139, 13.125310613, 13.164579981, 13.205254569, 13.246529852, 13.282731898, 13.318678576, 13.358918939, 13.39653093, 13.433052873, 13.469031917, 13.508508501, 13.545899121, 13.58018394, 13.61683416, 13.657073832, 13.695262213, 13.73520164, 13.773689734, 13.814976363, 13.852312027, 13.897784269, 13.934360393, 13.975412058, 14.017775214, 14.051730767, 14.09115577, 14.127704395, 14.167873753, 14.209398833, 14.245705413, 14.282923621, 14.317111627, 14.358878171, 14.402716347, 14.442466432, 14.482032655, 14.526472438, 14.565763317, 14.605487159, 14.644731579, 14.68674541, 14.726613209, 14.766155082, 14.809388935, 14.847757844, 14.886066221, 14.927240125, 14.969691191, 15.01128237, 15.05347297, 15.094701095, 15.138650958, 15.179364646, 15.223441962, 15.264190485, 15.306670381, 15.344773763, 15.384057016, 15.43342212, 15.476165914, 15.518530034, 15.559279257, 15.598846582, 15.634505575, 15.671366448, 15.711712561, 15.752076947, 15.793430803, 15.838631265, 15.879485889, 15.918404272, 15.965431106, 16.002836763, 16.045639074, 16.082835888, 16.126737456, 16.168760989, 16.206079305, 16.250720863, 16.290902509, 16.327539773, 16.370887493, 16.410487856, 16.45104139, 16.492869633, 16.536189862, 16.569847576, 16.61464104, 16.655393506, 16.694050244, 16.734066475, 16.775543007, 16.819962176, 16.860902805, 16.904973359, 16.950457987, 16.998355971, 17.036009891, 17.078014944, 17.121025123, 17.158264308, 17.204801211, 17.248207952, 17.293208549, 17.338506267, 17.381946465, 17.42078027, 17.468614647, 17.520907535, 17.566355318, 17.606759332, 17.654072879, 17.699799495, 17.741657194, 17.789275838, 17.835491312, 17.88122275, 17.922041947, 17.977885118, 18.025175244, 18.067189375, 18.1136232, 18.165575957, 18.206768316, 18.248437206, 18.296010955, 18.347090183, 18.391092829, 18.437449124, 18.47793348, 18.522193401, 18.564947938, 18.613807975, 18.66408711, 18.702975645, 18.744388855, 18.783550179, 18.828238188, 18.885045547, 18.924226509, 18.967445602, 19.005363159, 19.047125626, 19.09819107, 19.152194472, 19.199611854, 19.247924173, 19.2910138, 19.33743649, 19.381901013, 19.426921453, 19.473018914, 19.512539389, 19.558920115, 19.608999834, 19.66878986, 19.717969512, 19.763690546, 19.816212359, 19.863869136, 19.917294436, 19.963871525, 20.007901889, 20.059031663, 20.104103646, 20.148968851, 20.208784874, 20.250611304, 20.260864673, 20.301633064, 20.356242161, 20.410323694, 20.475885128, 20.529820987, 20.585500615, 20.637192051, 20.68271839, 20.731569614, 20.776363445, 20.834937128, 20.909834124, 20.956168503, 21.002129131, 21.052588409, 21.094520126, 21.152101549, 21.188800537, 21.244103764, 21.310006433, 21.354955521, 21.40206369, 21.451007678, 21.496271298, 21.556132338, 21.596261685, 21.647609367, 21.699590413, 21.757692891, 21.799117089, 21.853644828, 21.909484857, 21.964467698, 22.008776652, 22.068830939, 22.121923491, 22.162710405, 22.215669156, 22.2693537, 22.323182076, 22.370740573, 22.424421703, 22.466611751, 22.531483557, 22.570230473, 22.617088966, 22.682316728, 22.724022677, 22.776742054, 22.846380802, 22.894232053, 22.937789069, 22.98876521, 23.031455078, 23.086757448, 23.12985261, 23.194654071, 23.248685814, 23.30577049, 23.366295531, 23.405813505, 23.453791538, 23.515263701, 23.561628285, 23.601817044, 23.647521613, 23.681187305, 23.724276935, 23.780825527, 23.832248062, 23.880707677, 23.92956275, 23.981621568, 24.016026022, 24.072275342, 24.119481715, 24.16720295, 24.231751128, 24.274181962, 24.312844376, 24.37659505, 24.438828699, 24.487800035, 24.542615578, 24.58945204, 24.633320195, 24.695411749, 24.770024218, 24.835249015, 24.889796744, 24.923664032, 24.96557347, 25.025889114, 25.090011401, 25.126508622, 25.163440205, 25.223166277, 25.267377228, 25.344636145, 25.39815572, 25.436128022, 25.487430653, 25.55223161, 25.597565588, 25.652514018, 25.705482866, 25.74953022, 25.792848257, 25.828800816, 25.869168934, 25.936397709, 26.002356204, 26.053682635, 26.08087032, 26.132783828, 26.173515992, 26.229510266, 26.272451472, 26.309083047, 26.359753651, 26.401396449, 26.439655782, 26.52359056, 26.570079827, 26.618393095, 26.666802646, 26.727531139, 26.791988234, 26.848400995, 26.885521682, 26.967373135, 27.054281972, 27.126185196, 27.183460336, 27.223065766, 27.289476595, 27.375225828, 27.439923738, 27.477301541, 27.521925285, 27.570839079, 27.616758862, 27.656552659, 27.703057733, 27.761724127, 27.823437408, 27.882175375, 27.922825706, 27.960352229, 28.032756295, 28.07334876, 28.131610108, 28.169855066, 28.231016279, 28.278081515, 28.335405431, 28.413819878, 28.480196918, 28.537600887, 28.598292655, 28.675957775, 28.72404327, 28.769166625, 28.807193164, 28.90209439, 28.962740334, 29.018164949, 29.137117605, 29.194046141, 29.264688281, 29.321271073, 29.403531514, 29.445165682, 29.545930535, 29.606740538, 29.666936289, 29.776747342, 29.80744734, 29.859842159, 29.901741074, 29.93032483, 29.963381947, 29.998891358, 30.045012452, 30.11812948, 30.199097058, 30.238209676, 30.287112238, 30.374915642, 30.431931488, 30.501493336, 30.542877905, 30.635749315, 30.670782714, 30.785330861, 30.835762564, 30.865149921, 30.914420871, 30.944687051, 31.01630189, 31.044910467, 31.090188515, 31.171517457, 31.208208842, 31.276984199, 31.322863365, 31.397462852, 31.426239419, 31.469240155, 31.498110677, 31.55080374, 31.61311541, 31.67985269, 31.717604212, 31.810703749, 31.855962473, 31.885165866, 31.936221169, 31.991485511, 32.095267577, 32.149774825, 32.215132505, 32.255260932, 32.357580683, 32.422995529, 32.476985465, 32.541405968, 32.606052982, 32.639744704, 32.68682831, 32.74459581, 32.886422118, 32.962292367, 32.986547533, 33.078495458, 33.095588872, 33.22660229, 33.305341441, 33.381124971, 33.47112108, 33.513695621, 33.594251757, 33.664915995, 33.751212262, 33.801982951, 33.870467069, 33.967773124, 34.016359868, 34.116978732, 34.213198621, 34.291303944, 34.35267169, 34.405031834, 34.504573306, 34.599669406, 34.667354694, 34.756180964, 34.772101323, 34.800954217, 34.829519917, 34.894981847, 34.962036857, 34.989634698, 35.139006994, 35.191216342, 35.303532396, 35.381490532, 35.40344537, 35.434872406, 35.511672376, 35.636608928, 35.719547598, 35.830798778, 35.941286771, 35.995870806, 36.048051451, 36.134846943, 36.174543236, 36.252959754, 36.320845061, 36.411175035, 36.465428134, 36.536601048, 36.552838305, 36.621592403, 36.651809219, 36.683483414, 36.689399464, 36.716580037, 36.751964023, 36.795326349, 36.831413385, 36.843559234, 36.900053899, 36.989542159, 37.114403425, 37.199344052, 37.221008725, 37.421660163, 37.546276656, 37.550029287, 37.597373401, 37.683463608, 37.77477639, 37.792971714, 37.975615327, 38.092603058, 38.235941387, 38.378966583, 38.415297286, 38.42722264, 38.567016786, 38.727151144, 38.742254089, 38.766900609, 38.8570361, 38.930008015, 38.971851011, 39.212871608, 39.233183416, 39.43810679, 39.486847253, 39.540422443, 39.711002872, 39.74067893, 39.833629017, 39.841016861, 40.044551158, 40.054603865, 40.370238296, 40.396922984, 40.489101459, 40.53998817, 40.556387706, 40.569473614, 40.652730554, 40.672932824, 40.74787794, 40.855127934, 40.96580759), "1600" = c(1.9608e-05, 1.9648e-05, 1.9727e-05, 2.0009e-05, 2.0041e-05, 2.0139e-05, 2.0404e-05, 2.0586e-05, 2.0881e-05, 2.098e-05, 2.0996e-05, 2.1208e-05, 2.1646e-05, 2.2085e-05, 2.2228e-05, 2.2776e-05, 2.305e-05, 2.3159e-05, 2.3327e-05, 2.3809e-05, 2.3967e-05, 2.5013e-05, 2.5054e-05, 2.5344e-05, 2.6033e-05, 2.6367e-05, 2.6606e-05, 2.6877e-05, 2.7451e-05, 2.7841e-05, 2.7963e-05, 2.8765e-05, 2.9129e-05, 2.9248e-05, 3.0029e-05, 3.1115e-05, 3.1445e-05, 3.1527e-05, 3.1743e-05, 3.2646e-05, 3.266e-05, 3.3491e-05, 3.3662e-05, 3.3833e-05, 3.4055e-05, 3.4456e-05, 3.454e-05, 3.5166e-05, 3.5674e-05, 3.5783e-05, 3.6293e-05, 3.6576e-05, 3.6828e-05, 3.7116e-05, 3.7307e-05, 3.7549e-05, 3.7707e-05, 3.8436e-05, 3.8537e-05, 3.9156e-05, 3.9638e-05, 4.0333e-05, 4.0407e-05, 4.1254e-05, 4.1391e-05, 4.1557e-05, 4.2304e-05, 4.2535e-05, 4.3134e-05, 4.3469e-05, 4.4021e-05, 4.4534e-05, 4.4883e-05, 4.5663e-05, 4.6507e-05, 4.7421e-05, 4.8536e-05, 4.8858e-05, 4.9498e-05, 5.0205e-05, 5.0792e-05, 5.1395e-05, 5.2132e-05, 5.2864e-05, 5.3111e-05, 5.438e-05, 5.4629e-05, 5.5095e-05, 5.5176e-05, 5.6272e-05, 5.6604e-05, 5.7165e-05, 5.737e-05, 5.8394e-05, 5.8911e-05, 5.962e-05, 5.9769e-05, 5.9977e-05, 6.0294e-05, 6.0669e-05, 6.0788e-05, 6.2715e-05, 6.3488e-05, 6.3968e-05, 6.4149e-05, 6.5143e-05, 6.5705e-05, 6.6558e-05, 6.7992e-05, 6.8934e-05, 6.935e-05, 6.9942e-05, 7.0384e-05, 7.1346e-05, 7.2086e-05, 7.2511e-05, 7.2964e-05, 7.3703e-05, 7.4205e-05, 7.4706e-05, 7.5241e-05, 7.7104e-05, 7.7865e-05, 7.8385e-05, 8.0289e-05, 8.158e-05, 8.193e-05, 8.2404e-05, 8.3532e-05, 8.4174e-05, 8.5311e-05, 8.5934e-05, 8.6961e-05, 8.8601e-05, 8.9361e-05, 9.1574e-05, 9.2368e-05, 9.3477e-05, 9.4418e-05, 9.5328e-05, 9.5785e-05, 9.6351e-05, 9.7946e-05, 9.9014e-05, 9.9914e-05, 0.000101638, 0.000103633, 0.000105045, 0.000106481, 0.000107, 0.00010876, 0.000110241, 0.000111898, 0.000113577, 0.000115178, 0.000116739, 0.000118434, 0.000119892, 0.00012238, 0.000123131, 0.000124411, 0.000125164, 0.000126644, 0.000127636, 0.000128797, 0.000130438, 0.000133073, 0.000134469, 0.000135637, 0.000136585, 0.000138459, 0.000140227, 0.000141832, 0.00014371, 0.000145563, 0.000147242, 0.000149543, 0.000150163, 0.000151477, 0.000152457, 0.000154833, 0.000156335, 0.000158661, 0.000160509, 0.000162146, 0.000163496, 0.00016585, 0.000168024, 0.000170576, 0.000173971, 0.000176986, 0.000178693, 0.00018082, 0.000182338, 0.000184639, 0.000186151, 0.000187686, 0.000190065, 0.00019204, 0.000194543, 0.000197008, 0.000198837, 0.000199687, 0.000201194, 0.000204191, 0.000206865, 0.000209102, 0.000211181, 0.000214209, 0.000216775, 0.000220638, 0.000223163, 0.000225164, 0.000227157, 0.000229533, 0.000230987, 0.000234294, 0.000236859, 0.000238718, 0.000241831, 0.000244894, 0.000247702, 0.000252175, 0.000255984, 0.000258987, 0.000262327, 0.000267135, 0.000270125, 0.000273046, 0.000276148, 0.000278128, 0.00028031, 0.000285022, 0.000287534, 0.000291167, 0.000293897, 0.000297144, 0.000299136, 0.000302594, 0.000307489, 0.000310602, 0.000314946, 0.000319264, 0.0003233, 0.000325702, 0.00032958, 0.000332149, 0.000334744, 0.000339388, 0.000343894, 0.000348425, 0.00035381, 0.000357602, 0.000362248, 0.000366632, 0.000370196, 0.000373131, 0.0003792, 0.000383007, 0.000388162, 0.000393247, 0.000397325, 0.000401533, 0.000405681, 0.000409477, 0.000416028, 0.000421962, 0.00042728, 0.000430528, 0.000435504, 0.000439555, 0.000445165, 0.000452395, 0.000458133, 0.000464227, 0.000470577, 0.000474971, 0.000480308, 0.000485912, 0.000493768, 0.000499034, 0.000504568, 0.000510515, 0.000518386, 0.000525701, 0.00053136, 0.000537427, 0.000543175, 0.000549798, 0.000556652, 0.00056581, 0.000571205, 0.00057816, 0.000584698, 0.000590741, 0.000596818, 0.000605053, 0.000611814, 0.000619932, 0.000627088, 0.000633434, 0.000642642, 0.0006506, 0.000658292, 0.000667178, 0.000674553, 0.000682585, 0.000690141, 0.000697951, 0.000705781, 0.000716598, 0.000724589, 0.000733255, 0.000741133, 0.000748811, 0.00075455, 0.000760989, 0.00076857, 0.000778212, 0.000787916, 0.000797474, 0.000809724, 0.000818929, 0.000830413, 0.00083854, 0.000847903, 0.000857198, 0.000865811, 0.000877492, 0.000887602, 0.000899217, 0.000908817, 0.000920277, 0.000932576, 0.000944885, 0.000952942, 0.000964371, 0.000974871, 0.000986834, 0.000997008, 0.001007407, 0.0010103, 0.00102127, 0.001031801, 0.001041964, 0.001052419, 0.001063847, 0.00107781, 0.001090016, 0.001102961, 0.001114682, 0.001124333, 0.001137592, 0.001149969, 0.001167903, 0.001180698, 0.001195647, 0.001209181, 0.001222212, 0.001237155, 0.001253557, 0.001266142, 0.001279445, 0.001294372, 0.001306666, 0.001323518, 0.001339331, 0.001357541, 0.001371849, 0.001385865, 0.001401686, 0.001420666, 0.001437118, 0.001453388, 0.001467082, 0.001482054, 0.001498343, 0.001515962, 0.001535743, 0.001550804, 0.001567058, 0.001582374, 0.001600578, 0.001621506, 0.0016405, 0.001661329, 0.001679951, 0.001702053, 0.001723209, 0.001743781, 0.001766747, 0.001784785, 0.001804502, 0.001825268, 0.001846743, 0.001870399, 0.0018882, 0.001905816, 0.001928426, 0.001951168, 0.00197417, 0.001996004, 0.002015532, 0.002036926, 0.002057964, 0.002082128, 0.002107694, 0.002131287, 0.002156351, 0.00218091, 0.002204043, 0.002229679, 0.002254802, 0.002282737, 0.00230747, 0.002337905, 0.002363414, 0.002391698, 0.002414529, 0.002440758, 0.002467858, 0.002497623, 0.002528854, 0.002555771, 0.002587122, 0.002616973, 0.00264712, 0.002680035, 0.002709456, 0.002738223, 0.002772198, 0.002801418, 0.00283865, 0.002867849, 0.002901419, 0.002931064, 0.002961736, 0.002996275, 0.00303342, 0.00306783, 0.003106326, 0.003137532, 0.003177853, 0.003214556, 0.00325315, 0.003288313, 0.003326135, 0.003367202, 0.003404877, 0.003445778, 0.003488188, 0.003531544, 0.003575849, 0.003616207, 0.003656485, 0.003697793, 0.00373393, 0.003779821, 0.003827249, 0.003872268, 0.003921892, 0.003971794, 0.004011367, 0.004060488, 0.004105589, 0.00415167, 0.004193045, 0.0042359, 0.00428922, 0.004332596, 0.00438236, 0.004436557, 0.004490335, 0.004542976, 0.004598667, 0.004648224, 0.004707669, 0.00476332, 0.004820933, 0.00487856, 0.004931938, 0.004988346, 0.005036333, 0.005095563, 0.005157784, 0.005212247, 0.005274377, 0.005333954, 0.005399004, 0.005459576, 0.005525137, 0.005592215, 0.005656783, 0.005728735, 0.00579675, 0.00585996, 0.005926989, 0.005999954, 0.006076654, 0.006144013, 0.006210273, 0.00628234, 0.006350621, 0.006425043, 0.006498696, 0.006576208, 0.006650547, 0.006731562, 0.006809107, 0.00689037, 0.006974664, 0.007062075, 0.007146844, 0.00722866, 0.007315649, 0.0073949, 0.007481442, 0.007564301, 0.007654682, 0.007743107, 0.007823353, 0.007907365, 0.007993999, 0.008086297, 0.008178087, 0.008270875, 0.008368043, 0.008466144, 0.008559625, 0.008660029, 0.008757896, 0.008863688, 0.00896028, 0.009062079, 0.009167135, 0.009280718, 0.009386579, 0.009487364, 0.009598223, 0.009713882, 0.009832575, 0.009919475, 0.009946867, 0.010057721, 0.010174549, 0.010292708, 0.010417993, 0.010539793, 0.010661047, 0.010785576, 0.010906694, 0.011033031, 0.011173554, 0.011303163, 0.011428046, 0.011554525, 0.011689424, 0.011827982, 0.011972646, 0.012112454, 0.012259515, 0.012398831, 0.012540376, 0.012686258, 0.01283184, 0.01298467, 0.013133881, 0.013280041, 0.013435068, 0.013581967, 0.013746377, 0.013909884, 0.014068109, 0.014232, 0.014399898, 0.014569567, 0.014751051, 0.014921487, 0.015093927, 0.015267785, 0.015440931, 0.015619531, 0.015797833, 0.015991919, 0.016183064, 0.016376191, 0.016555717, 0.016749219, 0.016936646, 0.017118963, 0.017324913, 0.017528987, 0.017737855, 0.017945007, 0.018157602, 0.018364985, 0.018590534, 0.018814443, 0.019049483, 0.019274873, 0.019504447, 0.019733016, 0.019959117, 0.020203727, 0.020432253, 0.020669645, 0.020915064, 0.021168859, 0.021405693, 0.021662116, 0.021919422, 0.02217014, 0.022437214, 0.022691281, 0.022959496, 0.02322258, 0.023490352, 0.023772717, 0.024053644, 0.024336686, 0.024608589, 0.024897038, 0.025186381, 0.02547233, 0.025767037, 0.026060726, 0.026353098, 0.026654712, 0.026963741, 0.027267906, 0.027585446, 0.027912959, 0.028229763, 0.02853743, 0.028882079, 0.029210589, 0.029546228, 0.029892296, 0.030233018, 0.030600219, 0.030956478, 0.03130502, 0.031676159, 0.032046511, 0.032412659, 0.032790146, 0.033181605, 0.033567581, 0.033953982, 0.034341506, 0.034731434, 0.035130116, 0.035544055, 0.035945951, 0.03636141, 0.036788304, 0.037217739, 0.03765034, 0.038096194, 0.038538564, 0.038978488, 0.039442876, 0.039894266, 0.040372895, 0.04083233, 0.041309209, 0.041805408, 0.042306804, 0.042806917, 0.043294524, 0.043806263, 0.044314986, 0.044835526, 0.045353608, 0.045877006, 0.046402208, 0.04695312, 0.047496679, 0.048053065, 0.048611292, 0.049181859, 0.049767139, 0.050339708, 0.050951946, 0.05153766, 0.052142431, 0.052767165, 0.05337718, 0.053996316, 0.054642896, 0.05525726, 0.055896179, 0.056555187, 0.057225787, 0.057898253, 0.05857945, 0.059271187, 0.059968963, 0.060689466, 0.061393938, 0.062134928, 0.06283996, 0.063599242, 0.064355874, 0.065126401, 0.065893865, 0.066675653, 0.067449514, 0.068249411, 0.069028923, 0.069839254, 0.070639622, 0.071483182, 0.072338802, 0.073164123, 0.073991743, 0.074853715, 0.07574516, 0.07665707, 0.077565151, 0.078504158, 0.079411986, 0.08033844, 0.081280688, 0.082244622, 0.083215287, 0.084190493, 0.085168159, 0.08617903, 0.087199267, 0.088231057, 0.089277281, 0.090327973, 0.091394135, 0.092491532, 0.093592559, 0.094700481, 0.095801566, 0.096934808, 0.098077559, 0.09923554, 0.100408144, 0.101342244, 0.101581964, 0.102799278, 0.104035833, 0.105252859, 0.106485856, 0.107765218, 0.109056564, 0.110361397, 0.111704873, 0.113051946, 0.114382018, 0.115755541, 0.117129819, 0.118539953, 0.119971105, 0.12139324, 0.122859848, 0.124296569, 0.125760445, 0.127249288, 0.128759327, 0.130283119, 0.131840809, 0.133413958, 0.13501097, 0.136635398, 0.138319555, 0.139949203, 0.141627465, 0.14331139, 0.145025488, 0.146803641, 0.14852178, 0.150343154, 0.152131926, 0.153963843, 0.155841704, 0.15772419, 0.159569409, 0.161489262, 0.163464392, 0.165429376, 0.167406227, 0.169459197, 0.171517532, 0.173574529, 0.175714045, 0.177821718, 0.180004145, 0.182211284, 0.184468577, 0.186723296, 0.188979943, 0.191235228, 0.193546528, 0.195906166, 0.198290112, 0.200685291, 0.203120711, 0.205612479, 0.208131298, 0.21069092, 0.213270603, 0.215872227, 0.218510376, 0.221216802, 0.223929011, 0.226692725, 0.229506877, 0.232311141, 0.2351993, 0.238052004, 0.240955432, 0.243965712, 0.246968563, 0.250028176, 0.253116323, 0.256213911, 0.259343908, 0.262526436, 0.265779164, 0.269065249, 0.272438077, 0.27583639, 0.279266913, 0.282695665, 0.286246667, 0.289859822, 0.293391598, 0.297059828, 0.300787608, 0.304442371, 0.308265006, 0.312135158, 0.316008857, 0.320004978, 0.320894683, 0.324051021, 0.328118213, 0.332190459, 0.336370706, 0.340594626, 0.344888683, 0.349314441, 0.353690315, 0.358136965, 0.36265863, 0.367235229, 0.3719252, 0.376683997, 0.381489971, 0.386318183, 0.39127182, 0.396243372, 0.401427221, 0.406567475, 0.411843889, 0.417142071, 0.42248601, 0.427981978, 0.433494009, 0.4390649, 0.440231083, 0.444743833, 0.450498579, 0.456359969, 0.462209895, 0.468136755, 0.474254692, 0.480468468, 0.486756019, 0.493062126, 0.499584354, 0.506166285, 0.512921878, 0.519646688, 0.526545855, 0.533532776, 0.540649416, 0.547804238, 0.555107559, 0.562455713, 0.569944974, 0.577616831, 0.585389378, 0.593243353, 0.60122625, 0.609410895, 0.6175831, 0.625929333, 0.634386946, 0.64301333, 0.651771566, 0.660633663, 0.669650653, 0.678880465, 0.688181525, 0.697680563, 0.701783764, 0.707316414, 0.717190994, 0.727133311, 0.737301893, 0.747652375, 0.758145893, 0.768837757, 0.779592087, 0.790609584, 0.801792771, 0.813140822, 0.824785212, 0.836586167, 0.848635721, 0.860853584, 0.873323418, 0.886025574, 0.898971384, 0.912164306, 0.925455609, 0.939103405, 0.952905185, 0.967122956, 0.981559674, 0.996261066, 1.002379448, 1.011148739, 1.026481668, 1.042014651, 1.058027789, 1.074252012, 1.090714858, 1.107512391, 1.124734368, 1.142158291, 1.160153153, 1.178468263, 1.197071052, 1.216008435, 1.2354355, 1.255402234, 1.275580759, 1.296194001, 1.317422277, 1.339089232, 1.356776216, 1.396857901, 1.419166027, 1.441499595, 1.463914671, 1.486286028, 1.508553114, 1.530965741, 1.553256444, 1.575408395, 1.597757432, 1.61999203, 1.642248544, 1.66445951, 1.686623801, 1.708879757, 1.731187743, 1.753467545, 1.77584754, 1.788943678, 1.798092967, 1.820355471, 1.842533792, 1.8647118, 1.886936837, 1.909305865, 1.931529072, 1.954072842, 1.97632616, 1.998608017, 2.021052713, 2.043302192, 2.065607133, 2.087935173, 2.110229061, 2.132636253, 2.154995741, 2.177235488, 2.199402131, 2.221576509, 2.243897723, 2.266290772, 2.288519429, 2.31070944, 2.333081263, 2.34604377, 2.355550992, 2.377818707, 2.400255474, 2.422738582, 2.445085654, 2.467456507, 2.489585904, 2.511891072, 2.534260564, 2.556724906, 2.578914752, 2.601630169, 2.623749032, 2.64633981, 2.66874498, 2.691173507, 2.713614835, 2.735922446, 2.758327625, 2.780995364, 2.803597691, 2.82602563, 2.848557027, 2.871113937, 2.893592411, 2.916118093, 2.938385762, 2.961034904, 2.983444812, 3.005941158, 3.028652219, 3.05101414, 3.073272652, 3.095837104, 3.118429574, 3.136015486, 3.140710814, 3.163138918, 3.185804213, 3.208050254, 3.230456244, 3.252723084, 3.275477097, 3.298061271, 3.320630926, 3.343295719, 3.365893743, 3.388335587, 3.411000063, 3.433463548, 3.456103919, 3.478984207, 3.501678524, 3.524249862, 3.54693322, 3.569697957, 3.592441598, 3.615246225, 3.63796297, 3.660843769, 3.683646853, 3.701566223, 3.706492125, 3.729503775, 3.752249619, 3.775286507, 3.798256196, 3.821089945, 3.843911479, 3.866837404, 3.889765538, 3.912367522, 3.935198586, 3.95849341, 3.981666366, 4.004585015, 4.027455577, 4.050548471, 4.07333725, 4.096499729, 4.119721112, 4.142783164, 4.165786849, 4.188684091, 4.211799178, 4.23542033, 4.258444631, 4.281890123, 4.304955626, 4.328233819, 4.351453474, 4.37472522, 4.398061829, 4.42090751, 4.443790214, 4.46696961, 4.489925058, 4.513195561, 4.536385801, 4.5596758, 4.582575064, 4.605748125, 4.629605909, 4.653126205, 4.676299127, 4.700037044, 4.723414306, 4.746634849, 4.769973463, 4.793489829, 4.817049207, 4.840530591, 4.864497359, 4.887951261, 4.911842579, 4.935306815, 4.959295444, 4.983237294, 5.006667141, 5.030303609, 5.053877386, 5.077738734, 5.10201048, 5.126551184, 5.150146789, 5.174040192, 5.197615803, 5.221386333, 5.245090441, 5.269218155, 5.292958538, 5.317026774, 5.341222257, 5.365501678, 5.390026963, 5.413952116, 5.437987855, 5.462037731, 5.485389102, 5.509758948, 5.533935167, 5.55861352, 5.583254033, 5.607737669, 5.632073412, 5.656230003, 5.679981489, 5.70419867, 5.728780091, 5.753132828, 5.777633105, 5.802873749, 5.82829312, 5.852921963, 5.877345802, 5.902088029, 5.926784915, 5.95170284, 5.956932317, 5.976539626, 6.00132726, 6.026563375, 6.050891366, 6.075930831, 6.10100674, 6.126025231, 6.151159708, 6.175888513, 6.200908002, 6.22594573, 6.250873793, 6.275807847, 6.300432364, 6.325435375, 6.351154795, 6.376822732, 6.401844701, 6.427899435, 6.453341235, 6.47886146, 6.504204072, 6.529858887, 6.556075737, 6.581907713, 6.607280077, 6.632756136, 6.658769962, 6.685091357, 6.711490808, 6.737250795, 6.763185011, 6.788507367, 6.815523079, 6.841317336, 6.867145296, 6.892899729, 6.918920643, 6.945285114, 6.971541147, 6.997411954, 7.023948684, 7.04975532, 7.076827774, 7.103543859, 7.130164155, 7.156144125, 7.181755538, 7.20777682, 7.234404158, 7.261421502, 7.28755687, 7.314711435, 7.341336113, 7.367887734, 7.393810989, 7.420697423, 7.448476829, 7.47569705, 7.50287127, 7.530196223, 7.557572609, 7.583934051, 7.610549932, 7.637731589, 7.665086607, 7.691881199, 7.718975188, 7.746156972, 7.774414693, 7.80205666, 7.83087062, 7.859076354, 7.887065063, 7.915279777, 7.941908508, 7.969120682, 7.996871424, 8.024686683, 8.052752313, 8.080735981, 8.108699835, 8.137306191, 8.164735176, 8.192991548, 8.220996876, 8.249405279, 8.276549495, 8.304691194, 8.332483647, 8.360391301, 8.388989254, 8.419062944, 8.446804053, 8.474675229, 8.503925906, 8.532266427, 8.561929567, 8.591129884, 8.620195402, 8.648829425, 8.677572529, 8.707535185, 8.735724893, 8.76430221, 8.792445756, 8.82094665, 8.850373881, 8.879906437, 8.909855904, 8.938837154, 8.967751394, 8.996745769, 9.026304492, 9.055684078, 9.084658305, 9.11347585, 9.142978391, 9.172816101, 9.202146904, 9.232323031, 9.262932667, 9.292763445, 9.323302014, 9.353149539, 9.382141103, 9.412471261, 9.440785925, 9.470015853, 9.499454994, 9.531022442, 9.561485352, 9.591050563, 9.621325617, 9.652616599, 9.683588346, 9.714670612, 9.746328276, 9.777442923, 9.80953042, 9.839346426, 9.868991124, 9.900858858, 9.930867593, 9.961954972, 9.993317993, 10.02530063, 10.057943074, 10.09043792, 10.121011906, 10.15298009, 10.183747459, 10.213189069, 10.244521446, 10.273848143, 10.304374765, 10.33804826, 10.369510676, 10.403616696, 10.434119414, 10.466226387, 10.498922158, 10.530940443, 10.564481673, 10.595683465, 10.628777174, 10.659549962, 10.692689923, 10.725488703, 10.75635293, 10.789221417, 10.820740851, 10.853796554, 10.886242863, 10.922147388, 10.95422346, 10.986197733, 11.018607838, 11.051462786, 11.085296149, 11.115929815, 11.150454854, 11.184689508, 11.218197656, 11.250994913, 11.283732314, 11.315691555, 11.349590332, 11.383478532, 11.416762477, 11.44768531, 11.480623715, 11.513748435, 11.545544339, 11.579777003, 11.615240741, 11.650970235, 11.685131131, 11.719985525, 11.754139373, 11.761475492, 11.789629, 11.823465151, 11.857399017, 11.891871173, 11.924475122, 11.959037157, 11.994176664, 12.028251435, 12.061465241, 12.096112546, 12.13215272, 12.165511435, 12.203547152, 12.23927245, 12.273735408, 12.30811362, 12.346834802, 12.381585417, 12.417906017, 12.451604856, 12.489389194, 12.527012288, 12.562815567, 12.59828709, 12.630836396, 12.668348689, 12.704121517, 12.739190978, 12.774555877, 12.805485266, 12.842549733, 12.879094456, 12.915424885, 12.95315268, 12.989435484, 13.025246843, 13.060779958, 13.095694982, 13.134775737, 13.173183334, 13.212739565, 13.249454162, 13.285367867, 13.320872408, 13.358066451, 13.397240583, 13.431764433, 13.470991203, 13.508334144, 13.54452099, 13.57853487, 13.61352797, 13.65226941, 13.693113204, 13.729390776, 13.766609316, 13.802679346, 13.841446755, 13.879154544, 13.917690601, 13.957318139, 13.992388824, 14.031158169, 14.069696325, 14.107525482, 14.146858162, 14.184152224, 14.220486359, 14.261205632, 14.300037786, 14.340876401, 14.379109906, 14.420409474, 14.458274758, 14.49739161, 14.534847084, 14.570076741, 14.60622325, 14.644950766, 14.682386827, 14.720004683, 14.758984906, 14.799821017, 14.83668079, 14.874403317, 14.913396762, 14.952721607, 14.996582213, 15.03401045, 15.072766247, 15.113461069, 15.14935755, 15.187840487, 15.226492162, 15.266485928, 15.306154044, 15.345960051, 15.382635992, 15.418649399, 15.463932926, 15.503573428, 15.547200981, 15.591215516, 15.62736016, 15.671998769, 15.705713984, 15.74634414, 15.781734275, 15.818461095, 15.858422943, 15.899084153, 15.941888608, 15.983722119, 16.027103789, 16.071712072, 16.112938766, 16.1553971, 16.196504528, 16.236527087, 16.275561028, 16.311273455, 16.359528695, 16.406036871, 16.448818256, 16.49033708, 16.529993071, 16.579253103, 16.637203761, 16.674866379, 16.715299427, 16.766606419, 16.811127695, 16.850836947, 16.890734465, 16.93634556, 16.976157376, 17.022172795, 17.063896712, 17.106364998, 17.150379759, 17.19213418, 17.231503548, 17.273745227, 17.31935129, 17.358169549, 17.401296875, 17.445995257, 17.494154846, 17.534586447, 17.572755021, 17.609645732, 17.647421606, 17.67891636, 17.730262271, 17.771399881, 17.815478631, 17.857317702, 17.900325493, 17.946297417, 17.984045514, 18.019226649, 18.066491996, 18.108012114, 18.152787064, 18.196015588, 18.236892167, 18.280939889, 18.326067691, 18.378107337, 18.422755376, 18.472761828, 18.509803984, 18.56034217, 18.602769612, 18.647500055, 18.692068495, 18.739540464, 18.775787521, 18.814153634, 18.859371604, 18.90502837, 18.944135638, 18.981714708, 19.030072503, 19.074001942, 19.119015824, 19.15190502, 19.19341947, 19.234633149, 19.282267636, 19.324859856, 19.374693713, 19.420738199, 19.460079179, 19.509073897, 19.560539872, 19.60356102, 19.642746263, 19.6943337, 19.750659494, 19.760136154, 19.803178696, 19.854249396, 19.890116428, 19.942864407, 19.981187444, 20.034104942, 20.07638789, 20.132895418, 20.181209773, 20.233053118, 20.285619988, 20.327316759, 20.36954867, 20.403895814, 20.447995722, 20.488015682, 20.524519424, 20.568648548, 20.624641957, 20.682753936, 20.725554361, 20.78762286, 20.828133805, 20.872930157, 20.917587139, 20.979322573, 21.041880885, 21.086759022, 21.141800413, 21.190669952, 21.249117492, 21.304351712, 21.354522955, 21.411996191, 21.464604221, 21.514155059, 21.553542685, 21.584748074, 21.637298684, 21.688436817, 21.737904522, 21.786050471, 21.833464433, 21.883446042, 21.932893752, 21.992641442, 22.042515609, 22.081466348, 22.126777512, 22.18222527, 22.216450324, 22.293491865, 22.359962337, 22.407936733, 22.445616563, 22.501558625, 22.547141032, 22.623054476, 22.69091366, 22.73429762, 22.784541465, 22.825037373, 22.866531616, 22.912266011, 22.95437647, 23.006652629, 23.050325172, 23.088871084, 23.12764019, 23.170882246, 23.227082372, 23.265526191, 23.331458681, 23.38301373, 23.446352516, 23.50309599, 23.556372768, 23.607967213, 23.659282609, 23.714309954, 23.766279058, 23.819871055, 23.860768398, 23.94430774, 24.01308824, 24.070126647, 24.115387817, 24.171107678, 24.239440687, 24.286843451, 24.338798459, 24.392677126, 24.458103069, 24.521377392, 24.568082718, 24.640511356, 24.691545779, 24.747048057, 24.811608497, 24.862819798, 24.910276908, 24.965956215, 25.007428883, 25.042230043, 25.093164383, 25.173819618, 25.224174306, 25.276966566, 25.330070004, 25.372717679, 25.412123296, 25.462419047, 25.509216911, 25.553764883, 25.584662084, 25.645225118, 25.688118429, 25.741395106, 25.786230858, 25.845900415, 25.88750361, 25.942039158, 26.000380361, 26.048367453, 26.099270646, 26.140294246, 26.200320236, 26.25018939, 26.282010157, 26.346791107, 26.389578251, 26.437089604, 26.495216299, 26.580603435, 26.629803073, 26.691484214, 26.747337301, 26.843623193, 26.925133392, 26.955887647, 27.026045529, 27.075125608, 27.120625714, 27.161729973, 27.224039066, 27.286711693, 27.345276498, 27.426836551, 27.475963987, 27.557269686, 27.604269028, 27.686019623, 27.738327574, 27.80257818, 27.868994024, 27.934557856, 27.9919186, 28.050055367, 28.099790186, 28.176384648, 28.263431888, 28.314574092, 28.384654866, 28.420857437, 28.482016571, 28.534125084, 28.586209073, 28.655717515, 28.694753936, 28.752989333, 28.776198243, 28.826679329, 28.88821201, 28.970385188, 29.037645252, 29.095543609, 29.127662593, 29.178346659, 29.21808891, 29.256437237, 29.311458519, 29.396945312, 29.465971776, 29.513974769, 29.541268448, 29.604064023, 29.67624075, 29.738991003, 29.842024561, 29.914227423, 29.962348737, 30.023793139, 30.062890127, 30.156809384, 30.197704197, 30.240681224, 30.284695816, 30.334973768, 30.39014567, 30.402034559, 30.464131869, 30.49928459, 30.5491443, 30.570208303, 30.680412976, 30.762882334, 30.797688397, 30.846291531, 30.888630084, 30.955892322, 30.99327326, 31.038180846, 31.08331476, 31.177114069, 31.219740799, 31.278481994, 31.307356672, 31.397091692, 31.427870067, 31.518257919, 31.560807038, 31.656693868, 31.709666696, 31.81093475, 31.97720113, 32.008186296, 32.062251627, 32.128760312, 32.201684428, 32.24835578, 32.275283572, 32.381527085, 32.440260139, 32.480574195, 32.511497111, 32.594310598, 32.657048537, 32.686852256, 32.770629339, 32.886079338, 32.908666946, 32.983498442, 33.081414235, 33.172397776, 33.205603604, 33.259229164, 33.339995403, 33.426661359, 33.446689526, 33.581070378, 33.653683469, 33.762545454, 33.841207286, 33.900457283, 33.939159982, 33.982114093, 34.047358415, 34.113938239, 34.251111922, 34.289813067, 34.372027694, 34.453224165, 34.502118774, 34.578105824, 34.700178181, 34.820598518, 34.903547937, 34.998687655, 35.085454585, 35.109470558, 35.166703921, 35.182107392, 35.480223295, 35.532236046, 35.582482125, 35.624753312, 35.633269296, 35.729647242, 35.745811846, 35.788632725, 35.861119459, 35.884927747, 36.016584275, 36.08383383, 36.150716721, 36.171502887, 36.384959313, 36.451892434, 36.651091929, 36.677581245, 36.723017198, 36.786973784, 36.790022964, 36.922170198, 37.17308079, 37.219391715, 37.331649375, 37.342276474, 37.600697317, 37.668423705, 37.758140792, 37.826097596, 37.877297373, 37.983718784, 37.995134734, 38.06848652, 38.119232119, 38.18332962, 38.263766958, 38.487017648, 38.549110355, 38.565895129, 38.651149164, 38.664741018, 38.672926811, 38.676696303, 38.844565215, 38.927415905, 39.08920136, 39.109342143, 39.117129606, 39.119680444, 39.187010546, 39.290260773, 39.322468768, 39.480664433, 39.482836853, 39.544826561, 39.549907921, 39.613493916, 39.655546418, 39.680673602, 39.879221838, 39.98433193, 40.033156282, 40.1705654, 40.337001074, 40.404112195, 40.404179982, 40.471469348), "2400" = c(1.7178e-05, 1.7437e-05, 1.7474e-05, 1.7721e-05, 1.7971e-05, 1.8153e-05, 1.8376e-05, 1.8903e-05, 1.8981e-05, 1.8999e-05, 1.91e-05, 1.9322e-05, 1.9456e-05, 1.9488e-05, 2.0038e-05, 2.0845e-05, 2.138e-05, 2.2005e-05, 2.2142e-05, 2.2537e-05, 2.2595e-05, 2.2684e-05, 2.312e-05, 2.377e-05, 2.4908e-05, 2.5018e-05, 2.5166e-05, 2.5388e-05, 2.5756e-05, 2.6553e-05, 2.6588e-05, 2.6661e-05, 2.6764e-05, 2.6861e-05, 2.7395e-05, 2.8357e-05, 2.8654e-05, 2.8697e-05, 2.9443e-05, 3.0047e-05, 3.0104e-05, 3.0159e-05, 3.0535e-05, 3.114e-05, 3.1683e-05, 3.2517e-05, 3.3254e-05, 3.3919e-05, 3.3976e-05, 3.4779e-05, 3.5213e-05, 3.5363e-05, 3.5624e-05, 3.5878e-05, 3.6538e-05, 3.6577e-05, 3.7234e-05, 3.726e-05, 3.7699e-05, 3.7964e-05, 3.8244e-05, 3.8499e-05, 3.9057e-05, 3.9522e-05, 3.9768e-05, 4.0305e-05, 4.0658e-05, 4.1134e-05, 4.2235e-05, 4.2752e-05, 4.3105e-05, 4.3585e-05, 4.3931e-05, 4.481e-05, 4.5382e-05, 4.566e-05, 4.6139e-05, 4.6581e-05, 4.7066e-05, 4.741e-05, 4.7918e-05, 4.8133e-05, 4.8824e-05, 4.9514e-05, 5.0328e-05, 5.0894e-05, 5.1307e-05, 5.1739e-05, 5.2239e-05, 5.2509e-05, 5.2976e-05, 5.3183e-05, 5.3507e-05, 5.4248e-05, 5.4371e-05, 5.4855e-05, 5.5065e-05, 5.5405e-05, 5.57e-05, 5.6261e-05, 5.7648e-05, 5.8271e-05, 5.867e-05, 5.8854e-05, 5.951e-05, 6.0263e-05, 6.126e-05, 6.1816e-05, 6.2375e-05, 6.2857e-05, 6.3786e-05, 6.5115e-05, 6.679e-05, 6.7969e-05, 6.9317e-05, 6.9939e-05, 7.1844e-05, 7.3132e-05, 7.3791e-05, 7.4373e-05, 7.564e-05, 7.7774e-05, 7.7979e-05, 7.913e-05, 7.9552e-05, 8.0045e-05, 8.1189e-05, 8.145e-05, 8.2741e-05, 8.3656e-05, 8.4934e-05, 8.5803e-05, 8.6824e-05, 8.7421e-05, 8.8203e-05, 8.9835e-05, 9.0877e-05, 9.1476e-05, 9.3902e-05, 9.4631e-05, 9.5619e-05, 9.7568e-05, 9.8753e-05, 0.000100161, 0.000101953, 0.000103111, 0.000104311, 0.00010669, 0.000108172, 0.000109192, 0.000110088, 0.000112323, 0.000114076, 0.00011498, 0.000116711, 0.000118339, 0.000119571, 0.000120763, 0.000121844, 0.000122623, 0.000124201, 0.000125346, 0.000126003, 0.000127776, 0.00013001, 0.000131695, 0.000132976, 0.00013585, 0.00013714, 0.000138367, 0.000139583, 0.000141045, 0.000143948, 0.000145445, 0.000147692, 0.000149832, 0.00015145, 0.000152527, 0.000153448, 0.000154116, 0.000155534, 0.000157445, 0.000158536, 0.000160169, 0.000161586, 0.000162579, 0.000166052, 0.00016849, 0.000170624, 0.000171936, 0.000173872, 0.000176034, 0.000177679, 0.000180457, 0.000182536, 0.000185257, 0.000189009, 0.000191639, 0.000193225, 0.000195724, 0.000197973, 0.000200201, 0.000202041, 0.000203402, 0.00020551, 0.000207531, 0.000209424, 0.000211528, 0.000213214, 0.000217075, 0.000219678, 0.000221447, 0.000224685, 0.000226149, 0.000228229, 0.000230797, 0.000233824, 0.0002372, 0.000240453, 0.000242019, 0.000244964, 0.000246839, 0.000249381, 0.000252412, 0.000254984, 0.000257801, 0.000260351, 0.000263763, 0.000266824, 0.000269706, 0.000273499, 0.000275559, 0.000279494, 0.000282232, 0.000284475, 0.000287297, 0.000291561, 0.000294584, 0.000297794, 0.000301962, 0.000305252, 0.000307996, 0.000312772, 0.000315531, 0.000318755, 0.000323499, 0.000326694, 0.000330664, 0.000334312, 0.000338793, 0.000343186, 0.000346828, 0.000349586, 0.000353464, 0.000357289, 0.000361042, 0.000364642, 0.000370987, 0.000375025, 0.000380453, 0.00038464, 0.000388846, 0.000395453, 0.000400012, 0.000404898, 0.000409761, 0.00041559, 0.000419713, 0.000424505, 0.000430912, 0.000434929, 0.000442776, 0.000448807, 0.000453865, 0.000457571, 0.000465744, 0.00047165, 0.000475702, 0.000481828, 0.00048767, 0.000492853, 0.000498283, 0.000504681, 0.00050994, 0.00051498, 0.000521487, 0.000528681, 0.000535209, 0.000539164, 0.000544623, 0.000552155, 0.000557323, 0.000564447, 0.000569849, 0.000577763, 0.00058411, 0.000591151, 0.000597625, 0.000604459, 0.000610396, 0.000618998, 0.000624474, 0.00063043, 0.000638556, 0.000646811, 0.000652603, 0.000658358, 0.000666018, 0.000671239, 0.000679593, 0.000686094, 0.000694392, 0.000701857, 0.000710419, 0.000718598, 0.000729937, 0.000739465, 0.000746897, 0.000754684, 0.000762091, 0.000769664, 0.000778649, 0.000787438, 0.000799968, 0.000811161, 0.000820619, 0.000830402, 0.000839233, 0.000847345, 0.000858064, 0.000867324, 0.000879508, 0.000891637, 0.000901385, 0.00091315, 0.000924437, 0.000936487, 0.00094632, 0.000958511, 0.000972629, 0.000980697, 0.000983118, 0.00099413, 0.001005918, 0.001019113, 0.001034105, 0.001044248, 0.001058422, 0.00107034, 0.001084847, 0.001095882, 0.001109201, 0.001122132, 0.001134029, 0.001146245, 0.001162419, 0.001176039, 0.001188434, 0.001203787, 0.001218663, 0.001232436, 0.001245984, 0.001263996, 0.001279096, 0.001291714, 0.001305906, 0.001321977, 0.001333861, 0.001352614, 0.001370857, 0.00138673, 0.001401786, 0.001416167, 0.001431409, 0.001446859, 0.001465124, 0.001482466, 0.001500133, 0.001517755, 0.001534841, 0.001552331, 0.001568846, 0.001586565, 0.00160552, 0.001621112, 0.001642942, 0.001661675, 0.001680207, 0.001697626, 0.00171904, 0.001735997, 0.001754478, 0.001772701, 0.001796223, 0.001818976, 0.001836072, 0.001857108, 0.001874873, 0.001894533, 0.001917298, 0.001938081, 0.00196265, 0.001985383, 0.002007206, 0.002028534, 0.002053734, 0.002075714, 0.002101298, 0.002123986, 0.002150206, 0.002174722, 0.002199332, 0.002225742, 0.002251239, 0.002275661, 0.00230621, 0.002333786, 0.002360553, 0.002387843, 0.002418137, 0.002446432, 0.002473129, 0.002499084, 0.002526203, 0.002555245, 0.002586402, 0.002615502, 0.002651863, 0.002686339, 0.002716645, 0.002746473, 0.002776418, 0.002808543, 0.002845148, 0.002881292, 0.002913609, 0.002950416, 0.002986623, 0.003016033, 0.003050717, 0.003086049, 0.003124963, 0.003162131, 0.003197467, 0.003234507, 0.003268726, 0.003310684, 0.003347375, 0.003388629, 0.003431794, 0.003472548, 0.00351216, 0.003556334, 0.003597877, 0.003640444, 0.00368133, 0.003721665, 0.003767964, 0.003809081, 0.003856594, 0.003900152, 0.00394266, 0.003987306, 0.004025994, 0.004067197, 0.004116095, 0.004167899, 0.004217941, 0.004264051, 0.004313678, 0.004365274, 0.004413741, 0.00446791, 0.004517147, 0.004568485, 0.00461457, 0.004664479, 0.004720351, 0.004777366, 0.004838668, 0.004896029, 0.004954582, 0.005010859, 0.005067983, 0.005122995, 0.005183631, 0.005248049, 0.005311365, 0.00536894, 0.005427244, 0.005485687, 0.005549502, 0.005625527, 0.005694803, 0.005757091, 0.005829949, 0.005897995, 0.005963789, 0.006036973, 0.006107589, 0.006182345, 0.006249977, 0.006325233, 0.006395935, 0.006475263, 0.006551027, 0.006626429, 0.00670336, 0.006786473, 0.006865358, 0.006943197, 0.007020769, 0.007101306, 0.007187275, 0.007270768, 0.007350367, 0.00743613, 0.007520745, 0.00761086, 0.007692459, 0.007792366, 0.007888121, 0.007979645, 0.00807733, 0.008173997, 0.008270828, 0.008362489, 0.008459631, 0.008552975, 0.008653754, 0.008754328, 0.008857084, 0.008953231, 0.009059186, 0.009167588, 0.009266781, 0.009372374, 0.00947985, 0.009599794, 0.009715327, 0.00983675, 0.009924768, 0.009952102, 0.010071156, 0.01018647, 0.010304928, 0.010429585, 0.010557138, 0.010678739, 0.01079989, 0.01091722, 0.011042485, 0.011161808, 0.011294579, 0.01142476, 0.01156346, 0.011703474, 0.011832839, 0.011971103, 0.01211058, 0.012252592, 0.012390961, 0.012542363, 0.012680313, 0.012823761, 0.012972982, 0.013131328, 0.013281827, 0.013439499, 0.013604936, 0.013763899, 0.013928818, 0.014095325, 0.014255072, 0.014418183, 0.014587162, 0.014758513, 0.014931828, 0.015107095, 0.015278353, 0.015462594, 0.015645494, 0.015835385, 0.01601119, 0.016196222, 0.016394421, 0.016585983, 0.016773089, 0.016972546, 0.017184694, 0.017393817, 0.017591183, 0.017794451, 0.017995498, 0.018197984, 0.018418062, 0.018635599, 0.018869315, 0.019082504, 0.019291503, 0.019504017, 0.019717064, 0.019960598, 0.020202869, 0.02043564, 0.020679515, 0.020919757, 0.02116134, 0.021404922, 0.021647379, 0.021910124, 0.022170309, 0.022420124, 0.022672084, 0.022937411, 0.023205852, 0.023486991, 0.023764069, 0.024030969, 0.024319918, 0.024604837, 0.024893858, 0.02517042, 0.025458572, 0.025754499, 0.026055543, 0.026359237, 0.026666379, 0.026980776, 0.027305872, 0.027622481, 0.027954964, 0.028286362, 0.028603047, 0.028936428, 0.029275817, 0.029614225, 0.029952019, 0.030293205, 0.030642352, 0.031009775, 0.031358948, 0.031735829, 0.032103997, 0.032477892, 0.032857532, 0.033252433, 0.033628941, 0.034013696, 0.034402629, 0.03480071, 0.035199981, 0.0356191, 0.036023859, 0.036435773, 0.036844972, 0.037274241, 0.037717446, 0.038159516, 0.038598537, 0.039063441, 0.039520243, 0.039970313, 0.040454153, 0.040928799, 0.041393215, 0.041892881, 0.042361309, 0.042857362, 0.043371653, 0.043893933, 0.044405253, 0.044946153, 0.045462704, 0.046007642, 0.046548841, 0.047094555, 0.047649602, 0.048196448, 0.048755232, 0.049334034, 0.049906955, 0.050483322, 0.051089235, 0.051670329, 0.052277327, 0.052901455, 0.05353137, 0.054142319, 0.054786458, 0.055429137, 0.056092204, 0.056745643, 0.057418575, 0.058079271, 0.058759564, 0.059457664, 0.060155071, 0.060868665, 0.061592644, 0.062315054, 0.063044267, 0.063779558, 0.064534261, 0.065284005, 0.066051685, 0.066823465, 0.067628628, 0.068438803, 0.069240711, 0.070057348, 0.070881036, 0.071712672, 0.072571553, 0.073435425, 0.074298605, 0.075163985, 0.076034761, 0.076940045, 0.077842799, 0.078779043, 0.079712029, 0.08068198, 0.081644575, 0.082617632, 0.083605125, 0.08458859, 0.085555836, 0.08656141, 0.087606809, 0.088679207, 0.089696287, 0.090735237, 0.091829309, 0.092914815, 0.094023333, 0.09515461, 0.096266232, 0.097406381, 0.098576076, 0.099761519, 0.100939449, 0.101907814, 0.102149726, 0.103339141, 0.104586084, 0.105853005, 0.107120517, 0.108378213, 0.109668845, 0.110966013, 0.112287156, 0.11359717, 0.114940835, 0.116325174, 0.117697907, 0.119088503, 0.120505426, 0.121909432, 0.123365267, 0.124856359, 0.126348009, 0.127852919, 0.129378992, 0.130914202, 0.132493523, 0.134059548, 0.135637545, 0.137272472, 0.138919785, 0.140588076, 0.14228093, 0.143982038, 0.145681888, 0.147453704, 0.149236438, 0.151049783, 0.152853106, 0.154666927, 0.156501633, 0.158407308, 0.160312385, 0.162266449, 0.164198001, 0.1661557, 0.168129124, 0.170141295, 0.172198355, 0.174307857, 0.176415954, 0.178539637, 0.180720427, 0.182902931, 0.185104554, 0.187390916, 0.189653674, 0.191955441, 0.194269691, 0.196595039, 0.198985864, 0.201399085, 0.203885789, 0.206357176, 0.208880364, 0.211361109, 0.213957377, 0.216551459, 0.219176579, 0.221907478, 0.224635846, 0.227438882, 0.230207054, 0.233059616, 0.235932373, 0.238861496, 0.241799465, 0.244785191, 0.247799029, 0.250835805, 0.253942417, 0.257074188, 0.260270103, 0.263511637, 0.266783666, 0.270091972, 0.27345334, 0.276894703, 0.280364977, 0.283845425, 0.287312312, 0.290911744, 0.294554357, 0.298255152, 0.301935999, 0.305693808, 0.309529316, 0.313396626, 0.317250081, 0.321270054, 0.322139063, 0.325295904, 0.329409678, 0.333567374, 0.33774375, 0.341953689, 0.346325147, 0.350701812, 0.355123474, 0.359627458, 0.364204253, 0.368871471, 0.373653969, 0.378411956, 0.383212247, 0.388107092, 0.393078723, 0.398121124, 0.403205145, 0.408384823, 0.413613482, 0.418867692, 0.424284446, 0.429769233, 0.435312983, 0.44098072, 0.442144527, 0.446702385, 0.452546535, 0.458432153, 0.464429635, 0.470543747, 0.476671433, 0.482888155, 0.489197648, 0.495591457, 0.502022942, 0.508634811, 0.515402521, 0.522181099, 0.528995975, 0.535949028, 0.543090116, 0.550329385, 0.557644341, 0.565103749, 0.572701362, 0.580367712, 0.58819613, 0.596089679, 0.604138638, 0.612273067, 0.620619492, 0.629006227, 0.637631434, 0.646353388, 0.655134243, 0.664112224, 0.673185771, 0.682405463, 0.691863272, 0.701446786, 0.705581565, 0.711232288, 0.721180558, 0.731195992, 0.741443715, 0.751837201, 0.762385853, 0.773101373, 0.783986918, 0.795067615, 0.806368064, 0.817903017, 0.829656217, 0.841693863, 0.853668951, 0.866015967, 0.878563406, 0.891316592, 0.904359949, 0.917571555, 0.93109899, 0.944825266, 0.958804168, 0.973031121, 0.987484295, 1.002276938, 1.008530771, 1.017476252, 1.03275271, 1.04847124, 1.064459315, 1.08078857, 1.097387345, 1.114358835, 1.131724573, 1.149341986, 1.167266931, 1.185729253, 1.204415062, 1.223481726, 1.242906313, 1.262987479, 1.283382427, 1.304316705, 1.325891181, 1.347847948, 1.365481472, 1.40580525, 1.428460823, 1.450991213, 1.473438129, 1.49602067, 1.518652624, 1.541116162, 1.563643747, 1.586240885, 1.608594779, 1.63116568, 1.653751161, 1.676404984, 1.699042017, 1.72162917, 1.744163959, 1.766817474, 1.789113743, 1.802417191, 1.811635257, 1.834141336, 1.856609158, 1.87910716, 1.901725223, 1.92435071, 1.946917157, 1.969717094, 1.992231574, 2.014819142, 2.0373553, 2.059903609, 2.082201512, 2.104647547, 2.127083039, 2.149376035, 2.171876532, 2.194552861, 2.216973039, 2.239475447, 2.261934277, 2.284546308, 2.307115957, 2.329575983, 2.352103239, 2.364951716, 2.374504381, 2.397049982, 2.419669689, 2.44198323, 2.464759817, 2.487276033, 2.510036945, 2.532717128, 2.555159038, 2.577707394, 2.600271866, 2.622796853, 2.645359057, 2.668063194, 2.69058936, 2.713269637, 2.735773689, 2.758295254, 2.780980611, 2.80369892, 2.826294373, 2.8487794, 2.871370699, 2.893842225, 2.916405659, 2.939280951, 2.961612792, 2.984248203, 3.006890565, 3.02961361, 3.052243329, 3.074858513, 3.097525875, 3.120329855, 3.143230716, 3.161144138, 3.165870734, 3.1888734, 3.211369087, 3.234139919, 3.256838528, 3.279636109, 3.302656357, 3.325358664, 3.348341078, 3.371037115, 3.393646687, 3.416139481, 3.439047403, 3.461909242, 3.48462072, 3.5075706, 3.530301218, 3.553181285, 3.576009165, 3.59906504, 3.621699243, 3.644617717, 3.667748017, 3.690259504, 3.713128569, 3.730866886, 3.735794329, 3.758864544, 3.781433536, 3.804085816, 3.826952002, 3.849672079, 3.872580984, 3.895434332, 3.918474292, 3.941200559, 3.96426954, 3.987451614, 4.010215844, 4.033093005, 4.056386578, 4.079411973, 4.102410733, 4.125749387, 4.148803156, 4.171877872, 4.19494414, 4.218160662, 4.241304178, 4.264636928, 4.287901164, 4.311267137, 4.334051415, 4.357064524, 4.380371316, 4.403578577, 4.426493532, 4.449414154, 4.472535832, 4.495789125, 4.519043462, 4.542360934, 4.5658265, 4.588539824, 4.611847808, 4.635107778, 4.658324432, 4.681961104, 4.705212613, 4.728867723, 4.752110245, 4.775824215, 4.799421178, 4.822757165, 4.846011137, 4.869538275, 4.892857015, 4.916484808, 4.939423623, 4.962649097, 4.9861198, 5.009325377, 5.032777036, 5.056163712, 5.079946684, 5.103444849, 5.126880829, 5.150453208, 5.173832757, 5.197204073, 5.221088276, 5.244741587, 5.268636866, 5.292648233, 5.316248211, 5.339513461, 5.363143551, 5.387452981, 5.412081395, 5.436285098, 5.459868944, 5.484082695, 5.507908495, 5.531307323, 5.554947907, 5.578762914, 5.602734511, 5.626619461, 5.650028925, 5.674376384, 5.69843985, 5.722191109, 5.746543591, 5.770078784, 5.793602674, 5.81750026, 5.841602902, 5.865306004, 5.889584876, 5.913772507, 5.937732138, 5.962052368, 5.967110903, 5.986579687, 6.011107636, 6.035057288, 6.059412629, 6.083923037, 6.107534158, 6.132428395, 6.156502254, 6.181117885, 6.205781981, 6.230481611, 6.254351216, 6.278350074, 6.302793164, 6.326876927, 6.351342337, 6.375938596, 6.400840107, 6.425151745, 6.450069878, 6.474727372, 6.499993369, 6.525027202, 6.550037234, 6.57466392, 6.59916796, 6.624218204, 6.649284456, 6.674174086, 6.699596346, 6.725030583, 6.749735652, 6.774004921, 6.799673519, 6.824452054, 6.848917722, 6.874225516, 6.89903727, 6.92386197, 6.949070285, 6.974604917, 6.999167132, 7.023879343, 7.049149731, 7.074642688, 7.099473698, 7.125206782, 7.149628897, 7.17481879, 7.20016764, 7.225965865, 7.251059055, 7.276512752, 7.301713799, 7.327357036, 7.353079223, 7.379202432, 7.404450253, 7.429221149, 7.454701634, 7.481095699, 7.507695273, 7.533941952, 7.560974652, 7.587527163, 7.613640784, 7.638918521, 7.665867142, 7.691830998, 7.717291199, 7.743225618, 7.769235129, 7.794958706, 7.821333697, 7.846691841, 7.873400198, 7.898939259, 7.924686123, 7.950732841, 7.976969698, 8.00281312, 8.028902501, 8.053659862, 8.080108627, 8.107082651, 8.132653743, 8.158944232, 8.184581752, 8.210690121, 8.237599273, 8.263748808, 8.291611799, 8.317527275, 8.344585297, 8.371611933, 8.397904545, 8.425754419, 8.45256399, 8.479529924, 8.505661285, 8.533133195, 8.559490641, 8.587413367, 8.614544253, 8.640598881, 8.667004924, 8.694783588, 8.721377241, 8.747924273, 8.775911121, 8.803331405, 8.831586999, 8.858405125, 8.885430621, 8.913959505, 8.941519699, 8.968690845, 8.996629785, 9.024009773, 9.050224709, 9.077306119, 9.104480936, 9.131817332, 9.159377714, 9.188278773, 9.214645825, 9.242891709, 9.270908394, 9.298767502, 9.327678091, 9.355292259, 9.383426355, 9.411902166, 9.438540198, 9.467466525, 9.496963637, 9.524351293, 9.552120062, 9.580712591, 9.608358535, 9.636483336, 9.66493032, 9.693457515, 9.721257111, 9.750301491, 9.778960406, 9.807490339, 9.836827778, 9.866784461, 9.897201746, 9.925997484, 9.953875666, 9.982107577, 10.010734819, 10.03982484, 10.069970716, 10.097722622, 10.125617278, 10.154168507, 10.184081807, 10.212766524, 10.241571158, 10.272141577, 10.301563646, 10.330137108, 10.359668633, 10.38964189, 10.417549287, 10.446563363, 10.476822321, 10.506277581, 10.538312212, 10.567160902, 10.597204745, 10.625173765, 10.657469698, 10.686792236, 10.715657586, 10.744439088, 10.772419593, 10.803605962, 10.833307463, 10.864584557, 10.894464225, 10.923708658, 10.953589745, 10.983105603, 11.01485826, 11.045509612, 11.074769333, 11.10487523, 11.135689233, 11.167770298, 11.196401773, 11.224056242, 11.25569361, 11.286019219, 11.31672206, 11.347195545, 11.376409629, 11.383993511, 11.407971755, 11.438796004, 11.470825216, 11.504748594, 11.536677409, 11.567197457, 11.59746986, 11.628572748, 11.659910735, 11.691564915, 11.720783522, 11.752107744, 11.780771998, 11.8137527, 11.846291322, 11.873566196, 11.90388229, 11.934678364, 11.964801822, 11.997067981, 12.031546296, 12.062734814, 12.095350284, 12.126817421, 12.160490575, 12.191546489, 12.223823278, 12.254899083, 12.288157596, 12.32128418, 12.35413014, 12.384381333, 12.419443852, 12.45312663, 12.483135874, 12.516896682, 12.551271545, 12.585184095, 12.618000185, 12.649908465, 12.68041151, 12.713074011, 12.743903329, 12.77874738, 12.811508235, 12.844440768, 12.874802388, 12.906689029, 12.939940049, 12.968628341, 13.003139573, 13.038543063, 13.070347555, 13.10273164, 13.135767511, 13.170318546, 13.203922908, 13.237874146, 13.270633228, 13.304522598, 13.336677651, 13.369552669, 13.399722555, 13.432625278, 13.464680849, 13.499114314, 13.531274044, 13.566848576, 13.602684205, 13.636829434, 13.67035139, 13.706866953, 13.741093796, 13.770131076, 13.801968587, 13.83615658, 13.869423118, 13.902821459, 13.938330245, 13.972967788, 14.00719326, 14.040425096, 14.074932047, 14.109382312, 14.141443433, 14.176512898, 14.210593514, 14.244986639, 14.278224326, 14.310589744, 14.341207379, 14.377948726, 14.408690363, 14.443229524, 14.479035873, 14.51211821, 14.546488604, 14.578455699, 14.613138033, 14.651970483, 14.689190358, 14.720059592, 14.757214584, 14.794303984, 14.833084556, 14.867182797, 14.904650794, 14.938921947, 14.973609043, 15.008017455, 15.041895751, 15.078546754, 15.109603065, 15.144989174, 15.178437127, 15.213156459, 15.249252282, 15.280671333, 15.312954917, 15.346938801, 15.381173289, 15.417751469, 15.454000121, 15.487649877, 15.526093407, 15.563890453, 15.601219573, 15.641170188, 15.677400919, 15.714078326, 15.751622962, 15.785983745, 15.823013755, 15.859674291, 15.898039146, 15.93482367, 15.969735534, 16.009580417, 16.044773812, 16.082829745, 16.126985378, 16.157163718, 16.196901956, 16.233733727, 16.271885657, 16.3084295, 16.350748196, 16.38592205, 16.421514743, 16.458203303, 16.494502013, 16.533405137, 16.573069511, 16.607111527, 16.645373487, 16.681097722, 16.721040013, 16.757695439, 16.793370432, 16.827347655, 16.865012281, 16.908519564, 16.950189977, 16.979972553, 17.014887567, 17.049507415, 17.085173719, 17.118646667, 17.153956847, 17.190247617, 17.233511783, 17.264723574, 17.297200814, 17.332133021, 17.365855023, 17.40655102, 17.447540356, 17.478756028, 17.515101543, 17.549724134, 17.585869928, 17.631101868, 17.676289195, 17.721127984, 17.762388086, 17.803903217, 17.841310787, 17.87835534, 17.911578029, 17.951778814, 17.986913324, 18.023452398, 18.072236234, 18.107121732, 18.140482444, 18.189214697, 18.232866693, 18.272601155, 18.316311833, 18.354632652, 18.365565399, 18.400917639, 18.444173703, 18.484899384, 18.518604119, 18.566785153, 18.602079057, 18.654747824, 18.694235602, 18.728499058, 18.76662534, 18.800232532, 18.836687777, 18.870374068, 18.901521715, 18.931953622, 18.967163461, 19.003869911, 19.046112026, 19.08824437, 19.130638349, 19.16939537, 19.211332752, 19.24595799, 19.28392522, 19.318485533, 19.368420157, 19.416042404, 19.453752916, 19.499588369, 19.542521343, 19.576806291, 19.62212728, 19.663056893, 19.71400696, 19.756368865, 19.798902537, 19.840941302, 19.882029316, 19.922159128, 19.964449323, 19.996558399, 20.034285781, 20.064175575, 20.106548888, 20.160624527, 20.18536048, 20.224428438, 20.274007611, 20.323866436, 20.377569333, 20.411644781, 20.454536806, 20.497767618, 20.533715847, 20.573284147, 20.609948874, 20.651642368, 20.690866691, 20.726748828, 20.761827113, 20.80498687, 20.845130874, 20.899457687, 20.942248135, 20.964423066, 21.001486629, 21.054483475, 21.090011477, 21.129752435, 21.16786368, 21.209827778, 21.256404704, 21.290061976, 21.338857412, 21.387331963, 21.450562724, 21.490778467, 21.538694703, 21.582845758, 21.62360905, 21.659987148, 21.685737242, 21.728563865, 21.770176787, 21.815330008, 21.851625788, 21.899681723, 21.954663215, 21.998638047, 22.053428717, 22.094894284, 22.144796508, 22.186897441, 22.253479161, 22.284187978, 22.332233752, 22.373853579, 22.415788295, 22.459238736, 22.494024435, 22.526910966, 22.572964459, 22.616899706, 22.668259782, 22.720054314, 22.750433632, 22.785346852, 22.843451195, 22.882612057, 22.928456385, 22.969111368, 22.995995512, 23.027496203, 23.067154871, 23.102537411, 23.154232503, 23.193091021, 23.236852454, 23.282557004, 23.31911965, 23.36209296, 23.42571173, 23.475411499, 23.52164052, 23.559370977, 23.618556112, 23.656855911, 23.733556935, 23.783429381, 23.813929793, 23.859191912, 23.891388205, 23.926234722, 23.975712724, 24.020675868, 24.066062326, 24.120677358, 24.167038827, 24.203135514, 24.249375678, 24.295417606, 24.334724023, 24.380831961, 24.417310532, 24.455872228, 24.487010297, 24.530576465, 24.583251364, 24.637609723, 24.691218855, 24.735911826, 24.795274171, 24.840619875, 24.875995088, 24.947947427, 24.987209154, 25.054174834, 25.13143555, 25.153574329, 25.202780519, 25.277129825, 25.327043671, 25.396556956, 25.431642873, 25.483189731, 25.534043777, 25.571590125, 25.623557684, 25.660291627, 25.739542246, 25.79154879, 25.803056747, 25.853028036, 25.886286844, 25.927389932, 25.992145126, 26.016255324, 26.042231623, 26.083773439, 26.118150584, 26.14294115, 26.182928797, 26.230300769, 26.278425536, 26.352711911, 26.394304545, 26.456281347, 26.503629664, 26.572383549, 26.625113091, 26.656145241, 26.670551336, 26.734232112, 26.822014679, 26.840120016, 26.890677701, 26.933735372, 27.006289692, 27.04661356, 27.098483752, 27.130072318, 27.160311453, 27.204211372, 27.247874038, 27.306609763, 27.327955127, 27.473616661, 27.503863355, 27.577761856, 27.64799816, 27.705348801, 27.777149632, 27.832377341, 27.914380893, 27.958138221, 27.998299742, 28.065718124, 28.09925855, 28.147589685, 28.176287902, 28.249552217, 28.279529192, 28.317596103, 28.396777135, 28.427620286, 28.442051442, 28.491079598, 28.522080348, 28.588767101, 28.662395793, 28.707666408, 28.742701171, 28.784294068, 28.826840808, 28.844340279, 28.950034848, 29.022169913, 29.055088464, 29.107846902, 29.132902008, 29.144022741, 29.175716109, 29.204298157, 29.223452892, 29.306082201, 29.338438437, 29.363644872, 29.392262279, 29.495521305, 29.549736011, 29.580042458, 29.656963298, 29.692667434, 29.73705362, 29.757052647, 29.804236026, 29.82247234, 29.864209623, 29.92210566, 29.93063263, 29.959537835, 30.038625373, 30.072490151, 30.283490052, 30.297527243, 30.36262779, 30.387965438, 30.450388416, 30.517136696, 30.539799408, 30.560837229, 30.576840205, 30.623862338, 30.768741908, 30.885477707, 30.906308484, 30.937393567, 30.978182687, 31.056075041, 31.071539842, 31.122357634, 31.291715029, 31.306619664, 31.371314476, 31.421543285, 31.457476945, 31.49788851, 31.533396535, 31.555900433, 31.688530089, 31.784683867, 31.84714738, 31.879725638, 31.906355661, 31.960954068, 32.020208946, 32.073361081, 32.088500579, 32.182330199, 32.248456316, 32.279806867, 32.339736411, 32.356972287, 32.374786383, 32.420280009, 32.46249827, 32.520639729, 32.523398832, 32.613391347, 32.762000787, 32.769422083, 32.831194625, 32.874232547, 32.958124855, 32.9988881, 33.017075206, 33.135250264, 33.135395583, 33.261582139, 33.314243134, 33.418348973, 33.467991181, 33.505846218, 33.516651261, 33.528551668, 33.63001442, 33.799264125, 33.816592197, 33.868146472, 33.95452163, 33.959913635, 33.962965333, 34.167400107, 34.275508823, 34.321322032, 34.346509619, 34.401987518, 34.449756523, 34.487266332, 34.498623383), "10000" = c(1.9113e-05, 1.9205e-05, 1.9231e-05, 1.973e-05, 1.9808e-05, 1.9926e-05, 2.0324e-05, 2.0587e-05, 2.0935e-05, 2.1019e-05, 2.1063e-05, 2.1724e-05, 2.1845e-05, 2.2713e-05, 2.2943e-05, 2.307e-05, 2.3081e-05, 2.3495e-05, 2.3499e-05, 2.3688e-05, 2.4026e-05, 2.4122e-05, 2.4371e-05, 2.5164e-05, 2.5424e-05, 2.5572e-05, 2.6309e-05, 2.632e-05, 2.6826e-05, 2.7639e-05, 2.7816e-05, 2.8324e-05, 2.8952e-05, 2.9073e-05, 2.9275e-05, 2.9921e-05, 2.9999e-05, 3.0115e-05, 3.0541e-05, 3.0875e-05, 3.1442e-05, 3.1601e-05, 3.1816e-05, 3.194e-05, 3.2868e-05, 3.3397e-05, 3.3485e-05, 3.3609e-05, 3.3857e-05, 3.42e-05, 3.4358e-05, 3.503e-05, 3.5124e-05, 3.5725e-05, 3.6057e-05, 3.6577e-05, 3.7825e-05, 3.8555e-05, 3.8993e-05, 3.9758e-05, 4.0642e-05, 4.1027e-05, 4.1652e-05, 4.2936e-05, 4.3551e-05, 4.3716e-05, 4.4037e-05, 4.4259e-05, 4.4539e-05, 4.4735e-05, 4.5896e-05, 4.6437e-05, 4.6642e-05, 4.6919e-05, 4.7293e-05, 4.8493e-05, 4.9248e-05, 4.9787e-05, 4.9943e-05, 5.0342e-05, 5.1434e-05, 5.1851e-05, 5.2791e-05, 5.3464e-05, 5.3673e-05, 5.4326e-05, 5.464e-05, 5.553e-05, 5.578e-05, 5.6338e-05, 5.6381e-05, 5.6901e-05, 5.7152e-05, 5.7637e-05, 5.8319e-05, 5.8374e-05, 5.8813e-05, 5.9602e-05, 6.0237e-05, 6.0759e-05, 6.1653e-05, 6.2439e-05, 6.3446e-05, 6.4244e-05, 6.503e-05, 6.7763e-05, 6.8607e-05, 6.8971e-05, 6.9901e-05, 7.0959e-05, 7.1428e-05, 7.2114e-05, 7.361e-05, 7.4595e-05, 7.5327e-05, 7.6726e-05, 7.8059e-05, 7.8583e-05, 7.9104e-05, 7.9599e-05, 8.0018e-05, 8.1092e-05, 8.1436e-05, 8.3325e-05, 8.3949e-05, 8.5012e-05, 8.633e-05, 8.6812e-05, 8.7775e-05, 8.9573e-05, 9.0935e-05, 9.2026e-05, 9.3203e-05, 9.4522e-05, 9.5662e-05, 9.61e-05, 9.7849e-05, 9.9217e-05, 9.9637e-05, 0.000101461, 0.000102683, 0.000103715, 0.000104661, 0.000105469, 0.000106373, 0.000107443, 0.000108663, 0.000109944, 0.000111038, 0.000112832, 0.000113964, 0.000115699, 0.00011683, 0.000117959, 0.000119312, 0.000119697, 0.000120544, 0.000121966, 0.000122756, 0.000124028, 0.000124799, 0.000125608, 0.000128378, 0.000129729, 0.00013131, 0.000133061, 0.000134293, 0.000135476, 0.00013796, 0.000139381, 0.000140881, 0.000141841, 0.00014247, 0.000144129, 0.000146627, 0.000148061, 0.000149751, 0.00015171, 0.000152925, 0.000154548, 0.000156115, 0.000159157, 0.00016049, 0.000163224, 0.000165589, 0.000166848, 0.000169405, 0.000171321, 0.000173023, 0.000174959, 0.000177255, 0.000179062, 0.000181058, 0.000183189, 0.000185692, 0.000187527, 0.000189032, 0.000190378, 0.000193243, 0.000194526, 0.00019777, 0.000199371, 0.000201853, 0.000204935, 0.000207285, 0.000208971, 0.000210847, 0.000212454, 0.000215876, 0.00021846, 0.000220332, 0.000223133, 0.000226016, 0.000229636, 0.000232914, 0.00023645, 0.000238326, 0.000241797, 0.000245161, 0.000247618, 0.000250668, 0.000253731, 0.000257225, 0.00025975, 0.000262678, 0.00026568, 0.000267737, 0.000269979, 0.000272333, 0.000276164, 0.000279397, 0.000281898, 0.000283387, 0.000286795, 0.000289575, 0.000293066, 0.000295805, 0.000300734, 0.000304314, 0.00030848, 0.000311122, 0.000314662, 0.000317852, 0.000322351, 0.000326085, 0.000329782, 0.000333962, 0.000337763, 0.000341106, 0.000344523, 0.000348615, 0.000353732, 0.000359992, 0.000364439, 0.000368165, 0.000373202, 0.000376621, 0.000380007, 0.000383722, 0.000387424, 0.000392995, 0.000395967, 0.000400809, 0.00040448, 0.000408966, 0.000415003, 0.000419893, 0.000425783, 0.000430954, 0.000436316, 0.000441486, 0.000444828, 0.000449064, 0.000452615, 0.000458091, 0.000462015, 0.000469942, 0.000474515, 0.000480316, 0.000486574, 0.000492201, 0.000497833, 0.000502629, 0.000507922, 0.000514454, 0.000518318, 0.000524265, 0.000530382, 0.000535941, 0.000541999, 0.000546711, 0.000553182, 0.000560016, 0.000567406, 0.000573708, 0.000580453, 0.000588058, 0.000594258, 0.000601884, 0.000608639, 0.000613954, 0.000621157, 0.000626981, 0.000635032, 0.000642225, 0.000647378, 0.000654467, 0.000660991, 0.000669902, 0.000677885, 0.000685055, 0.000693242, 0.000702966, 0.000711407, 0.000722574, 0.000728942, 0.00073585, 0.000744105, 0.000753806, 0.000761157, 0.000772299, 0.000779454, 0.000790328, 0.000798951, 0.000810843, 0.000820614, 0.000830988, 0.000839745, 0.000847953, 0.000856775, 0.000865299, 0.000876475, 0.000888252, 0.000897385, 0.000909719, 0.000923365, 0.000933342, 0.00094605, 0.000956811, 0.000969173, 0.000976318, 0.000979332, 0.000993564, 0.001005039, 0.001016103, 0.001025172, 0.001038597, 0.00104944, 0.001064093, 0.00107921, 0.001091534, 0.001105862, 0.001118496, 0.001131185, 0.001142954, 0.001158096, 0.0011722, 0.001186894, 0.001202164, 0.001218249, 0.001232575, 0.001247647, 0.001265873, 0.001283783, 0.001297789, 0.00131253, 0.00132636, 0.001340195, 0.001357354, 0.001372434, 0.001388906, 0.001405144, 0.001424482, 0.001438795, 0.00145831, 0.001472921, 0.001489218, 0.001506165, 0.001525709, 0.001543268, 0.001561492, 0.00158057, 0.001596647, 0.001613427, 0.001633854, 0.001653302, 0.001676213, 0.001697714, 0.001717371, 0.001739668, 0.001758515, 0.001780935, 0.001802748, 0.001823756, 0.001844841, 0.0018657, 0.00188685, 0.001908887, 0.001931815, 0.001953135, 0.001975967, 0.002000222, 0.002026763, 0.002049139, 0.002071201, 0.002096148, 0.002120228, 0.002145104, 0.002171967, 0.002199421, 0.002222931, 0.002249921, 0.002275478, 0.002300627, 0.002326402, 0.002353507, 0.002381964, 0.002407152, 0.002435657, 0.002459124, 0.002485891, 0.002516222, 0.002548849, 0.002578078, 0.002602483, 0.002633057, 0.00266164, 0.002699039, 0.002731672, 0.002762611, 0.002790618, 0.002821572, 0.002856852, 0.002889224, 0.002918868, 0.002952661, 0.002987048, 0.00301797, 0.003054713, 0.003087561, 0.00312267, 0.003155237, 0.003192587, 0.003228129, 0.003271984, 0.003314523, 0.003351523, 0.003388489, 0.003428068, 0.003467536, 0.00351275, 0.003553854, 0.00359994, 0.003641945, 0.003688275, 0.003732734, 0.003772217, 0.003813692, 0.003858764, 0.003903562, 0.003955557, 0.003998601, 0.004042842, 0.00408987, 0.004136763, 0.00418031, 0.004225705, 0.004272827, 0.004320931, 0.004376629, 0.00442466, 0.004473494, 0.00452825, 0.004580761, 0.004635671, 0.004691539, 0.004747212, 0.004801832, 0.0048537, 0.004908977, 0.004966246, 0.005022952, 0.005080471, 0.005137943, 0.005198803, 0.005259809, 0.005322021, 0.005381294, 0.005448784, 0.005506109, 0.005569297, 0.005636612, 0.005709272, 0.005776645, 0.005842622, 0.005907972, 0.005979773, 0.006050268, 0.006119947, 0.006191937, 0.006257924, 0.006332057, 0.006397062, 0.006468974, 0.006543425, 0.006621174, 0.006694334, 0.006767494, 0.006846333, 0.006922691, 0.007001868, 0.007077291, 0.007156531, 0.007242269, 0.007322086, 0.007406104, 0.0074938, 0.007583883, 0.00767322, 0.007758872, 0.00785313, 0.007946915, 0.008041751, 0.00813417, 0.008232993, 0.00832743, 0.008422489, 0.00850936, 0.008608189, 0.008703262, 0.008812769, 0.008915303, 0.009013235, 0.009115237, 0.009228099, 0.009338106, 0.00944284, 0.009553399, 0.009661682, 0.009771256, 0.009893945, 0.009987961, 0.010011588, 0.010128678, 0.010246869, 0.010362978, 0.010479596, 0.010597811, 0.010716364, 0.0108441, 0.010970138, 0.011105286, 0.011233498, 0.011358782, 0.01148587, 0.011620296, 0.011756402, 0.01189446, 0.01203156, 0.012173215, 0.012310305, 0.012446006, 0.012598927, 0.012747672, 0.012899352, 0.013041951, 0.013198545, 0.01336034, 0.013514248, 0.013672629, 0.013833003, 0.013989302, 0.014157266, 0.014324415, 0.014494696, 0.014654952, 0.014826421, 0.014993453, 0.01518531, 0.015374356, 0.015552943, 0.015732018, 0.015910393, 0.016101102, 0.01628202, 0.016474503, 0.016668722, 0.016870715, 0.017072664, 0.017272478, 0.017465778, 0.017663856, 0.017868938, 0.018078108, 0.018286096, 0.018502116, 0.018714076, 0.018933194, 0.019146969, 0.019364799, 0.019603091, 0.019826448, 0.020048365, 0.020276861, 0.020506979, 0.020730198, 0.02096665, 0.021216835, 0.021468721, 0.021716815, 0.021963973, 0.022218165, 0.02249038, 0.022742974, 0.023009418, 0.023278825, 0.023560105, 0.023836891, 0.024117304, 0.024389161, 0.02467489, 0.024979292, 0.025279586, 0.025569242, 0.025864336, 0.026171801, 0.026482004, 0.026786519, 0.027092973, 0.027436527, 0.027745921, 0.028076733, 0.028403527, 0.028741013, 0.029091065, 0.029428384, 0.029773884, 0.030118636, 0.030460549, 0.030815852, 0.031187915, 0.031553373, 0.031926508, 0.032308221, 0.032680967, 0.033059975, 0.033448324, 0.033845057, 0.034256549, 0.034651379, 0.035067622, 0.035484032, 0.035912454, 0.036314418, 0.036738958, 0.037162515, 0.037608517, 0.038045379, 0.038486902, 0.038955459, 0.039418652, 0.039869928, 0.040317247, 0.0407707, 0.041235997, 0.041720606, 0.042224011, 0.042726931, 0.043227051, 0.043731151, 0.044241674, 0.044773434, 0.045292988, 0.045809581, 0.046339434, 0.046874789, 0.047413108, 0.047965485, 0.048516821, 0.049091405, 0.049663424, 0.050243036, 0.050813737, 0.051408716, 0.05201184, 0.052609203, 0.053229173, 0.053845641, 0.054467917, 0.05510297, 0.055759368, 0.056408494, 0.057058393, 0.057729424, 0.058414888, 0.059116772, 0.0597981, 0.060490588, 0.061192425, 0.061907969, 0.06263199, 0.063392313, 0.064143348, 0.064881775, 0.065648476, 0.066409027, 0.067188155, 0.06797513, 0.068750824, 0.069569587, 0.070403169, 0.071243789, 0.0720801, 0.072930627, 0.073781569, 0.074651084, 0.075561893, 0.076449292, 0.077360133, 0.078263329, 0.079187385, 0.080106821, 0.081054234, 0.082005024, 0.082998005, 0.083978622, 0.084982081, 0.085987934, 0.086995793, 0.088034154, 0.089091603, 0.090144015, 0.09119519, 0.092288066, 0.093383155, 0.094475291, 0.095575296, 0.096716658, 0.09786501, 0.099034795, 0.100186764, 0.101384212, 0.102353303, 0.102608275, 0.103822879, 0.105084515, 0.106329987, 0.107601963, 0.108884933, 0.110179284, 0.111489639, 0.112823351, 0.114184706, 0.115534168, 0.116934916, 0.118312661, 0.119723719, 0.121179005, 0.122614932, 0.12408028, 0.125607617, 0.127117844, 0.128675821, 0.130204332, 0.131748261, 0.133347317, 0.134974832, 0.13660032, 0.138256084, 0.139894704, 0.141567156, 0.143272747, 0.144988186, 0.146742392, 0.14851702, 0.150300215, 0.152072053, 0.153883075, 0.155741877, 0.157615018, 0.159539699, 0.161462968, 0.163447274, 0.165419698, 0.167403487, 0.169465999, 0.171512491, 0.173594842, 0.175710734, 0.17781881, 0.179995191, 0.182149252, 0.184372258, 0.186590762, 0.188863674, 0.191145993, 0.193505482, 0.195826177, 0.198215164, 0.200615415, 0.203025168, 0.205515597, 0.208023942, 0.21058194, 0.213181505, 0.215771723, 0.218407288, 0.221053286, 0.223744485, 0.22647246, 0.229265894, 0.232071778, 0.234900276, 0.237795354, 0.240701792, 0.243667921, 0.246622937, 0.249648621, 0.252671452, 0.255739059, 0.258869934, 0.262069996, 0.265331463, 0.26862322, 0.271982608, 0.275396827, 0.278853574, 0.282297456, 0.285826785, 0.289398895, 0.293013057, 0.296637045, 0.300384672, 0.304141693, 0.307925098, 0.311758599, 0.315626989, 0.319586624, 0.323572304, 0.324482584, 0.327639688, 0.331724196, 0.335898652, 0.340126904, 0.344356883, 0.348713883, 0.353050529, 0.357533678, 0.362142031, 0.366734177, 0.371380188, 0.37613222, 0.380915221, 0.385805748, 0.390686515, 0.395647902, 0.400783906, 0.405924596, 0.411137691, 0.416437348, 0.421763918, 0.427219507, 0.432745285, 0.438358055, 0.443950978, 0.445098911, 0.449691877, 0.45551343, 0.461449668, 0.467499555, 0.473617463, 0.479866822, 0.486134019, 0.492443033, 0.498912301, 0.505458898, 0.512138571, 0.518810816, 0.525675686, 0.532626972, 0.539662164, 0.546833215, 0.554171041, 0.561575312, 0.569053974, 0.576679115, 0.584477513, 0.592267446, 0.600264156, 0.608407889, 0.61661681, 0.624987398, 0.633488998, 0.642130529, 0.650973956, 0.659904965, 0.66895086, 0.678146213, 0.687553174, 0.697080788, 0.706725016, 0.710835446, 0.716522943, 0.726605261, 0.73675373, 0.747041251, 0.757603248, 0.768271013, 0.779086525, 0.790086954, 0.801467527, 0.812993436, 0.82463898, 0.836658917, 0.848745115, 0.860990569, 0.873474269, 0.886261549, 0.899237068, 0.912496999, 0.926019843, 0.939559171, 0.95349634, 0.967678427, 0.982123815, 0.99683852, 1.011854472, 1.018074694, 1.027029105, 1.042510483, 1.05832214, 1.074628134, 1.091323101, 1.108352608, 1.125464103, 1.143092581, 1.161039627, 1.179357356, 1.198010015, 1.217044686, 1.236438616, 1.256413992, 1.276822646, 1.297641298, 1.318759204, 1.340466779, 1.362769541, 1.380813191, 1.421839241, 1.444706794, 1.467757033, 1.490801155, 1.513604652, 1.53642429, 1.559431719, 1.582306189, 1.605163235, 1.628119192, 1.651106655, 1.67394735, 1.696747518, 1.719632869, 1.742427519, 1.765334369, 1.788280658, 1.811235982, 1.824762899, 1.834066276, 1.857041227, 1.880129096, 1.903151676, 1.926021295, 1.948868757, 1.971789649, 1.994524594, 2.017493213, 2.040351274, 2.063197505, 2.086015042, 2.109074118, 2.132020323, 2.155018084, 2.177747075, 2.200720009, 2.223396652, 2.246136027, 2.269204726, 2.292060244, 2.314665324, 2.337673977, 2.360687947, 2.383579603, 2.39678395, 2.406496153, 2.429571463, 2.452444775, 2.475296436, 2.498075808, 2.520917811, 2.543595992, 2.566592949, 2.589416066, 2.612389061, 2.63516765, 2.6580917, 2.681159045, 2.703994885, 2.726822622, 2.74959839, 2.772526291, 2.795447428, 2.818175682, 2.841298118, 2.864105138, 2.886974869, 2.910062207, 2.933073042, 2.955872771, 2.97875241, 3.002012321, 3.024900935, 3.047751948, 3.070702076, 3.093838732, 3.116737233, 3.139536846, 3.162607839, 3.185366338, 3.203576708, 3.208258924, 3.231243422, 3.254136622, 3.277409297, 3.300306828, 3.323307927, 3.346111609, 3.368775711, 3.391500163, 3.414223943, 3.436873624, 3.459895214, 3.482863538, 3.505974818, 3.529344276, 3.552351023, 3.575651971, 3.598575047, 3.621358129, 3.644211801, 3.667127522, 3.69023184, 3.713539776, 3.736469769, 3.759549309, 3.777783051, 3.782804279, 3.805741046, 3.828673116, 3.851582242, 3.874483158, 3.89746273, 3.920562307, 3.943494704, 3.966411152, 3.989837916, 4.012506628, 4.03563262, 4.058749216, 4.081417425, 4.104222863, 4.126966589, 4.150032311, 4.172942547, 4.195745795, 4.218713402, 4.242094246, 4.265214382, 4.288523908, 4.311774814, 4.33523561, 4.358333093, 4.381150221, 4.4041931, 4.427320514, 4.44999237, 4.473256417, 4.496300112, 4.51941676, 4.542529576, 4.565793943, 4.588838271, 4.612007785, 4.635021236, 4.658005277, 4.681102818, 4.703868097, 4.726753352, 4.750079944, 4.772822559, 4.79591235, 4.819273371, 4.842461023, 4.86585338, 4.889257759, 4.912191388, 4.935330689, 4.958259575, 4.981911279, 5.004698315, 5.027582433, 5.050379316, 5.07365985, 5.096505808, 5.119850501, 5.143041386, 5.166591282, 5.189651594, 5.212705059, 5.23528152, 5.258117232, 5.281225356, 5.304552059, 5.327354984, 5.349931119, 5.373401472, 5.396584264, 5.419984303, 5.443216919, 5.46675659, 5.490020154, 5.513843839, 5.537160747, 5.560406322, 5.583809855, 5.607145928, 5.630320082, 5.653712015, 5.676892069, 5.700460256, 5.723920246, 5.748147543, 5.771304051, 5.794657284, 5.818134764, 5.841428812, 5.864939105, 5.887960256, 5.911108228, 5.934205964, 5.957674208, 5.980635103, 5.985735184, 6.004379766, 6.027697822, 6.050831796, 6.074846313, 6.097486343, 6.120615546, 6.144105443, 6.167482109, 6.191192951, 6.214192013, 6.23791232, 6.261851599, 6.285425359, 6.308658778, 6.3318006, 6.35539821, 6.379317781, 6.402478033, 6.426629586, 6.449850911, 6.472757269, 6.496162126, 6.520086402, 6.543911011, 6.567273118, 6.590330468, 6.613644713, 6.636766776, 6.660457667, 6.683924627, 6.706662577, 6.72987785, 6.753048332, 6.777293778, 6.801380579, 6.825213157, 6.849139063, 6.873269298, 6.897617483, 6.92031197, 6.94323195, 6.966620608, 6.990256641, 7.014038558, 7.03762782, 7.061594753, 7.084524704, 7.107751459, 7.132080726, 7.155885644, 7.178844778, 7.202562218, 7.22676135, 7.251069521, 7.274901836, 7.298602888, 7.321947079, 7.345241594, 7.369204399, 7.393287777, 7.417370072, 7.440769256, 7.46464573, 7.488501421, 7.512544493, 7.536186612, 7.559649809, 7.583013899, 7.607231066, 7.630920846, 7.654824339, 7.679048681, 7.702645031, 7.726330728, 7.750380717, 7.773797316, 7.796923189, 7.820934791, 7.84420086, 7.866992807, 7.890810954, 7.914438545, 7.938991149, 7.963538553, 7.986848288, 8.010409612, 8.034342682, 8.057893432, 8.0814986, 8.105565027, 8.129491018, 8.153157557, 8.176225511, 8.199988856, 8.224302502, 8.247244967, 8.270735097, 8.295116731, 8.31887978, 8.342685312, 8.366776886, 8.391127462, 8.415567057, 8.438853282, 8.463062293, 8.487153553, 8.512192163, 8.535564365, 8.558782883, 8.584999974, 8.609331772, 8.633419705, 8.65772375, 8.681375063, 8.706117403, 8.729982387, 8.753647425, 8.77723426, 8.800306384, 8.825915771, 8.850230909, 8.875565671, 8.899660467, 8.923478601, 8.94673013, 8.970247117, 8.99571305, 9.021029926, 9.044338109, 9.067812183, 9.092436745, 9.116534101, 9.141173439, 9.16581246, 9.19016182, 9.213718398, 9.238553696, 9.263319158, 9.287780195, 9.312818417, 9.335650818, 9.360047671, 9.384148898, 9.407878145, 9.432512292, 9.458497367, 9.483293222, 9.50781117, 9.532396941, 9.55867118, 9.584239606, 9.610262997, 9.634404604, 9.65890613, 9.68416484, 9.708085733, 9.731545409, 9.75665308, 9.781612532, 9.806549653, 9.83164631, 9.855773889, 9.880832429, 9.906461607, 9.931392805, 9.957818529, 9.982988124, 10.007216475, 10.032968506, 10.056888974, 10.07924291, 10.102376488, 10.126335862, 10.151872437, 10.176880172, 10.200285928, 10.22478936, 10.24899299, 10.273258454, 10.296377443, 10.320424109, 10.345206656, 10.367762036, 10.3918676, 10.414851575, 10.438671446, 10.462928126, 10.488210843, 10.513115787, 10.540015512, 10.565615482, 10.590872799, 10.615257098, 10.638928263, 10.662965975, 10.688630901, 10.711997907, 10.737824537, 10.761477787, 10.786467629, 10.792231654, 10.812406907, 10.840110326, 10.864351032, 10.890767298, 10.914839666, 10.941550397, 10.965596399, 10.991601924, 11.015257328, 11.038812213, 11.063250376, 11.088158985, 11.110969924, 11.136501029, 11.160050068, 11.185168048, 11.208420564, 11.23449531, 11.258269627, 11.28333462, 11.308023927, 11.332149442, 11.35674268, 11.382709595, 11.408635456, 11.434081077, 11.460691115, 11.486886744, 11.511925957, 11.538227515, 11.561482114, 11.588038383, 11.613615497, 11.640000906, 11.666570697, 11.691574658, 11.718095227, 11.741774989, 11.767905802, 11.794080635, 11.8189974, 11.843191574, 11.869897942, 11.895302369, 11.921198187, 11.945994383, 11.971029875, 11.999356859, 12.02575441, 12.052458002, 12.078479965, 12.102351674, 12.128215565, 12.155193375, 12.180918728, 12.206071525, 12.232945321, 12.258985202, 12.284282214, 12.312340877, 12.334943443, 12.359099381, 12.387912068, 12.412346753, 12.437384193, 12.464081128, 12.490051813, 12.515095577, 12.540464028, 12.565115327, 12.590901432, 12.615516028, 12.641644221, 12.667287805, 12.690342248, 12.716665273, 12.74584328, 12.772823717, 12.79468774, 12.817717343, 12.844412416, 12.868887861, 12.894763409, 12.920278037, 12.94797719, 12.974302091, 13.001002582, 13.02991896, 13.058134468, 13.085473504, 13.113290603, 13.138432615, 13.161466991, 13.190223232, 13.215796624, 13.238943258, 13.26440621, 13.291255433, 13.318092951, 13.343115489, 13.369715506, 13.399482127, 13.42590911, 13.452359664, 13.4787372, 13.506241878, 13.527237724, 13.553870152, 13.578138904, 13.601917501, 13.631728658, 13.655675974, 13.681566582, 13.708549454, 13.738020555, 13.759773624, 13.78536036, 13.807242198, 13.83334189, 13.862074913, 13.88641803, 13.912677314, 13.935211416, 13.961523516, 13.987809955, 14.016189606, 14.044468375, 14.077597999, 14.107231333, 14.135385542, 14.162774649, 14.1873333, 14.211855811, 14.238396169, 14.264868818, 14.292020793, 14.318581268, 14.344092476, 14.370915605, 14.396728713, 14.424570272, 14.451920358, 14.478384546, 14.508639244, 14.53039032, 14.5544646, 14.582625673, 14.61192027, 14.636708016, 14.661911642, 14.686709221, 14.711020832, 14.735690136, 14.763541904, 14.789784351, 14.813448353, 14.846229171, 14.86830997, 14.894117104, 14.921738904, 14.955020808, 14.984595065, 15.014557113, 15.039844056, 15.068733065, 15.095186713, 15.126635765, 15.156778159, 15.181193589, 15.206289764, 15.232388602, 15.25468962, 15.282240409, 15.305502241, 15.33381819, 15.358781265, 15.383394818, 15.408615071, 15.438348368, 15.466865177, 15.494027617, 15.527721318, 15.556087058, 15.580720574, 15.610593233, 15.637725393, 15.667592105, 15.695452943, 15.728039465, 15.755593351, 15.782846731, 15.814585652, 15.845362251, 15.872293979, 15.901956006, 15.931442266, 15.95630612, 15.984759421, 16.015721082, 16.04144634, 16.05164719, 16.067132169, 16.090129135, 16.113178777, 16.143404946, 16.172407612, 16.204191332, 16.236950768, 16.268898532, 16.296974092, 16.322992924, 16.338979209, 16.361586192, 16.388674794, 16.416639129, 16.452999313, 16.478163633, 16.50349834, 16.528266993, 16.557166262, 16.577620842, 16.603543288, 16.630289228, 16.65782226, 16.687659026, 16.717200793, 16.749410579, 16.771644772, 16.793892317, 16.830283961, 16.855870419, 16.883081266, 16.910815692, 16.944913092, 16.975130468, 17.002275256, 17.035655385, 17.061144001, 17.09076142, 17.118666514, 17.14933933, 17.174606576, 17.209864013, 17.240932162, 17.269894885, 17.297863787, 17.320020753, 17.345718806, 17.366174563, 17.385332378, 17.403942865, 17.434170847, 17.464387864, 17.496301624, 17.52159258, 17.547912196, 17.577732943, 17.596594383, 17.626801495, 17.647201961, 17.677370291, 17.70462828, 17.751083617, 17.776368386, 17.797823279, 17.81959781, 17.843597637, 17.862590964, 17.900599573, 17.934218444, 17.959376549, 17.989139158, 18.024174897, 18.059488246, 18.086663296, 18.111138854, 18.148657051, 18.180230185, 18.208105326, 18.235472994, 18.261277404, 18.286004033, 18.315272052, 18.348611163, 18.383736355, 18.420249564, 18.445069249, 18.468553199, 18.499833977, 18.53260525, 18.564322782, 18.600765601, 18.630925991, 18.655744493, 18.682030879, 18.705624299, 18.733848803, 18.759553745, 18.793948319, 18.824964964, 18.840525753, 18.863035577, 18.888515695, 18.920156247, 18.947292951, 18.979309166, 19.011339372, 19.039102594, 19.075241114, 19.094528102, 19.127505157, 19.153849514, 19.176863805, 19.198475326, 19.22932657, 19.246496105, 19.272057321, 19.297184385, 19.320840451, 19.343128872, 19.359622668, 19.387155605, 19.420125166, 19.443364598, 19.477563357, 19.501981701, 19.525499587, 19.561157541, 19.589036889, 19.608136575, 19.63344721, 19.665400589, 19.683431536, 19.709911865, 19.752103229, 19.780886616, 19.815262894, 19.853236895, 19.884251557, 19.918852043, 19.939729968, 19.971313697, 20.003996899, 20.043244746, 20.080171541, 20.126200331, 20.153193524, 20.178767288, 20.211899696, 20.245437777, 20.267088983, 20.294749841, 20.316821507, 20.355951972, 20.388050596, 20.404681547, 20.430763097, 20.462834763, 20.48217512, 20.527059696, 20.561021129, 20.620512046, 20.641887509, 20.682123183, 20.713720103, 20.732439408, 20.756800303, 20.781591036, 20.825271323, 20.841334052, 20.86377364, 20.894405747, 20.924786397, 20.95031274, 20.987350088, 21.011710295, 21.032226973, 21.058906283, 21.072841234, 21.13060025, 21.1651364, 21.218803998, 21.271269265, 21.308874393, 21.337807323, 21.353758961, 21.375514536, 21.401666373, 21.419324351, 21.448392333, 21.48365833, 21.510465887, 21.562343035, 21.595330316, 21.638457773, 21.673420571, 21.709197658, 21.728695918, 21.774307486, 21.787296725, 21.827665014, 21.866367778, 21.895080195, 21.903843845, 21.921600286, 21.946299211, 21.982785895, 22.039371515, 22.082036147, 22.101947287, 22.121003254, 22.163009226, 22.184504353, 22.214185064, 22.222782427, 22.25126491, 22.299124636, 22.317412928, 22.350775586, 22.399291558, 22.438757012, 22.456301417, 22.499935415, 22.532784789, 22.60156022, 22.636485459, 22.678030492, 22.69956242, 22.735447784, 22.777606533, 22.788632485, 22.797931312, 22.837180453, 22.86596757, 22.888916233, 22.946742326, 22.974604712, 23.003491087, 23.035161967, 23.097804069, 23.122325995, 23.140576181, 23.184421908, 23.224538776, 23.287732272, 23.319570439, 23.343978328, 23.38774935, 23.446583199, 23.453492148, 23.505542654, 23.516144987, 23.562788454, 23.577253453, 23.582717683, 23.629252236, 23.652089402, 23.681712286, 23.697473803, 23.722171055, 23.750206714, 23.775301761, 23.805282649, 23.815443127, 23.848098835, 23.867746378, 23.886847441, 23.90105248, 23.933918917, 23.964668736, 24.030082728, 24.183934579, 24.190867612, 24.244196373, 24.284390552, 24.359729962, 24.385272677, 24.448685167, 24.522437854, 24.527607467, 24.542801663, 24.61371486, 24.675095637, 24.720456848, 24.725428965, 24.790294908, 24.799948966, 24.800939572, 24.810143823, 24.848215793, 24.91043489, 24.918278488, 24.935245201, 24.968281895, 24.984504569, 25.026148115, 25.064518562, 25.116401007, 25.134021561, 25.139076389, 25.187784998, 25.189022684, 25.213284168, 25.323710031, 25.401259278, 25.460350133, 25.462677897, 25.471552555, 25.477670604, 25.529011239, 25.607512567, 25.617872297, 25.625716314, 25.672753602, 25.67911233, 25.718541815, 25.747157979, 25.761652248, 25.843885294, 25.890676333, 25.91760945, 25.995443385, 26.034834368, 26.03634578, 26.043951844, 26.051527127, 26.078781322, 26.096850322, 26.120832803, 26.190551683, 26.205826895, 26.243900869, 26.265534583, 26.302539129, 26.329828819, 26.367210457, 26.370845622, 26.385461048, 26.47064484, 26.522115411, 26.553212865)), .Names = c("5", "6", "8", "10", "20", "35", "50", "75", "100", "150", "200", "300", "500", "800", "1000", "1400", "1600", "2400", "10000"), row.names = c("1e-05", "1.01e-05", "1.02e-05", "1.04e-05", "1.05e-05", "1.06e-05", "1.07e-05", "1.08e-05", "1.1e-05", "1.11e-05", "1.12e-05", "1.14e-05", "1.15e-05", "1.16e-05", "1.17e-05", "1.19e-05", "1.2e-05", "1.22e-05", "1.23e-05", "1.24e-05", "1.26e-05", "1.27e-05", "1.29e-05", "1.3e-05", "1.32e-05", "1.33e-05", "1.35e-05", "1.36e-05", "1.38e-05", "1.4e-05", "1.41e-05", "1.43e-05", "1.45e-05", "1.46e-05", "1.48e-05", "1.5e-05", "1.51e-05", "1.53e-05", "1.55e-05", "1.57e-05", "1.58e-05", "1.6e-05", "1.62e-05", "1.64e-05", "1.66e-05", "1.68e-05", "1.7e-05", "1.72e-05", "1.74e-05", "1.76e-05", "1.78e-05", "1.8e-05", "1.82e-05", "1.84e-05", "1.86e-05", "1.88e-05", "1.91e-05", "1.93e-05", "1.95e-05", "1.97e-05", "2e-05", "2.02e-05", "2.04e-05", "2.07e-05", "2.09e-05", "2.11e-05", "2.14e-05", "2.16e-05", "2.19e-05", "2.21e-05", "2.24e-05", "2.26e-05", "2.29e-05", "2.32e-05", "2.34e-05", "2.37e-05", "2.4e-05", "2.43e-05", "2.45e-05", "2.48e-05", "2.51e-05", "2.54e-05", "2.57e-05", "2.6e-05", "2.63e-05", "2.66e-05", "2.69e-05", "2.72e-05", "2.75e-05", "2.79e-05", "2.82e-05", "2.85e-05", "2.88e-05", "2.92e-05", "2.95e-05", "2.99e-05", "3.02e-05", "3.05e-05", "3.09e-05", "3.13e-05", "3.16e-05", "3.2e-05", "3.24e-05", "3.27e-05", "3.31e-05", "3.35e-05", "3.39e-05", "3.43e-05", "3.47e-05", "3.51e-05", "3.55e-05", "3.59e-05", "3.63e-05", "3.67e-05", "3.72e-05", "3.76e-05", "3.8e-05", "3.85e-05", "3.89e-05", "3.94e-05", "3.98e-05", "4.03e-05", "4.07e-05", "4.12e-05", "4.17e-05", "4.22e-05", "4.27e-05", "4.32e-05", "4.37e-05", "4.42e-05", "4.47e-05", "4.52e-05", "4.57e-05", "4.62e-05", "4.68e-05", "4.73e-05", "4.79e-05", "4.84e-05", "4.9e-05", "4.95e-05", "5.01e-05", "5.07e-05", "5.13e-05", "5.19e-05", "5.25e-05", "5.31e-05", "5.37e-05", "5.43e-05", "5.5e-05", "5.56e-05", "5.62e-05", "5.69e-05", "5.75e-05", "5.82e-05", "5.89e-05", "5.96e-05", "6.03e-05", "6.1e-05", "6.17e-05", "6.24e-05", "6.31e-05", "6.38e-05", "6.46e-05", "6.53e-05", "6.61e-05", "6.68e-05", "6.76e-05", "6.84e-05", "6.92e-05", "7e-05", "7.08e-05", "7.16e-05", "7.24e-05", "7.33e-05", "7.41e-05", "7.5e-05", "7.59e-05", "7.67e-05", "7.76e-05", "7.85e-05", "7.94e-05", "8.04e-05", "8.13e-05", "8.22e-05", "8.32e-05", "8.41e-05", "8.51e-05", "8.61e-05", "8.71e-05", "8.81e-05", "8.91e-05", "9.02e-05", "9.12e-05", "9.23e-05", "9.33e-05", "9.44e-05", "9.55e-05", "9.66e-05", "9.77e-05", "9.89e-05", "1e-04", "0.0001012", "0.0001023", "0.0001035", "0.0001047", "0.0001059", "0.0001072", "0.0001084", "0.0001096", "0.0001109", "0.0001122", "0.0001135", "0.0001148", "0.0001161", "0.0001175", "0.0001189", "0.0001202", "0.0001216", "0.000123", "0.0001245", "0.0001259", "0.0001274", "0.0001288", "0.0001303", "0.0001318", "0.0001334", "0.0001349", "0.0001365", "0.000138", "0.0001396", "0.0001413", "0.0001429", "0.0001445", "0.0001462", "0.0001479", "0.0001496", "0.0001514", "0.0001531", "0.0001549", "0.0001567", "0.0001585", "0.0001603", "0.0001622", "0.0001641", "0.000166", "0.0001679", "0.0001698", "0.0001718", "0.0001738", "0.0001758", "0.0001778", "0.0001799", "0.000182", "0.0001841", "0.0001862", "0.0001884", "0.0001905", "0.0001928", "0.000195", "0.0001972", "0.0001995", "0.0002018", "0.0002042", "0.0002065", "0.0002089", "0.0002113", "0.0002138", "0.0002163", "0.0002188", "0.0002213", "0.0002239", "0.0002265", "0.0002291", "0.0002317", "0.0002344", "0.0002371", "0.0002399", "0.0002427", "0.0002455", "0.0002483", "0.0002512", "0.0002541", "0.000257", "0.00026", "0.000263", "0.0002661", "0.0002692", "0.0002723", "0.0002754", "0.0002786", "0.0002818", "0.0002851", "0.0002884", "0.0002917", "0.0002951", "0.0002985", "0.000302", "0.0003055", "0.000309", "0.0003126", "0.0003162", "0.0003199", "0.0003236", "0.0003273", "0.0003311", "0.000335", "0.0003388", "0.0003428", "0.0003467", "0.0003508", "0.0003548", "0.0003589", "0.0003631", "0.0003673", "0.0003715", "0.0003758", "0.0003802", "0.0003846", "0.000389", "0.0003936", "0.0003981", "0.0004027", "0.0004074", "0.0004121", "0.0004169", "0.0004217", "0.0004266", "0.0004315", "0.0004365", "0.0004416", "0.0004467", "0.0004519", "0.0004571", "0.0004624", "0.0004677", "0.0004732", "0.0004786", "0.0004842", "0.0004898", "0.0004955", "5e-04", "0.0005012", "0.000507", "0.0005129", "0.0005188", "0.0005248", "0.0005309", "0.000537", "0.0005433", "0.0005495", "0.0005559", "0.0005623", "0.0005689", "0.0005754", "0.0005821", "0.0005888", "0.0005957", "0.0006026", "0.0006095", "0.0006166", "0.0006237", "0.000631", "0.0006383", "0.0006457", "0.0006531", "0.0006607", "0.0006683", "0.0006761", "0.0006839", "0.0006918", "0.0006998", "0.0007079", "0.0007161", "0.0007244", "0.0007328", "0.0007413", "0.0007499", "0.0007586", "0.0007674", "0.0007762", "0.0007852", "0.0007943", "0.0008035", "0.0008128", "0.0008222", "0.0008318", "0.0008414", "0.0008511", "0.000861", "0.000871", "0.000881", "0.0008913", "0.0009016", "0.000912", "0.0009226", "0.0009333", "0.0009441", "0.000955", "0.0009661", "0.0009772", "0.0009886", "0.001", "0.0010116", "0.0010233", "0.0010351", "0.0010471", "0.0010593", "0.0010715", "0.0010839", "0.0010965", "0.0011092", "0.001122", "0.001135", "0.0011482", "0.0011614", "0.0011749", "0.0011885", "0.0012023", "0.0012162", "0.0012303", "0.0012445", "0.0012589", "0.0012735", "0.0012882", "0.0013032", "0.0013183", "0.0013335", "0.001349", "0.0013646", "0.0013804", "0.0013964", "0.0014125", "0.0014289", "0.0014454", "0.0014622", "0.0014791", "0.0014962", "0.0015136", "0.0015311", "0.0015488", "0.0015668", "0.0015849", "0.0016032", "0.0016218", "0.0016406", "0.0016596", "0.0016788", "0.0016982", "0.0017179", "0.0017378", "0.0017579", "0.0017783", "0.0017989", "0.0018197", "0.0018408", "0.0018621", "0.0018836", "0.0019055", "0.0019275", "0.0019498", "0.0019724", "0.0019953", "0.0020184", "0.0020417", "0.0020654", "0.0020893", "0.0021135", "0.002138", "0.0021627", "0.0021878", "0.0022131", "0.0022387", "0.0022646", "0.0022909", "0.0023174", "0.0023442", "0.0023714", "0.0023988", "0.0024266", "0.0024547", "0.0024831", "0.0025119", "0.002541", "0.0025704", "0.0026002", "0.0026303", "0.0026607", "0.0026915", "0.0027227", "0.0027542", "0.0027861", "0.0028184", "0.002851", "0.002884", "0.0029174", "0.0029512", "0.0029854", "0.00302", "0.0030549", "0.0030903", "0.0031261", "0.0031623", "0.0031989", "0.0032359", "0.0032734", "0.0033113", "0.0033497", "0.0033884", "0.0034277", "0.0034674", "0.0035075", "0.0035481", "0.0035892", "0.0036308", "0.0036728", "0.0037154", "0.0037584", "0.0038019", "0.0038459", "0.0038905", "0.0039355", "0.0039811", "0.0040272", "0.0040738", "0.004121", "0.0041687", "0.004217", "0.0042658", "0.0043152", "0.0043652", "0.0044157", "0.0044668", "0.0045186", "0.0045709", "0.0046238", "0.0046774", "0.0047315", "0.0047863", "0.0048417", "0.0048978", "0.0049545", "0.005", "0.0050119", "0.0050699", "0.0051286", "0.005188", "0.0052481", "0.0053088", "0.0053703", "0.0054325", "0.0054954", "0.005559", "0.0056234", "0.0056885", "0.0057544", "0.005821", "0.0058884", "0.0059566", "0.0060256", "0.0060954", "0.006166", "0.0062373", "0.0063096", "0.0063826", "0.0064565", "0.0065313", "0.0066069", "0.0066834", "0.0067608", "0.0068391", "0.0069183", "0.0069984", "0.0070795", "0.0071614", "0.0072444", "0.0073282", "0.0074131", "0.0074989", "0.0075858", "0.0076736", "0.0077625", "0.0078524", "0.0079433", "0.0080353", "0.0081283", "0.0082224", "0.0083176", "0.008414", "0.0085114", "0.0086099", "0.0087096", "0.0088105", "0.0089125", "0.0090157", "0.0091201", "0.0092257", "0.0093325", "0.0094406", "0.0095499", "0.0096605", "0.0097724", "0.0098855", "0.01", "0.0101158", "0.0102329", "0.0103514", "0.0104713", "0.0105925", "0.0107152", "0.0108393", "0.0109648", "0.0110917", "0.0112202", "0.0113501", "0.0114815", "0.0116145", "0.011749", "0.011885", "0.0120226", "0.0121619", "0.0123027", "0.0124451", "0.0125893", "0.012735", "0.0128825", "0.0130317", "0.0131826", "0.0133352", "0.0134896", "0.0136458", "0.0138038", "0.0139637", "0.0141254", "0.0142889", "0.0144544", "0.0146218", "0.0147911", "0.0149624", "0.0151356", "0.0153109", "0.0154882", "0.0156675", "0.0158489", "0.0160325", "0.0162181", "0.0164059", "0.0165959", "0.016788", "0.0169824", "0.0171791", "0.017378", "0.0175792", "0.0177828", "0.0179887", "0.018197", "0.0184077", "0.0186209", "0.0188365", "0.0190546", "0.0192752", "0.0194984", "0.0197242", "0.0199526", "0.0201837", "0.0204174", "0.0206538", "0.020893", "0.0211349", "0.0213796", "0.0216272", "0.0218776", "0.0221309", "0.0223872", "0.0226464", "0.0229087", "0.0231739", "0.0234423", "0.0237137", "0.0239883", "0.0242661", "0.0245471", "0.0248313", "0.0251189", "0.0254097", "0.025704", "0.0260016", "0.0263027", "0.0266073", "0.0269153", "0.027227", "0.0275423", "0.0278612", "0.0281838", "0.0285102", "0.0288403", "0.0291743", "0.0295121", "0.0298538", "0.0301995", "0.0305492", "0.030903", "0.0312608", "0.0316228", "0.031989", "0.0323594", "0.0327341", "0.0331131", "0.0334965", "0.0338844", "0.0342768", "0.0346737", "0.0350752", "0.0354813", "0.0358922", "0.0363078", "0.0367282", "0.0371535", "0.0375837", "0.0380189", "0.0384592", "0.0389045", "0.039355", "0.0398107", "0.0402717", "0.040738", "0.0412098", "0.0416869", "0.0421697", "0.042658", "0.0431519", "0.0436516", "0.044157", "0.0446684", "0.0451856", "0.0457088", "0.0462381", "0.0467735", "0.0473151", "0.047863", "0.0484172", "0.0489779", "0.049545", "0.05", "0.0501187", "0.0506991", "0.0512861", "0.05188", "0.0524807", "0.0530884", "0.0537032", "0.054325", "0.0549541", "0.0555904", "0.0562341", "0.0568853", "0.057544", "0.0582103", "0.0588844", "0.0595662", "0.060256", "0.0609537", "0.0616595", "0.0623735", "0.0630957", "0.0638263", "0.0645654", "0.0653131", "0.0660693", "0.0668344", "0.0676083", "0.0683912", "0.0691831", "0.0699842", "0.0707946", "0.0716143", "0.0724436", "0.0732825", "0.074131", "0.0749894", "0.0758578", "0.0767361", "0.0776247", "0.0785236", "0.0794328", "0.0803526", "0.0812831", "0.0822243", "0.0831764", "0.0841395", "0.0851138", "0.0860994", "0.0870964", "0.0881049", "0.0891251", "0.0901571", "0.0912011", "0.0922571", "0.0933254", "0.0944061", "0.0954993", "0.0966051", "0.0977237", "0.0988553", "0.1", "0.1011579", "0.1023293", "0.1035142", "0.1047129", "0.1059254", "0.1071519", "0.1083927", "0.1096478", "0.1109175", "0.1122018", "0.1135011", "0.1148154", "0.1161449", "0.1174898", "0.1188502", "0.1202264", "0.1216186", "0.1230269", "0.1244515", "0.1258925", "0.1273503", "0.128825", "0.1303167", "0.1318257", "0.1333521", "0.1348963", "0.1364583", "0.1380384", "0.1396368", "0.1412538", "0.1428894", "0.144544", "0.1462177", "0.1479108", "0.1496236", "0.15", "0.1513561", "0.1531087", "0.1548817", "0.1566751", "0.1584893", "0.1603245", "0.162181", "0.164059", "0.1659587", "0.1678804", "0.1698244", "0.1717908", "0.1737801", "0.1757924", "0.1778279", "0.1798871", "0.1819701", "0.1840772", "0.1862087", "0.1883649", "0.1905461", "0.1927525", "0.1949845", "0.1972423", "0.1995262", "0.2", "0.2018366", "0.2041738", "0.206538", "0.2089296", "0.2113489", "0.2137962", "0.2162719", "0.2187762", "0.2213095", "0.2238721", "0.2264644", "0.2290868", "0.2317395", "0.2344229", "0.2371374", "0.2398833", "0.242661", "0.2454709", "0.2483133", "0.2511886", "0.2540973", "0.2570396", "0.260016", "0.2630268", "0.2660725", "0.2691535", "0.2722701", "0.2754229", "0.2786121", "0.2818383", "0.2851018", "0.2884032", "0.2917427", "0.2951209", "0.2985383", "0.3", "0.3019952", "0.3054921", "0.3090295", "0.3126079", "0.3162278", "0.3198895", "0.3235937", "0.3273407", "0.3311311", "0.3349654", "0.3388442", "0.3427678", "0.3467369", "0.3507519", "0.3548134", "0.3589219", "0.3630781", "0.3672823", "0.3715352", "0.3758374", "0.3801894", "0.3845918", "0.3890451", "0.3935501", "0.3981072", "0.4", "0.402717", "0.4073803", "0.4120975", "0.4168694", "0.4216965", "0.4265795", "0.4315191", "0.4365158", "0.4415704", "0.4466836", "0.4518559", "0.4570882", "0.462381", "0.4677351", "0.4731513", "0.4786301", "0.4841724", "0.4897788", "0.4954502", "0.5", "0.5102212", "0.5158276", "0.5213699", "0.5268487", "0.5322649", "0.537619", "0.5429118", "0.5481441", "0.5533164", "0.5584296", "0.5634842", "0.5684809", "0.5734205", "0.5783035", "0.5831306", "0.5879025", "0.5926197", "0.597283", "0.6", "0.6018928", "0.6064499", "0.6109549", "0.6154082", "0.6198106", "0.6241626", "0.6284648", "0.6327177", "0.6369219", "0.6410781", "0.6451866", "0.6492481", "0.6532631", "0.6572322", "0.6611558", "0.6650346", "0.6688689", "0.6726593", "0.6764063", "0.6801105", "0.6837722", "0.6873921", "0.6909705", "0.6945079", "0.6980048", "0.7", "0.7014617", "0.7048791", "0.7082573", "0.7115968", "0.7148982", "0.7181617", "0.7213879", "0.7245771", "0.7277299", "0.7308465", "0.7339275", "0.7369732", "0.739984", "0.7429604", "0.7459027", "0.7488114", "0.7516867", "0.7545291", "0.757339", "0.7601167", "0.7628626", "0.7655771", "0.7682605", "0.7709132", "0.7735356", "0.7761279", "0.7786905", "0.7812238", "0.7837281", "0.7862038", "0.7886511", "0.7910704", "0.793462", "0.7958262", "0.7981634", "0.8", "0.8004738", "0.8027577", "0.8050155", "0.8072475", "0.8094539", "0.8116351", "0.8137913", "0.8159228", "0.8180299", "0.8201129", "0.8221721", "0.8242076", "0.8262199", "0.8282092", "0.8301756", "0.8321196", "0.8340413", "0.835941", "0.837819", "0.8396755", "0.8415107", "0.8433249", "0.8451183", "0.8468913", "0.8486439", "0.85", "0.8503764", "0.8520892", "0.8537823", "0.855456", "0.8571106", "0.8587462", "0.8603632", "0.8619616", "0.8635417", "0.8651037", "0.8666479", "0.8681743", "0.8696833", "0.871175", "0.8726497", "0.8741075", "0.8755485", "0.8769731", "0.8783814", "0.8797736", "0.8811498", "0.8825102", "0.8838551", "0.8851846", "0.8864989", "0.8877982", "0.8890825", "0.8903522", "0.8916073", "0.8928481", "0.8940746", "0.8952871", "0.8964858", "0.8976707", "0.8988421", "0.9", "0.9011447", "0.9022763", "0.9033949", "0.9045007", "0.9055939", "0.9066746", "0.9077429", "0.9087989", "0.9098429", "0.9108749", "0.9118951", "0.9129036", "0.9139006", "0.9148862", "0.9158605", "0.9168236", "0.9177757", "0.9187169", "0.9196474", "0.9205672", "0.9214764", "0.9223753", "0.9232639", "0.9241422", "0.9250106", "0.925869", "0.9267175", "0.9275564", "0.9283857", "0.9292054", "0.9300158", "0.9308169", "0.9316088", "0.9323917", "0.9331656", "0.9339307", "0.9346869", "0.9354346", "0.9361737", "0.9369043", "0.9376265", "0.9383405", "0.9390463", "0.939744", "0.9404338", "0.9411156", "0.9417897", "0.942456", "0.9431147", "0.9437659", "0.9444096", "0.9450459", "0.945675", "0.9462968", "0.9469116", "0.9475193", "0.94812", "0.9487139", "0.9493009", "0.9498813", "0.95", "0.950455", "0.9510221", "0.9515828", "0.952137", "0.9526849", "0.9532265", "0.9537619", "0.9542912", "0.9548144", "0.9553316", "0.955843", "0.9563484", "0.9568481", "0.957342", "0.9578303", "0.9583131", "0.9587902", "0.959262", "0.9597283", "0.9601893", "0.960645", "0.9610955", "0.9615408", "0.9619811", "0.9624163", "0.9628465", "0.9632718", "0.9636922", "0.9641078", "0.9645187", "0.9649248", "0.9653263", "0.9657232", "0.9661156", "0.9665035", "0.9668869", "0.9672659", "0.9676406", "0.968011", "0.9683772", "0.9687392", "0.969097", "0.9694508", "0.9698005", "0.9701462", "0.9704879", "0.9708257", "0.9711597", "0.9714898", "0.9718162", "0.9721388", "0.9724577", "0.972773", "0.9730847", "0.9733927", "0.9736973", "0.9739984", "0.974296", "0.9745903", "0.9748811", "0.9751687", "0.9754529", "0.9757339", "0.9760117", "0.9762863", "0.9765577", "0.9768261", "0.9770913", "0.9773536", "0.9776128", "0.9778691", "0.9781224", "0.9783728", "0.9786204", "0.9788651", "0.979107", "0.9793462", "0.9795826", "0.9798163", "0.9800474", "0.9802758", "0.9805016", "0.9807248", "0.9809454", "0.9811635", "0.9813791", "0.9815923", "0.981803", "0.9820113", "0.9822172", "0.9824208", "0.982622", "0.9828209", "0.9830176", "0.983212", "0.9834041", "0.9835941", "0.9837819", "0.9839675", "0.9841511", "0.9843325", "0.9845118", "0.9846891", "0.9848644", "0.9850376", "0.9852089", "0.9853782", "0.9855456", "0.9857111", "0.9858746", "0.9860363", "0.9861962", "0.9863542", "0.9865104", "0.9866648", "0.9868174", "0.9869683", "0.9871175", "0.987265", "0.9874107", "0.9875549", "0.9876973", "0.9878381", "0.9879774", "0.988115", "0.988251", "0.9883855", "0.9885185", "0.9886499", "0.9887798", "0.9889083", "0.9890352", "0.9891607", "0.9892848", "0.9894075", "0.9895287", "0.9896486", "0.9897671", "0.9898842", "0.99", "0.9901145", "0.9902276", "0.9903395", "0.9904501", "0.9905594", "0.9906675", "0.9907743", "0.9908799", "0.9909843", "0.9910875", "0.9911895", "0.9912904", "0.9913901", "0.9914886", "0.991586", "0.9916824", "0.9917776", "0.9918717", "0.9919647", "0.9920567", "0.9921476", "0.9922375", "0.9923264", "0.9924142", "0.9925011", "0.9925869", "0.9926718", "0.9927556", "0.9928386", "0.9929205", "0.9930016", "0.9930817", "0.9931609", "0.9932392", "0.9933166", "0.9933931", "0.9934687", "0.9935435", "0.9936174", "0.9936904", "0.9937627", "0.993834", "0.9939046", "0.9939744", "0.9940434", "0.9941116", "0.994179", "0.9942456", "0.9943115", "0.9943766", "0.994441", "0.9945046", "0.9945675", "0.9946297", "0.9946912", "0.9947519", "0.994812", "0.9948714", "0.9949301", "0.9949881", "0.995", "0.9950455", "0.9951022", "0.9951583", "0.9952137", "0.9952685", "0.9953226", "0.9953762", "0.9954291", "0.9954814", "0.9955332", "0.9955843", "0.9956348", "0.9956848", "0.9957342", "0.995783", "0.9958313", "0.995879", "0.9959262", "0.9959728", "0.9960189", "0.9960645", "0.9961095", "0.9961541", "0.9961981", "0.9962416", "0.9962846", "0.9963272", "0.9963692", "0.9964108", "0.9964519", "0.9964925", "0.9965326", "0.9965723", "0.9966116", "0.9966503", "0.9966887", "0.9967266", "0.9967641", "0.9968011", "0.9968377", "0.9968739", "0.9969097", "0.9969451", "0.99698", "0.9970146", "0.9970488", "0.9970826", "0.997116", "0.997149", "0.9971816", "0.9972139", "0.9972458", "0.9972773", "0.9973085", "0.9973393", "0.9973697", "0.9973998", "0.9974296", "0.997459", "0.9974881", "0.9975169", "0.9975453", "0.9975734", "0.9976012", "0.9976286", "0.9976558", "0.9976826", "0.9977091", "0.9977354", "0.9977613", "0.9977869", "0.9978122", "0.9978373", "0.997862", "0.9978865", "0.9979107", "0.9979346", "0.9979583", "0.9979816", "0.9980047", "0.9980276", "0.9980502", "0.9980725", "0.9980945", "0.9981164", "0.9981379", "0.9981592", "0.9981803", "0.9982011", "0.9982217", "0.9982421", "0.9982622", "0.9982821", "0.9983018", "0.9983212", "0.9983404", "0.9983594", "0.9983782", "0.9983968", "0.9984151", "0.9984332", "0.9984512", "0.9984689", "0.9984864", "0.9985038", "0.9985209", "0.9985378", "0.9985546", "0.9985711", "0.9985875", "0.9986036", "0.9986196", "0.9986354", "0.998651", "0.9986665", "0.9986817", "0.9986968", "0.9987118", "0.9987265", "0.9987411", "0.9987555", "0.9987697", "0.9987838", "0.9987977", "0.9988115", "0.9988251", "0.9988386", "0.9988518", "0.998865", "0.998878", "0.9988908", "0.9989035", "0.9989161", "0.9989285", "0.9989407", "0.9989529", "0.9989649", "0.9989767", "0.9989884", "0.999", "0.9990114", "0.9990228", "0.9990339", "0.999045", "0.9990559", "0.9990667", "0.9990774", "0.999088", "0.9990984", "0.9991087", "0.999119", "0.999129", "0.999139", "0.9991489", "0.9991586", "0.9991682", "0.9991778", "0.9991872", "0.9991965", "0.9992057", "0.9992148", "0.9992238", "0.9992326", "0.9992414", "0.9992501", "0.9992587", "0.9992672", "0.9992756", "0.9992839", "0.9992921", "0.9993002", "0.9993082", "0.9993161", "0.9993239", "0.9993317", "0.9993393", "0.9993469", "0.9993543", "0.9993617", "0.999369", "0.9993763", "0.9993834", "0.9993905", "0.9993974", "0.9994043", "0.9994112", "0.9994179", "0.9994246", "0.9994311", "0.9994377", "0.9994441", "0.9994505", "0.9994567", "0.999463", "0.9994691", "0.9994752", "0.9994812", "0.9994871", "0.999493", "0.9994988", "0.9995", "0.9995045", "0.9995102", "0.9995158", "0.9995214", "0.9995268", "0.9995323", "0.9995376", "0.9995429", "0.9995481", "0.9995533", "0.9995584", "0.9995635", "0.9995685", "0.9995734", "0.9995783", "0.9995831", "0.9995879", "0.9995926", "0.9995973", "0.9996019", "0.9996064", "0.999611", "0.9996154", "0.9996198", "0.9996242", "0.9996285", "0.9996327", "0.9996369", "0.9996411", "0.9996452", "0.9996492", "0.9996533", "0.9996572", "0.9996612", "0.999665", "0.9996689", "0.9996727", "0.9996764", "0.9996801", "0.9996838", "0.9996874", "0.999691", "0.9996945", "0.999698", "0.9997015", "0.9997049", "0.9997083", "0.9997116", "0.9997149", "0.9997182", "0.9997214", "0.9997246", "0.9997277", "0.9997308", "0.9997339", "0.999737", "0.99974", "0.999743", "0.9997459", "0.9997488", "0.9997517", "0.9997545", "0.9997573", "0.9997601", "0.9997629", "0.9997656", "0.9997683", "0.9997709", "0.9997735", "0.9997761", "0.9997787", "0.9997812", "0.9997837", "0.9997862", "0.9997887", "0.9997911", "0.9997935", "0.9997958", "0.9997982", "0.9998005", "0.9998028", "0.999805", "0.9998072", "0.9998095", "0.9998116", "0.9998138", "0.9998159", "0.999818", "0.9998201", "0.9998222", "0.9998242", "0.9998262", "0.9998282", "0.9998302", "0.9998321", "0.999834", "0.9998359", "0.9998378", "0.9998397", "0.9998415", "0.9998433", "0.9998451", "0.9998469", "0.9998486", "0.9998504", "0.9998521", "0.9998538", "0.9998555", "0.9998571", "0.9998587", "0.9998604", "0.999862", "0.9998635", "0.9998651", "0.9998666", "0.9998682", "0.9998697", "0.9998712", "0.9998726", "0.9998741", "0.9998755", "0.999877", "0.9998784", "0.9998798", "0.9998811", "0.9998825", "0.9998839", "0.9998852", "0.9998865", "0.9998878", "0.9998891", "0.9998904", "0.9998916", "0.9998928", "0.9998941", "0.9998953", "0.9998965", "0.9998977", "0.9998988", "0.9999", "0.9999011", "0.9999023", "0.9999034", "0.9999045", "0.9999056", "0.9999067", "0.9999077", "0.9999088", "0.9999098", "0.9999109", "0.9999119", "0.9999129", "0.9999139", "0.9999149", "0.9999159", "0.9999168", "0.9999178", "0.9999187", "0.9999196", "0.9999206", "0.9999215", "0.9999224", "0.9999233", "0.9999241", "0.999925", "0.9999259", "0.9999267", "0.9999276", "0.9999284", "0.9999292", "0.99993", "0.9999308", "0.9999316", "0.9999324", "0.9999332", "0.9999339", "0.9999347", "0.9999354", "0.9999362", "0.9999369", "0.9999376", "0.9999383", "0.999939", "0.9999397", "0.9999404", "0.9999411", "0.9999418", "0.9999425", "0.9999431", "0.9999438", "0.9999444", "0.999945", "0.9999457", "0.9999463", "0.9999469", "0.9999475", "0.9999481", "0.9999487", "0.9999493", "0.9999499", "0.9999505", "0.999951", "0.9999516", "0.9999521", "0.9999527", "0.9999532", "0.9999538", "0.9999543", "0.9999548", "0.9999553", "0.9999558", "0.9999563", "0.9999568", "0.9999573", "0.9999578", "0.9999583", "0.9999588", "0.9999593", "0.9999597", "0.9999602", "0.9999606", "0.9999611", "0.9999615", "0.999962", "0.9999624", "0.9999628", "0.9999633", "0.9999637", "0.9999641", "0.9999645", "0.9999649", "0.9999653", "0.9999657", "0.9999661", "0.9999665", "0.9999669", "0.9999673", "0.9999676", "0.999968", "0.9999684", "0.9999687", "0.9999691", "0.9999695", "0.9999698", "0.9999701", "0.9999705", "0.9999708", "0.9999712", "0.9999715", "0.9999718", "0.9999721", "0.9999725", "0.9999728", "0.9999731", "0.9999734", "0.9999737", "0.999974", "0.9999743", "0.9999746", "0.9999749", "0.9999752", "0.9999755", "0.9999757", "0.999976", "0.9999763", "0.9999766", "0.9999768", "0.9999771", "0.9999774", "0.9999776", "0.9999779", "0.9999781", "0.9999784", "0.9999786", "0.9999789", "0.9999791", "0.9999793", "0.9999796", "0.9999798", "0.99998", "0.9999803", "0.9999805", "0.9999807", "0.9999809", "0.9999812", "0.9999814", "0.9999816", "0.9999818", "0.999982", "0.9999822", "0.9999824", "0.9999826", "0.9999828", "0.999983", "0.9999832", "0.9999834", "0.9999836", "0.9999838", "0.999984", "0.9999842", "0.9999843", "0.9999845", "0.9999847", "0.9999849", "0.999985", "0.9999852", "0.9999854", "0.9999855", "0.9999857", "0.9999859", "0.999986", "0.9999862", "0.9999864", "0.9999865", "0.9999867", "0.9999868", "0.999987", "0.9999871", "0.9999873", "0.9999874", "0.9999876", "0.9999877", "0.9999878", "0.999988", "0.9999881", "0.9999883", "0.9999884", "0.9999885", "0.9999886", "0.9999888", "0.9999889", "0.999989", "0.9999892", "0.9999893", "0.9999894", "0.9999895", "0.9999896", "0.9999898", "0.9999899", "0.99999"), class = "data.frame") } ################################################################################ fBasics/R/dist-hyp.R0000644000176200001440000001342713202116742013716 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dhyp Returns density for hyperbolic DF # phyp Returns probability for hyperbolic DF # qhyp Returns quantiles for hyperbolic DF # rhyp Returns random variates for hyperbolic DF ################################################################################ dhyp <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns Hyperbolic Density Function PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameters: if (length(alpha) == 4) { mu = alpha[4] delta = alpha[3] beta = alpha[2] alpha = alpha[1] } # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Settings: pm = match.arg(pm) # Density: ans = NA if (pm == 1) ans = .dhyp1(x, alpha, beta, delta, mu) if (pm == 2) ans = .dhyp2(x, alpha, beta, delta, mu) if (pm == 3) ans = .dhyp3(x, alpha, beta, delta, mu) if (pm == 4) ans = .dhyp4(x, alpha, beta, delta, mu) # Log: if (log) ans = log(ans) # Return value: ans } # ------------------------------------------------------------------------------ phyp <- function(q, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), ...) { # A function implemented by Diethelm Wuertz # Description: # Return cumulative probability of Hyperbolic PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Settings: pm = match.arg(pm) # Return Value: ans = NA if (pm == 1) return(.phyp1(q, alpha, beta, delta, mu, ...)) if (pm == 2) return(.phyp2(q, alpha, beta, delta, mu, ...)) if (pm == 3) return(.phyp3(q, alpha, beta, delta, mu, ...)) if (pm == 4) return(.phyp4(q, alpha, beta, delta, mu, ...)) } # ------------------------------------------------------------------------------ qhyp <- function(p, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), ...) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of Hyperbolic PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # Note: # This procedure will not run under Splus. # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Settings: pm = match.arg(pm) # Return Value: ans = NA if (pm == 1) return(.qhyp1(p, alpha, beta, delta, mu, ...)) if (pm == 2) return(.qhyp2(p, alpha, beta, delta, mu, ...)) if (pm == 3) return(.qhyp3(p, alpha, beta, delta, mu, ...)) if (pm == 4) return(.qhyp4(p, alpha, beta, delta, mu, ...)) } # ------------------------------------------------------------------------------ rhyp <- function(n, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4")) { # A function implemented by Diethelm Wuertz # Description: # Returns random deviates of Hyperbolic PDF # Arguments: # n - number of random deviates to be generated # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # Notes: # I have removed my original Fortran program and replaced it by # the dhyperb() function from the HyperbolicDist Package, written # by David Scott, Ai-Wei Lee, Jennifer Tso, Richard Trendall. # License: GPL # FUNCTION: # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Settings: pm = match.arg(pm) # Result: ans = NA if (pm == 1) ans = .rhyp1(n, alpha, beta, delta, mu) if (pm == 2) ans = .rhyp2(n, alpha, beta, delta, mu) if (pm == 3) ans = .rhyp3(n, alpha, beta, delta, mu) if (pm == 4) ans = .rhyp4(n, alpha, beta, delta, mu) # Attributes: attr(ans, "control") = c(dist = "hyp", alpha = alpha, beta = beta, delta = delta, mu = mu) # Return Value: ans } ################################################################################ fBasics/R/gui-stableSlider.R0000644000176200001440000000667513202116741015362 0ustar liggesusers # This R package is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This R package is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: STABLE SLIDERS: # stableSlider Displays stable distribution function ################################################################################ stableSlider <- function(col= "steelblue", col.med = "gray30") { # A function implemented by Diethelm Wuertz # Description: # Displays the stable distribution # FUNCTION: # Internal Function: refresh.code <- function(...) { # Sliders: N = .sliderMenu(no = 1) alpha = .sliderMenu(no = 2) beta = .sliderMenu(no = 3) gamma = .sliderMenu(no = 4) delta = .sliderMenu(no = 5) pm = .sliderMenu(no = 6) # Compute Data: x.rng <- round( stabledist::qstable(c(1,99)/100, alpha, beta, gamma, delta, pm), digits = 2) xmin <- x.rng[1]; xmax <- x.rng[2] s = seq(xmin, xmax, length = N) f = stabledist::dstable(s, alpha, beta, gamma, delta, pm) F = stabledist::pstable(s, alpha, beta, gamma, delta, pm) med <- stabledist::qstable(0.5, alpha, beta, gamma, delta, pm) main1 <- paste("Stable Density\n", "alpha = ", as.character(alpha), " | ", "beta = ", as.character(beta), " | ", "gamma = ", as.character(gamma), " | ", "delta = ", as.character(delta)) main2 <- paste("Stable Probability\n", "xmin [ 1%] = ", as.character(xmin), " | ", "xmax [99%] = ", as.character(xmax), " | ", "pm = ", as.character(pm)) # Frame: op <- par(mfrow = c(2, 1), cex = 0.7) ; on.exit(par(op)) # Density: plot(s, f, type = "l", main = main1, xlim = x.rng, col = col) abline (h = 0, lty = 3) # Probability: plot(s, F, type = "l", xlim = x.rng, ylim = c(0, 1), col = col, main = main2) abline(h = 0:1, lty = 3) lines(c(par("usr")[1],med,med), c(0.5 ,0.5, 0), lty = 2, col=col.med) text(med, 0.1, "median", adj=0, col=col.med) axis(1, labels=expression(delta), at = delta, col = "red", col.axis="red", lwd=1.5, line = .5, tck = 1/8, hadj = -1, padj = -4) } # Open Slider Menu: .sliderMenu(refresh.code, names = c("no. points", "alpha","beta","gamma","delta", "pm"), minima = c( 50, 0. , -1. , 0. , -5. , 0), maxima = c( 1000, 2. , +1. , 5. , +5. , 2), resolutions = c( 50, 0.1, 0.1, 0.5, 0.5, 1), starts = c( 50, 1.8, 0. , 1. , 0. , 0)) } ################################################################################ fBasics/R/plot.R0000644000176200001440000002661213202116742013133 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: INTERNAL USED PLOT FUNCTIONS: # .residualsPlot Returns a residual series plot # .acfPlot Returns a autocorrelation function plot # .pacfPlot Returns a partial ACF plot # .mrlPlot Returns a mean residual life plot # FUNCTION: INTERNAL USED BIVARIATE PLOT FUNCTIONS: # .responsesPlot Returns a response series plot # .firePlot Returns a fitted values vs.residuals plot # FUNCTION: INTERNAL THREE-DIMENSIONAL PLOT UTILITIES: # .circlesPlot Returns a circles plot indexing 3rd variable # .perspPlot Returns a perspective plot in 2 dimensions # .contourPlot Returns a contour plot in 2 dimensions # .histStack Returns a stacked histogram plot ################################################################################ .residualsPlot <- function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns time series graph of residuals # Arguments: # x - an univariate time series of residuals # FUNCTION: # Get Data: x = as.vector(x) # Plot: plot(x, type = "l", ylab = "Residuals", main = "Residual Series", col = "steelblue", ...) rug(x, ticksize = 0.01, side = 4) grid() abline(h = 0, col = "grey") # Return Value: invisible() } # ------------------------------------------------------------------------------ .acfPlot <- function(x, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Convert Type: x = as.vector(x) # ACF: acf(x, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ .pacfPlot <- function(x, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Convert Type: x = as.vector(x) # ACF: pacf(x, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ .mrlPlot <- function(x, ci = 0.95, umin = mean(x), umax = max(x), nint = 100, doplot = TRUE, plottype = c("autoscale", ""), labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Create a mean residual life plot with # confidence intervals. # References: # A function originally written by S. Coles # FUNCTION: # Convert Type: x = as.vector(x) # Settings: plottype = plottype[1] # Convert x to a vector, if the input is a data.frame. if (is.data.frame(x)) x = x[,1] sx = xu = xl = rep(NA, nint) u = seq(umin, umax, length = nint) for (i in 1:nint) { x = x[x >= u[i]] sx[i] = mean(x - u[i]) sdev = sqrt(var(x)) n = length(x) xu[i] = sx[i] + (qnorm((1 + ci)/2) * sdev) / sqrt(n) xl[i] = sx[i] - (qnorm((1 + ci)/2) * sdev) / sqrt(n) } # Plot: if (doplot) { if (labels) { xlab = "Threshold: u" ylab = "Mean Excess: e" main = "Mean Residual Live Plot" } else { main = xlab = ylab = "" } if (plottype == "autoscale") { ylim = c(min(xl[!is.na(xl)]), max(xu[!is.na(xu)])) plot(u, sx, type = "o", pch = 19, col = "steelblue", xlab = xlab, ylab = ylab, ylim = ylim, main = main, ...) } else { plot(u[!is.na(xl)], sx[!is.na(xl)], type = "o", pch = 19, col = "steelblue", xlab = xlab, ylab = ylab, main = main, ...) } lines(u[!is.na(xl)], xl[!is.na(xl)], col = "brown") lines(u[!is.na(xu)], xu[!is.na(xu)], col = "brown") if (labels) { grid() text = paste("ci =", as.character(round(ci, 3))) mtext(text, side = 4, adj = 0, cex = 0.7) } } # Result result = data.frame(threshold = u, mrl = sx) # Return Value: if (doplot) return(invisible(result)) else return(result) } ################################################################################ .responsesPlot <- function(x, y = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns time series graph of responses and fitted values # Arguments: # x - an univariate time series of responses # y - an univariate time series of fitted values # FUNCTION: # Get Data: x = as.vector(x) y = as.vector(y) # Responses Plot: plot(x, type = "l", ylab = "Responses", main = "Responses & Fitted Values", col = "steelblue", ...) rug(x, ticksize = 0.01, side = 4) grid() abline(h = 0, col = "grey") # Add fitted values: if (!is.null(y)) points(y, pch = 19, col = "red") # Return Value: invisible() } # ------------------------------------------------------------------------------ .firePlot <- function(x, y, method = c("scatter", "hist"), ...) { # A function implemented by Diethelm Wuertz # Description: # Returns fitted values vs. residuals plots # Arguments: # x - univariate time series (residuals) # y - univariate time series (fitted) # FUNCTION: # Check Arguments: method = match.arg(method) # Get Data: x = as.vector(x) y = as.vector(y) if (method == "scatter") { # Scatter Plot: plot(x, y, xlab = "Fitted Values", ylab = "Residuals", main = "Residuals vs Fitted", pch = 19, col = "steelblue") panel.smooth(x, y) abline(h = 0, lty = 3, col = "grey") rug(x, ticksize = 0.01, side = 3) rug(y, ticksize = 0.01, side = 4) } else if (method == "hist") { # Histogram Plot: # Save default, for resetting ... def.par = par(no.readonly = TRUE) # Layout: nf = layout(matrix(c(2, 0, 1, 3), 2, 2, byrow = TRUE), c(3, 1), c(1, 3), TRUE) # Scatterplot: par(mar = c(3 ,3, 1, 1)) plot(x, y, xlim = range(x), ylim = range(y), xlab = "", ylab = "", pch = 19, col = "steelblue") panel.smooth(x, y) abline(h = 0, lty = 3, col = "grey") rug(x, side = 3) rug(y, side = 4) # Histogram: xhist = hist(x, nclass = 15, plot = FALSE) yhist = hist(y, nclass = 15, plot = FALSE) top = max(c(xhist$counts, yhist$counts)) # X-Side: par(mar = c(0, 3, 1, 1)) Main = "\n Fitted" barplot(xhist$counts, axes = FALSE, ylim = c(0, top), space = 0, col = "steelblue", border = "white", main = Main) abline(h = 0, lwd = 2, col = "grey") # Y-Side: par(mar = c(3, 0, 1, 1)) barplot(yhist$counts, axes = FALSE, xlim = c(0, top), space = 0, col = "steelblue", , border = "white", horiz = TRUE, main = "Residuals") abline(v = 0, lwd = 2, col = "grey") # Reset: par(def.par) } # Return Value: invisible() } ################################################################################ .circlesPlot <- function(x, y = NULL, z = NULL, scale = 1, points = TRUE, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Creates a scatterplot with circle size as third variable # Example: # circlesPlot(x=rnorm(50), y=rnorm(50), z=rnorm(50)) # circlesPlot(x=rnorm(50), y=rnorm(50), z=rnorm(50), labels= FALSE) # FUNCTION: # Transfor Input: if (is.list(x)) x = matrix(unlist(x), ncol = 3) if (is.data.frame(x)) x = as.matrix.data.frame(x) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } nX = length(x) nY = length(y) # nZ = length(z) stopifnot(nX == nY) # stopifnot(nX == nZ || nX*nY == nZ) # Create Circle Plot: if (labels) { plot(x, y, type = "n") } else { plot(x, y, xlab = "", ylab = "", type = "n") } symbols(x, y, add = TRUE, circles = abs(z)^scale, inches = 0.25, fg = "black", bg = "steelblue", ...) X = x[z < 0] Y = y[z < 0] Z = z[z < 0] symbols(X, Y, add = TRUE, circles = abs(Z)^scale, inches = 0.25, fg = "black", bg = "orange", ...) if (points) points(x, y, pch = 19) grid() # Return Value: invisible(NULL) } # ------------------------------------------------------------------------------ .perspPlot <- function(x, y, z, theta = -40, phi = 30, col = "steelblue", ps = 9, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns a perspecvtive plot # Notes: # A synonyme call for function 'persp' # FUNCTION: # Perspective Plot: if (class(version) == "Sversion") { # we assume SPlus: ans = persp(x = x, y = y, z = z, ...) } else { # R: par(ps = ps) if (!exists("ticktype")) ticktype = "detailed" if (!exists("expand")) expand = 0.6 if (!exists("r")) r = 500 ans = persp(x = x, y = y, z = z, theta = theta, phi = phi, col = col, ticktype = ticktype, expand = expand, ...) } # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ .contourPlot <- function(x, y, z, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns a contour plot # Notes: # A synonyme call for function 'contour' # FUNCTION: # Contour Plot: if (class(version) == "Sversion") { # we assume SPlus: ans = contour(x = x, y = y, z = z, ...) } else { # R: ans = contour(x = x, y = y, z = z, ...) } # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ .histStack <- function(x, y = NULL, space = 0, ylab = "frequency", ...) { # A function implemented by Diethelm Wuertz # Description: # Returns a stacked histogram Plot # Example: # .histStack(rnorm(1000, -1), rnorm(1000, 1)) # FUNCTION: # Compute Histograms: breaks = hist(c(x, y))$breaks bars = rbind( hist(x, breaks = breaks, plot = FALSE)$counts, hist(y, breaks = breaks, plot = FALSE)$counts) # Plot: barplot(bars, space = space, ylab = ylab, ...) at = seq(along = breaks) - 1 modulo = ceiling(length(at)/10) sel = (at%%modulo == 0) axis(side = 1, at = at[sel], labels = paste(breaks)[sel]) # Return Value: invisible() } ################################################################################ fBasics/R/utils-hessian.R0000644000176200001440000000516613202116742014746 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # tsHessian Computes Two Sided Hessian matrix ################################################################################ tsHessian <- function(x, fun, ...) { # Description: # Computes two sided (TS) approximated Hessian # Source: # A function borrowed from Kevin Sheppard's Matlab garch toolbox # as implemented by Alexios Ghalanos in his rgarch package # Notes: # optionally requires package Matrix (added as suggestion) # FUNCTION: # Settings: n = length(x) fx <- fun(x, ...) eps = .Machine$double.eps # Compute the stepsize: h = eps^(1/3) * apply( as.data.frame(x), 1, FUN = function(z) max(abs(z), 1.0e-2)) xh = x + h h = xh - x ee = diag(h) # Matrix(diag(h), sparse = TRUE) # Compute forward and backward steps: gp = vector(mode = "numeric", length = n) for(i in 1:n) gp[i] <- fun(x + ee[, i], ...) gm = vector(mode = "numeric", length = n) for(i in 1:n) gm[i] <- fun(x - ee[, i], ...) H = h %*% t(h) Hm = H Hp = H # Compute double forward and backward steps: for(i in 1:n){ for(j in i:n){ Hp[i, j] <- fun(x + ee[, i] + ee[, j], ...) Hp[j, i] <- Hp[i, j] Hm[i, j] <- fun(x - ee[, i] - ee[, j], ...) Hm[j, i] <- Hm[i, j] } } # Compute the Hessian: for(i in 1:n){ for(j in i:n){ H[i, j] = ((Hp[i, j] - gp[i] - gp[j] + fx + fx - gm[i] - gm[j] + Hm[i, j]) / H[i, j]) / 2 H[j, i] = H[i, j] } } # Return Value: return(H) } ################################################################################ fBasics/R/builtin-ssdenGss.R0000644000176200001440000000173013202116742015404 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ############################################################################### ##.ssden <- gss::ssden ##.pssden <- gss::pssden ##.qssden <- gss::qssden ##.dssden <- gss::dssden ############################################################################### fBasics/R/utils-unitrootNA.R0000644000176200001440000000471013202116741015407 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .unirootNA Computes zero of a function without error exit ################################################################################ .unirootNA <- function(f, interval, lower = min(interval), upper = max(interval), tol = .Machine$double.eps^0.25, ...) { # A function implemented by Diethelm Wuertz # Description: # Searches the interval from lower to upper for a # root (i.e., zero) of the function f with respect # to its first argument. # Arguments: # see 'uniroot' # Value: # Returns the x value of f where the root is located. If # now root exists NA will be returned. In the last case # the function doesn't terminate with an error like in the # case of the standard function uniroot. # Details: # R: # uniroot(f, interval, lower = min(interval), upper = max(interval), # tol = .Machine$double.eps^0.25, # maxiter = 1000, ...) # uniroot(f, interval, lower = min(interval), upper = max(interval), # tol = .Machine$double.eps^.25, # keep.xy = F, f.lower = NA, f.upper = NA, ...) # Example: # .unirootNA(sin, c(1, 2)); .unirootNA(sin, c(-1, 1)) # FUNCTION: # There is no Root: if (is.null(args(f))) { if (f(lower) * f(upper) >=0) return(NA) } else { if (f(lower, ...) * f(upper, ...) >= 0) return(NA) } # There is a Root: ans = uniroot(f = f, interval = interval, lower = lower, upper = upper, tol = tol, ...) # Return Value: ans$root } ################################################################################ fBasics/R/matrix-hilbert.R0000644000176200001440000000252013202116741015077 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # GENERATION: DESCRIPTION: # hilbert Creates a Hilbert matrix ################################################################################ hilbert <- function(n) { # A function implemented by Diethelm Wuertz # Description: # Creates a Hilbert matrix # Arguments: # n - the dimension of the square matrix # FUNCTION: # Hilbert: i = 1:n X = 1 / outer(i - 1, i, "+") # Return Value: X } ################################################################################ fBasics/R/utils-baseMethods.R0000644000176200001440000002742313202116742015552 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: BASIC EXTENSIONS: # align aligns time series objects by approximation # align.default align default method # atoms Extracts atoms from 'timeSeries' object # atoms.default atoms default method # attach attach a database to the R path # attach.default attach default method # colnames<- colnames<- has become a generic function # colnames<-.default colnames<- default method # cor cor has become a generic function # cor.default cor default method # cov var has become a generic function # cov.default var default method # log log has become a generic function # log.default log default method # outlier outlier added generic function # outlier.default outlier default method # rownames<- rownames<- has become a generic function # rownames<-.default rownames<- default method # rank rank has become a generic function # rank.default rank default method # sample sample has become a generic function # sample.default sample default method # sort sort has become a generic function # sort.default sort default method # stdev stdev added generic function # stdev.default stdev default method # termPlot termPlot has become a generic function # termPlot.default termPlot default method # var var has become a generic function # var.default var default method # volatility volatility has become a generic function # volatility.default volatility default method ################################################################################ ## It is bad practice to create S3 generic from function especially ## when one wants to use S4 methods -> this can lead to tricky dispatch ## problems. ## .conflicts.OK = TRUE # ------------------------------------------------------------------------------ ## align <- ## function(x, y, xout, ...) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("align") ## } ## # ------------------------------------------------------------------------------ ## align.default <- ## function(x, y, xout, method = "linear", n = 50, rule = 1, f = 0, ## ties = mean, ...) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Align by Approximation: ## ans = approx(x = x, y = y, xout = xout, method = method, n = n, ## rule = rule, f = f, ties = ties, ...) ## # Return Value: ## ans ## } # ------------------------------------------------------------------------------ ## atoms <- ## function(x, ...) ## { ## # A function implemented by Diethelm WUertz ## # FUNCTION: ## # Return Value: ## UseMethod("atoms") ## } ## # ------------------------------------------------------------------------------ ## atoms.default <- ## function(x, ...) ## { ## # A function implemented by Diethelm WUertz ## # FUNCTION: ## # Return Value: ## invisible(x) ## } # ------------------------------------------------------------------------------ ## attach <- ## function(what, pos = 2, name = deparse(substitute(what)), ## warn.conflicts = TRUE) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("attach") ## } ## # ------------------------------------------------------------------------------ ## attach.default <- base::attach # ------------------------------------------------------------------------------ ## "colnames<-" = ## function(x, value) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("colnames<-") ## } ## # ------------------------------------------------------------------------------ ## `colnames<-.default` <- base::`colnames<-` # ------------------------------------------------------------------------------ ## cor <- ## function(x, y = NULL, use = "all.obs", ## method = c("pearson", "kendall", "spearman")) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("cor") ## } # ------------------------------------------------------------------------------ ## cor.default <- stats::cor ## # ------------------------------------------------------------------------------ ## cov <- ## function(x, y = NULL, use = "all.obs", ## method = c("pearson", "kendall", "spearman")) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("cov") ## } ## # ------------------------------------------------------------------------------ ## cov.default <- stats::cov ## # ------------------------------------------------------------------------------ ## log <- ## function(x, base = exp(1)) ## { # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("log") ## } ## # ------------------------------------------------------------------------------ ## log.default <- ## function(x, base = exp(1)) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## base::log(x, base) ## } # ------------------------------------------------------------------------------ ## rank <- ## function(x, na.last = TRUE, ## ties.method = c("average", "first", "random", "max", "min")) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("rank") ## } # ------------------------------------------------------------------------------ ## rank.default <- ## function(x, na.last = TRUE, ## ties.method = c("average", "first", "random", "max", "min")) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## base::rank(x, na.last = na.last, ties.method = ties.method) ## } # ------------------------------------------------------------------------------ ## sample <- ## function(x, ...) ## { # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("sample") ## } ## # ------------------------------------------------------------------------------ ## sample.default <- ## function(x, size, replace = FALSE, prob = NULL, ...) ## { ## # FUNCTION: ## base::sample(x, size, replace = replace, prob = prob) ## } # ------------------------------------------------------------------------------ ## if(getRversion() < "2.4.0") { ## # Note: ## # sort() has been S3 generic in 'base' since 2.4.0 ## # Otherwise use something that works here ## sort <- function(x, decreasing = FALSE, ...) ## { ## if (!is.logical(decreasing) || length(decreasing) != 1) ## stop("'decreasing' must be a length-1 logical vector.\nDid you intend to set 'partial'?") ## UseMethod("sort") ## } ## sort.default <- function(x, decreasing = FALSE, ...) { ## if (is.object(x)) ## x[order(x, decreasing = decreasing)] ## else base::sort(x, decreasing = decreasing, ...) ## } ## }# endif {only for outdated R} # ------------------------------------------------------------------------------ ## outlier <- ## function(x, sd = 5, complement = TRUE, ...) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## UseMethod("outlier") ## } # ------------------------------------------------------------------------------ ## outlier.default <- ## function(x, sd = 5, complement = TRUE, ...) ## { ## # A function implemented by Diethelm Wuertz ## # Description: ## # Returns outliers ## # Arguments: ## # x - a numeric vector ## # sd - a numeric value of standard deviations, e.g. 5 ## # means that values larger or smaller tahn five ## # times the standard deviation of the series will ## # be detected. ## # complement - a logical flag, should the outlier series ## # or its complements be returned. ## # Note: ## # This function is thought to find splits in financial ## # price or index data. If a price or index is splitted we ## # observe in the returns a big jump of several standard ## # deviations. ## # FUNCTION: ## # Find Outliers: ## SD = sd * sd(x) ## if (complement) { ## ans = x[x <= SD] ## } else { ## ans = x[x > SD] ## names(ans) = as.character(which(x > SD)) ## } ## # Return Value: ## ans ## } # ------------------------------------------------------------------------------ ## "rownames<-" = ## function(x, value) ## { # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("rownames<-") ## } ## # ------------------------------------------------------------------------------ ## `rownames<-.default` <- base::`rownames<-` # ------------------------------------------------------------------------------ stdev.default <- function(x, na.rm = FALSE) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: stats::sd(x = x, na.rm = na.rm) } # ------------------------------------------------------------------------------ stdev <- function(x, na.rm = FALSE) UseMethod("stdev") # ------------------------------------------------------------------------------ termPlot <- function(model, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: UseMethod("termPlot") } # ------------------------------------------------------------------------------ termPlot.default <- function(model, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: stats::termplot(model, ...) } # ------------------------------------------------------------------------------ ## var <- ## function(x, y = NULL, na.rm = FALSE, use) ## { ## # A function implemented by Diethelm Wuertz ## # FUNCTION: ## # Return Value: ## UseMethod("var") ## } ## # ------------------------------------------------------------------------------ ## var.default <- stats::var # ------------------------------------------------------------------------------ volatility <- function(object, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: UseMethod("volatility") } # ------------------------------------------------------------------------------ volatility.default <- function(object, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Compute volatility: x = object ans = (x - mean(x))^2 # Return Value: ans } ################################################################################ fBasics/R/dist-gldFit.R0000644000176200001440000004761013202116742014330 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # gldFit Fits parameters of a GLD # .gldFit.mle Fits parameters of a GLD using maximum log-likelihood # .gldFit.mps Fits parameters of a GLD using maximum product spacings # .gldFit.gof Fits parameters of a GLD using GoF Statistics # .ksGLD Kolmogorov Smirnov Statistics # .cvmGLD Cramer von Mise Statistics # .adGLD Anderson Darling Statistics # .gldFit.hist Fits parameters of a GLD using a histogram fit # type="fd" Freedman-Diaconis binning # type="scott" Scott binning # type="sturges" Sturges binning # .gldFit.rob Fits parameters of a GLD using robust moments fit ################################################################################ gldFit <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, method = c("mle", "mps", "gof", "hist", "rob"), scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using maximum log-likelihood # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Note: # The GLD uses RS parameterization and parameters in Region 4, # i.e. lambda[3,4]<0, lambda2<0 # FUNCTION: # Check Parameters: stopifnot(lambda2 < 0) stopifnot(lambda3 < 0) stopifnot(lambda4 < 0) # Settings: method = match.arg(method) # Parameter Fit: if (method == "mle") { ans = .gldFit.mle(x, lambda1, lambda2, lambda3, lambda4, scale, doplot, add, span, trace, title, description, ...) } else if (method == "mps") { ans = .gldFit.mps(x, lambda1, lambda2, lambda3, lambda4, scale, doplot, add, span, trace, title, description, ...) } else if (method == "gof") { ans = .gldFit.gof(x, lambda1, lambda2, lambda3, lambda4, scale, doplot, add, span, trace, title, description, ...) } else if (method == "hist") { ans = .gldFit.hist(x, lambda1, lambda2, lambda3, lambda4, scale, doplot, add, span, trace, title, description, ...) } else if (method == "rob") { ans = .gldFit.rob (x, lambda1, lambda2, lambda3, lambda4, scale, doplot, add, span, trace, title, description, ...) } # Return Value: ans } # ------------------------------------------------------------------------------ .gldFit.mle <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using maximum log-likelihood # Example: # set.seed(4711); x=rgld(5000); fit=gldFit.mle(x)@fit$estimate; fit # FUNCTION: # Settings: scale = FALSE # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Objective Function: obj <- function(x, y = x, trace) { DGLD = try(dgld(y, x[1], x[2], x[3], x[4]), silent = TRUE) if (class(DGLD) == "try-error") return(1e9) f = -sum(log(DGLD)) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 100 r = nlminb( start = c(lambda1, lambda2, lambda3, lambda4), objective = obj, lower = c(-BIG, -BIG, -BIG, -BIG), upper = c(+BIG, -eps, -eps, -eps), y = x, trace = trace) names(r$par) <- c("lambda1", "lambda2", "lambda3", "lambda4") # Add Title and Description: if (is.null(title)) title = "GLD Region 4 Parameter Estimation" if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dgld(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), ...) } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "GLD Region 4 Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .gldFit.mps <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, type = c("sum", "mean", "max", "median", "var"), scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using maximum product spacings # Example: # set.seed(4711); x=rgld(5000); fit=.gldFit.mps(x)@fit$estimate; fit # FUNCTION: # Settings: scale = FALSE type = match.arg(type) CALL = match.call() # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Objective Function: TYPE = toupper(type) if(type == "sum") { typeFun = sum } else if (type == "mean") { typeFun = mean } else if (type == "median") { typeFun = median } else if (type == "max") { typeFun = function(x) -max(x) } else if (type == "var") { typeFun = function(x) -var(x) } obj = function(x, y = x, typeFun, trace) { PGLD = try(pgld(sort(y), x[1], x[2], x[3], x[4]), silent = TRUE) if (class(PGLD) == "try-error") return(1e9) DH = diff(c(0, na.omit(PGLD), 1)) f = try(-typeFun(log(DH[DH > 0])), silent = TRUE) if (class(PGLD) == "try-error") return(1e9) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 100 r = nlminb( start = c(lambda1, lambda2, lambda3, lambda4), objective = obj, lower = c(-BIG, -BIG, -BIG, -BIG), upper = c(+BIG, -eps, -eps, -eps), y = x, typeFun = typeFun, trace = trace) names(r$par) <- c("lambda1", "lambda2", "lambda3", "lambda4") # Add Title and Description: if (is.null(title)) title = "GLD Region 4 MPS Estimation" if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dgld(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), ...) } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "GLD Region 4 Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .ksGLD <- function(N, PFGL) { D = 1/(2*N) + max ( abs( PFGL - ((1:N)-0.5)/N ) ) D } .cvmGLD <- function(N, PFGL) { W2 = 1/(12*N) + sum ( PFGL - ((1:N)-0.5)/N )^2 W2 } .adGLD <- function(N, PFGL) { A2 = -N -(1/N) * sum( (2*(1:N)-1) * ( log(PFGL) + log(1-rev(PFGL)) ) ) A2 } # ------------------------------------------------------------------------------ .gldFit.gof <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, type = c("ad", "ks", "cvm"), scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using GoF Statistics # Example: # set.seed(4711); x=rgld(5000); fit=.gldFit.gof(x)@fit$estimate; fit # FUNCTION: # Settings: scale = FALSE type = match.arg(type) CALL = match.call() # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Objective Function: TYPE = toupper(type) ## DJS 20/02/2010 ## typeFun <- match.fun(paste(".", type, sep = "")) typeFun <- match.fun(paste(".", type, "GLD", sep = "")) obj = function(x, y = x, typeFun, trace) { PFGL = try(pgld(sort(y), x[1], x[2], x[3], x[4]), silent = TRUE) if (class(PFGL) == "try-error") return(1e9) PFGL = PFGL[PFGL > 0] PFGL = PFGL[PFGL < 1] N = length(PFGL) f = typeFun(N, PFGL) if (is.na(f)) return(1e9) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4],"\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 100 r = nlminb( start = c(lambda1, lambda2, lambda3, lambda4), objective = obj, lower = c(-BIG, -BIG, -BIG, -BIG), upper = c(+BIG, -eps, -eps, -eps), y = x, typeFun = typeFun, trace = trace) names(r$par) <- c("lambda1", "lambda2", "lambda3", "lambda4") # Add Title and Description: if (is.null(title)) title = paste("GLD Region 4", TYPE, "Estimation") if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dgld(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), ...) } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "GLD Region 4 Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .gldFit.hist <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, type = c("fd", "sturges", "scott"), scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using a histogram fit # Example: # set.seed(4711); x=rgld(5000); fit=gldFit.hist(x)@fit$estimate; fit # FUNCTION: # Settings: scale = FALSE CALL = match.call() type = match.arg(type) if (type == "fd") type = "FD" else if (type == "scott") type = "Scott" else if (type == "sturges") type = "Sturges" # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Histogram: HIST = hist(x, breaks = type, plot = FALSE) # Objective Function: obj = function(x, hist, trace) { DFGL = try(dgld(hist$mids, x[1], x[2], x[3], x[4]), silent = TRUE) if (class(DFGL) == "try-error") return(1e9) DST = (hist$density - DFGL)^2 f = sum(DST) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 100 r = nlminb( start = c(lambda1, lambda2, lambda3, lambda4), objective = obj, lower = c(-BIG, -BIG, -BIG, -BIG), upper = c(+BIG, -eps, -eps, -eps), hist = HIST, trace = trace) names(r$par) <- c("lambda1", "lambda2", "lambda3", "lambda4") # Add Title and Description: if (is.null(title)) title = "GLD Region 4 Histogram Estimation" if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dgld(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), ...) } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "GLD Region 4 Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .gldFit.rob <- function(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, scale = NA, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a GLD using robust moments (quantile) fit # Example: # set.seed(4711); x=rgld(5000); fit=.gldFit.rob(x)@fit$estimate; fit # FUNCTION: # Settings: scale = FALSE # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() xMED = sampleMED(x) xIQR = sampleIQR(x) xSKEW = sampleSKEW(x) xKURT = sampleKURT(x) # Objective Function: obj = function(x, xMED, xIQR, xSKEW, xKURT, trace) { lambda1 = x[1] lambda2 = x[2] lambda3 = x[3] lambda4 = x[4] ROB = try(sqrt( (xMED -gldMED (lambda1, lambda2, lambda3, lambda4))^2 + (xIQR -gldIQR (lambda1, lambda2, lambda3, lambda4))^2 + (xSKEW-gldSKEW(lambda1, lambda2, lambda3, lambda4))^2 + (xKURT-gldKURT(lambda1, lambda2, lambda3, lambda4))^2 ), silent = TRUE) if(class(ROB) == "try-error") return(1e9) f = ROB # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 100 r = nlminb( start = c(lambda1, lambda2, lambda3, lambda4), objective = obj, lower = c(-BIG, -BIG, -BIG, -BIG), upper = c(+BIG, -eps, -eps, -eps), xMED = xMED, xIQR = xIQR, xSKEW = xSKEW, xKURT = xKURT, trace = trace) names(r$par) <- c("lambda1", "lambda2", "lambda3", "lambda4") # Add Title and Description: if (is.null(title)) title = "GLD Region 4 Robust Moment Estimation" if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dgld(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), ...) } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "GLD Region 4 Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } ################################################################################ fBasics/R/dist-ghtMode.R0000644000176200001440000000343113202116742014477 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghtMode Computes the generalized hyperbolic Student-t mode ################################################################################ ghtMode <- function(beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Computes the mode of the Generalized Hyperbolic Student-t PDF # Arguments: # beta - skewness parameter # delta - scale parameter # mu - location parameter # nu - shape parameter # Example: # ghtMode() # FUNCTION: # Find Maximum: min = qght(0.01, beta, delta, mu, nu) max = qght(0.99, beta, delta, mu, nu) ans = optimize(f = dght, interval = c(min, max), beta = beta, delta = delta, mu = mu, nu = nu, maximum = TRUE, tol = .Machine$double.eps)$maximum # Return Value: ans } ################################################################################ fBasics/R/dist-ghRobMoments.R0000644000176200001440000001041113202116742015510 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghMED Returns true gh median # ghIQR Returns true gh inter quartal range # ghSKEW Returns true gh robust skewness # ghKURT Returns true gh robust kurtosis ################################################################################ ghMED <- function(alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh median # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Median Q = qgh(p=0.5, alpha, beta, delta, mu, lambda) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ ghIQR <- function(alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh inter quartal range # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Inter Quartile Range Q = numeric() Q[1] = qgh(p=0.25, alpha, beta, delta, mu, lambda) Q[2] = qgh(p=0.75, alpha, beta, delta, mu, lambda) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ ghSKEW <- function(alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh skewness # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Robust Skewness: Q = numeric() Q[1] = qgh(p=0.25, alpha, beta, delta, mu, lambda) Q[2] = qgh(p=0.50, alpha, beta, delta, mu, lambda) Q[3] = qgh(p=0.75, alpha, beta, delta, mu, lambda) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ ghKURT <- function(alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh kurtosis # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, qgh(p, alpha, beta, delta, mu, lambda)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/plot-subStars.R0000644000176200001440000001054413202116742014734 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: SLIDER MENU: # .subStars Creates a sub stars plot ################################################################################ .subStars <- function(x, keyOffset = c(0, 0), loc = NULL, palette = NULL) { # Description: # Creates a sub stars plot # Details: # this is the stars::graphics() function modified in such a # way, that it works together with the subplot builtin. # FUNCTION: # Palette: if (is.null(palette)) palette = palette(rainbow(12, s = 0.6, v = 0.75)) # Graph Frame: xCol = ncol(x) yCol = nrow(x) NY = NX = ceiling(sqrt(xCol)) if (NX * NY == xCol) NY = NY + 1 if (is.null(loc)) { for (nx in 1:NY) for (ny in 1:NX) loc = rbind(loc, c(nx, ny)) loc = loc[1:xCol, ] loc[, 2] = NY + 1 - loc[, 2] } # Stars - Settings: x = t(x) locations = loc len = 0.4 key.loc = c(NX + 1, 1) + keyOffset xlim = c(1, NX + 0.5) ylim = c(0, NY + 1) op <- par("xpd") on.exit(par(op)) par(xpd = TRUE) labels = dimnames(x)[[1]] key.labels = dimnames(x)[[2]] n.loc <- nrow(x) n.seg <- ncol(x) xloc <- locations[, 1] yloc <- locations[, 2] angles <- seq.int(0, 2 * pi, length.out = n.seg + 1)[-(n.seg + 1)] x <- apply(x, 2, function(x) (x - min(x, na.rm = TRUE))/diff(range(x, na.rm = TRUE))) mx <- max(x <- x * len) if (is.null(xlim)) xlim <- range(xloc) + c(-mx, mx) if (is.null(ylim)) ylim <- range(yloc) + c(-mx, mx) deg <- pi/180 plot(0, type = "n", xlim = xlim, ylim = ylim, main = "", sub = "", xlab = "", ylab = "", asp = 1, axes = FALSE) s.x <- xloc + x * rep.int(cos(angles), rep.int(n.loc, n.seg)) s.y <- yloc + x * rep.int(sin(angles), rep.int(n.loc, n.seg)) aangl <- c(angles, if (TRUE) 2 * pi else pi) for (i in 1:n.loc) { px <- py <- numeric() for (j in 1:n.seg) { k <- seq.int(from = aangl[j], to = aangl[j + 1], by = 1 * deg) px <- c(px, xloc[i], s.x[i, j], x[i, j] * cos(k) + xloc[i], NA) py <- c(py, yloc[i], s.y[i, j], x[i, j] * sin(k) + yloc[i], NA) } polygon(px, py, col = 1:n.seg, lwd = 0.25, lty = 1) } text(xloc, yloc - mx + 0.04, labels, cex = 0.7, font = 2, adj = c(0.5, 1)) key.x <- len * cos(angles) + key.loc[1] key.y <- len * sin(angles) + key.loc[2] px <- py <- numeric() for (j in 1:n.seg) { k <- seq.int(from = aangl[j], to = aangl[j + 1], by = 1 * deg) px <- c(px, key.loc[1], key.x[j], len * cos(k) + key.loc[1], NA) py <- c(py, key.loc[2], key.y[j], len * sin(k) + key.loc[2], NA) } polygon(px, py, col = 1:n.seg, lwd = 0.25, lty = 1) lab.angl <- angles + (angles[2] - angles[1])/2 label.x <- 1.15 * len * cos(lab.angl) + key.loc[1] label.y <- 1.15 * len * sin(lab.angl) + key.loc[2] for (k in 1:n.seg) { text.adj <- c(if (lab.angl[k] < 90 * deg || lab.angl[k] > 270 * deg) 0 else if (lab.angl[k] > 90 * deg && lab.angl[k] < 270 * deg) 1 else 0.5, if (lab.angl[k] <= 90 * deg) (1 - lab.angl[k]/(90 * deg))/2 else if (lab.angl[k] <= 270 * deg) (lab.angl[k] - 90 * deg)/(180 * deg) else 1 - (lab.angl[k] - 270 * deg)/(180 * deg)) text(label.x[k], label.y[k], labels = key.labels[k], cex = 0.7, adj = text.adj) } # Return Value: invisible(locations) } ################################################################################ fBasics/R/dist-ghtMoments.R0000644000176200001440000000726413202116741015244 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghtMean Returns true GH Student-t mean # ghtVar Returns true GH Student-t variance # ghtSkew Returns true GH Student-t skewness # ghtKurt Returns true GH Student-t kurtosis # FUNCTION: DESCRIPTION: # ghtMoments Returns true GH Student-t moments ################################################################################ ghtMean <- function(beta=0.1, delta=1, mu=0, nu=10) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true Mean of the GH Student-t distribution # FUNCTION: # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Return Value: ghMean(alpha, beta, delta, mu, lambda) } # ------------------------------------------------------------------------------ ghtVar <- function(beta=0.1, delta=1, mu=0, nu=10) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true variance of the GH Student-t distribution # FUNCTION: # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Return Value: ghVar(alpha, beta, delta, mu, lambda) } # ------------------------------------------------------------------------------ ghtSkew <- function(beta=0.1, delta=1, mu=0, nu=10) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true Skewness of the GH Student-t distribution # FUNCTION: # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Return Value: ghSkew(alpha, beta, delta, mu, lambda) } # ------------------------------------------------------------------------------ ghtKurt <- function(beta=0.1, delta=1, mu=0, nu=10) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true Kurtosis of the GH Student-t distribution # FUNCTION: # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Return Value: ghKurt(alpha, beta, delta, mu, lambda) } ################################################################################ ghtMoments <- function(order, type = c("raw", "central", "mu"), beta=0.1, delta=1, mu=0, nu=10) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns moments of the GH Student-t distribution # FUNCTION: # Settings: type = match.arg(type) # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Return Value: ghMoments(order, type, alpha, beta, delta, mu, lambda) } ################################################################################ fBasics/R/dist-sgh.R0000644000176200001440000001270613202116741013675 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dsgh Returns density of the standardized gh distribution # psgh Returns probabilities of the sgh distribution # qsgh Returns quantiles of the sgh distribution # rsgh Generates sgh distributed random variates # FUNCTION: DESCRIPTION: # .kappaGH Returns modified Bessel function ratio # .deltaKappaGH Returns difference of Bessel function ratios # .paramGH Change parameterization to alpha, beta, delta mu ################################################################################ dsgh <- function(x, zeta = 1, rho = 0, lambda = 1, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density of the sgh distribution # FUNCTION: # Parameters: if (length(zeta) == 3) { lambda = zeta[3] rho = zeta[2] zeta = zeta[1] } # Compute Density: param = .paramGH(zeta, rho, lambda) ans = dgh(x, param[1], param[2], param[3], param[4], lambda, log) # Return Value: ans } # ------------------------------------------------------------------------------ psgh <- function(q, zeta = 1, rho = 0, lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Returns probabilities of the sgh distribution # FUNCTION: # Compute Probabilities: param = .paramGH(zeta, rho, lambda) ans = pgh(q, param[1], param[2], param[3], param[4], lambda) # Return Value: ans } # ------------------------------------------------------------------------------ qsgh <- function(p, zeta = 1, rho = 0, lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of the sgh distribution # FUNCTION: # Compute Quantiles: param = .paramGH(zeta, rho, lambda) ans = qgh(p, param[1], param[2], param[3], param[4], lambda) # Return Value: ans } # ------------------------------------------------------------------------------ rsgh <- function(n, zeta = 1, rho = 0, lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Generates sgh distributed random variates # FUNCTION: # Generate Random Numbers: param = .paramGH(zeta, rho, lambda) ans = rgh(n, param[1], param[2], param[3], param[4], lambda) # Return Value: ans } ################################################################################ .kappaGH <- function(x, lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Returns modified Bessel function ratio # FUNCTION: # Check: stopifnot(x >= 0) stopifnot(length(lambda) == 1) # Ratio: if (lambda == -0.5) { # NIG: kappa = 1/x } else { # GH: kappa = ( besselK(x, lambda+1, expon.scaled = TRUE) / besselK(x, lambda, expon.scaled = TRUE) ) / x } # Return Value: kappa } # ------------------------------------------------------------------------------ .deltaKappaGH <- function(x, lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Returns difference of Bessel functions ratios # FUNCTION: # Difference in Ratios: if (lambda == -0.5) { # NIG: # Replace this with the recursion relation ... deltaKappa = .kappaGH(x, lambda+1) - .kappaGH(x, lambda) } else { # GH: deltaKappa = .kappaGH(x, lambda+1) - .kappaGH(x, lambda) } # Return Value: deltaKappa } ################################################################################ .paramGH <- function(zeta = 1, rho = 0 , lambda = 1) { # A function implemented by Diethelm Wuertz # Description: # Change parameterizations to alpha(zeta, rho, lambda) # FUNCTION: # Transformation: Rho2 = 1 - rho^2 alpha = zeta^2 * .kappaGH(zeta, lambda) / Rho2 alpha = alpha * ( 1 + rho^2 * zeta^2 * .deltaKappaGH(zeta, lambda) / Rho2) alpha = sqrt(alpha) beta = alpha * rho delta = zeta / ( alpha * sqrt(Rho2) ) mu = -beta * delta^2 * .kappaGH(zeta, lambda) # Return Value: c(alpha = alpha, beta = beta, delta = delta, mu = mu) } ################################################################################ fBasics/R/plot-varpie.R0000644000176200001440000001310013202116741014402 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # Function: DESCRIPTION: # .varpiePlot Plots a pie with variable radii # .varpieDemo Creates some demo plots ################################################################################ .varpiePlot <- function(x, radius = 0.8, labels = names(x), edges = 200, clockwise = FALSE, init.angle = if (clockwise) 90 else 0, density = NULL, angle = 45, col = NULL, border = NULL, lty = NULL, main = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Plots a pie with variable radii. # Note: # The idea is given in: # http://addictedtor.free.fr/packages/A2R/lastVersion/R/spieChart.R # Source: # Package: A2R # Type: Package # Title: Romain Francois misc functions # Version: 0.0-4 # Date: 2005-08-05 # Author: Romain Francois # Maintainer: Romain Francois # Description: Some functions of Romain Francois collection # License: GPL version 2 or newer # URL: http://addictedtor.free.fr/packages # FUNCTION: # Pie: if (length(radius) == 1) { # Normal Pie Plot: pie(x =x, labels = labels, edges = edges, radius = radius, clockwise = clockwise, init.angle = init.angle, density = density, angle = angle, col = col, border = border, lty = lty, main = main, ...) } else { # Variable Pie Plot: radius = radius/max(radius) X = x if (!is.numeric(x) || any(is.na(x) | x < 0)) stop("'x' values must be positive.") if (is.null(labels)) { labels = as.character(1:length(x)) } else { labels = as.graphicsAnnot(labels) } x = c(0, cumsum(x)/sum(x)) dx = diff(x) nx = length(dx) plot.new() pin = par("pin") xlim = ylim = c(-1, 1) if (pin[1] > pin[2]) { xlim = (pin[1]/pin[2]) * xlim } else { ylim = (pin[2]/pin[1]) * ylim } plot.window(xlim, ylim, "", asp = 1) if (is.null(col)) col = rainbow(n) if (is.null(border)) border = "darkgrey" col = if (is.null(density)) col else par("fg") pie(x = X, col = "white", lty = NULL, radius = max(radius), border = border, labels = labels, ...) phi = seq(0, 2*pi, length = 361) for (i in 1:length(radius)) lines(radius[i]*cos(phi), radius[i]*sin(phi), col = border) col = rep(col, length.out = nx) border = rep(border, length.out = nx) lty = rep(lty, length.out = nx) angle = rep(angle, length.out = nx) density = rep(density, length.out = nx) twopi = if (clockwise) -2 * pi else 2 * pi t2xy = function(t, i) { t2p = twopi * t + init.angle * pi/180 list(x = radius[i] * cos(t2p), y = radius[i] * sin(t2p)) } for (i in 1:nx) { n = max(2, floor(edges * dx[i])) P = t2xy(seq(x[i], x[i + 1], length = n), i) polygon(c(P$x, 0), c(P$y, 0), density = density[i], angle = angle[i], border = border[i], col = col[i], lty = lty[i]) P = t2xy(mean(x[i + 0:1]), i) # lab = as.character(labels[i]) # if (!is.na(lab) && nchar(lab)) { # lines(c(1, 1.05) * P$x, c(1, 1.05) * P$y, col = "red") # text(1.1 * P$x, 1.1 * P$y, labels[i], xpd = TRUE, # col = "red", adj = ifelse(P$x < 0, 1, 0), ...) } } title(main = main, ...) } # Return Values: invisible(NULL) } # ------------------------------------------------------------------------------ .varpieDemo <- function() { # Description: # Creates some demo plots # FUNCTION: # Demos: par (ask = TRUE) n = 64; phi = seq(0, pi/4, length = n) X = Y = runif(32) .varpiePlot(X, radius = Y, labels = "", border = "white") points(0, 0, pch = 19, cex = 4) n = 32; phi = seq(0, pi/4, length = n) X = abs(cos(phi)); Y = abs(sin(phi)) .varpiePlot(X, radius = Y, labels = "", border = "white") points(0, 0, pch = 19, cex = 4) n = 64; phi = seq(0, pi, length = n) X = abs(cos(phi)); Y = abs(sin(phi)) .varpiePlot(X, radius = Y, labels = "", border = "white", init.angle = -90) points(0, 0, pch = 19, cex = 4) n = 64; phi = seq(0, pi, length = n) X = abs(cos(phi)); Y = abs(sin(phi)) .varpiePlot(X, radius = Y, labels = "", col = heat.colors(n), border = "white", init.angle = -90) points(0, 0, pch = 19, cex = 4) } ################################################################################ fBasics/R/utils-symbolTable.R0000644000176200001440000000344413202116742015566 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # symbolTable Shows a table of plot symbols from a given font ################################################################################ symbolTable <- function(font = par('font'), cex = 0.7) { # A function implemented by Diethelm Wuertz # Description: # Shows a table of plot characters from a given font # Example: # symbolTable() # Author: # Unknown, piece of code found on the internet. # FUNCTION: # Table: plot(0, 0, xlim = c(-1, 11), ylim = c(0, 26), type = 'n', axes = FALSE, xlab = '', ylab = '', main = "Table of Plot Characters") j = -1 for(i in 0:255) { if(i %% 25 == 0) {j = j+1; k = 26} k = k-1 points(j, k, pch = i, font = font, cex = cex, col = 2) text(j + 0.50, k, i, cex = cex) } # Return Value: invisible(font) } ################################################################################ fBasics/R/dist-hypMoments.R0000644000176200001440000000677613202116741015271 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # hypMean Returns true hyperbolic mean # hypVar Returns true hyperbolic variance # hypSkew Returns true hyperbolic skewness # hypKurt Returns true hyperbolic kurtosis # FUNCTION: DESCRIPTION: # hypMoments Returns true hyperbolic moments ################################################################################ hypMean <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true hyperbolic mean # FUNCTION: # Return Value: ghMean(alpha, beta, delta, mu, lambda=1) } # ------------------------------------------------------------------------------ hypVar <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true hyperbolic variance # FUNCTION: # Return Value: ghVar(alpha, beta, delta, mu, lambda=1) } # ------------------------------------------------------------------------------ hypSkew <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true hyperbolic skewness # FUNCTION: # Return Value: ghSkew(alpha, beta, delta, mu, lambda=1) } # ------------------------------------------------------------------------------ hypKurt <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true hyperbolic kurtosis # FUNCTION: # Return Value: ghKurt(alpha, beta, delta, mu, lambda=1) } # ------------------------------------------------------------------------------ hypMoments <- function(order, type = c("raw", "central", "mu"), alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true moments of the hyperbolic distribution # FUNCTION: # Settings: type = match.arg(type) # Moments: lambda = 1 if (type == "raw") { ans = .ghRawMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "central") { ans = .ghCentralMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "central") { ans = .ghMuMoments(order, alpha, beta, delta, mu, lambda) } # Return Value: ans } ################################################################################ fBasics/R/gui-ghSlider.R0000644000176200001440000000632713202116741014500 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghSlider Displays generalized hyperbolic distribution function ################################################################################ ghSlider <- function() { # A function implemented by Diethelm Wuertz # Generalized Hyperbolic Distribution: # dhyp(x, alpha = 1, beta = 0, delta = 1, lamba = 1) # FUNCTION: # Internal Function: refresh.code = function(...) { # Sliders: N = .sliderMenu(no = 1) alpha = .sliderMenu(no = 2) beta = .sliderMenu(no = 3) delta = .sliderMenu(no = 4) mu = .sliderMenu(no = 5) lambda = .sliderMenu(no = 6) # Plot Data: xmin = round(qgh(0.01, alpha, beta, delta, mu, lambda), digits = 2) xmax = round(qgh(0.99, alpha, beta, delta, mu, lambda), digits = 2) s = seq(xmin, xmax, length = N) y1 = dgh(s, alpha, beta, delta, mu, lambda) y2 = pgh(s, alpha, beta, delta, mu, lambda) main1 = paste("GH Density\n", "alpha = ", as.character(alpha), " | ", "beta = ", as.character(beta), " | ", "delta = ", as.character(delta), " | ", "mu = ", as.character(mu), "|", "lambda = ", as.character(lambda) ) main2 = paste("GH Probability\n", "xmin 0.01% = ", as.character(xmin), " | ", "xmax 0.99% = ", as.character(xmax)) # Frame par(mfrow = c(2, 1), cex = 0.7) # Density: plot(s, y1, type = "l", xlim = c(xmin, xmax), col = "steelblue") abline (h = 0, lty = 3) title(main = main1) # Probability: plot(s, y2, type = "l", xlim = c(xmin, xmax), ylim = c(0, 1), col = "steelblue" ) abline(h = 0.0, lty = 3) abline(h = 1.0, lty = 3) abline(h = 0.5, lty = 3) abline(v = mu, lty = 3, col = "red") title(main = main2) # Reset Frame: par(mfrow = c(1, 1), cex = 0.7) } # Open Slider Menu: .sliderMenu(refresh.code, names = c( "N","alpha","beta","delta", "mu","lambda"), minima = c( 50, 0.00, -2.00, 0.00, -5.0, -4), maxima = c(1000, 2.00, +2.00, 5.00, +5.0, 4), resolutions = c( 50, 0.20, 0.20, 1.00, 1.0, 0.5), starts = c( 50, 1.00, 0.00, 1.00, 0.0, 1)) } ################################################################################ fBasics/R/utils-listFunctions.R0000644000176200001440000000475013202116742016156 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # listFunctionss Lists all functions in a package # countFunctions Counts all functions in a package ################################################################################ listFunctions <- function(package, character.only = FALSE) { # A function implemented by Diethelm Wuertz & Yohan Chalabi # Description: # Lists all functions in a package # Arguments: # package - a character string, the name of the Package # Author: # Original code from B. Ripley # FUNCTION: # List: if (!character.only) package <- as.character(substitute(package)) pkgNm <- paste("package", package, sep = ":") ## return if(!is.na(match(pkgNm, search())) || require(package, character.only = TRUE, quietly = TRUE)) { nm <- ls(env <- as.environment(pkgNm), all.names = TRUE) nm[unlist(lapply(nm, function(n) exists(n, where = env, mode = "function", inherits = FALSE)))] } else { character(0) } } # ------------------------------------------------------------------------------ countFunctions <- function(package, character.only = FALSE) { # A function implemented by Diethelm Wuertz & Yohan Chalabi # Description: # Counts all functions in a package # Arguments: # package - a character string, the name of the Package # FUNCTION: # Count: if (!character.only) package <- as.character(substitute(package)) ans = length(listFunctions(package, character.only = TRUE)) names(ans) = package # Return Value: ans } ################################################################################ fBasics/R/gui-stylizedFacts.R0000644000176200001440000004415213202116742015566 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ############################################################################### # FUNCTION: STYLIZED FACTS GUI: # .stylizedFactsGUI Opens a GUI for stylized facts # .lmacfPlot Estimates and displays the long memory ACF # .logpdfPlot Displays a pdf plot on logarithmic scale(s) # .ccfPlot Displays tailored cross correlation function plot # .qqgaussPlot Displays a tailored Gaussian quantile-quantile plot ############################################################################### .lmacfPlot <- function(x, lag.max = max(2, floor(10*log10(length(x)))), ci = 0.95, type = c("both", "acf", "hurst"), labels = TRUE, trace = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Evaluate and display long memory autocorrelation Function. # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) X = x # Match Arguments: type = match.arg(type) # Labels: if (labels) { main1 = "" xlab1 = "lag" ylab1 = "ACF" main2 = "" xlab2 = "log lag" ylab2 = "log ACF" } else { main1 = xlab1 = ylab1 = "" main2 = xlab2 = ylab2 = "" } Fitted = list() Hurst = NULL DIM = dim(X)[2] for (i in 1:DIM) { # Get Data: x.ret = as.matrix(X)[, i] x = abs(x.ret) if (labels) main1 = main2 = Units[i] # ACF: z = acf(x, lag.max = lag.max, type = "correlation", plot = FALSE) z$acf[1] = 0 cl = qnorm(0.5 + ci/2)/sqrt(z$n.used) z.min = min(z$acf, -cl) # lin-lin plot excluding one: x = seq(0, lag.max, by = 1) y = z$acf if (type == "both" | type == "acf") { plot(x = x[-1], y = y[-1], type = "l", main = main1, col = "steelblue", xlab = xlab1, ylab = ylab1, xlim = c(0, lag.max), ylim = c(-2*cl, max(y[-1])), ...) # abline(h = 0, lty = 3) if (trace) { cat ("\nLong Memory Autocorrelation Function:") paste (cat ("\n Maximum Lag "), cat(lag.max)) paste (cat ("\n Cut-Off ConfLevel "), cat(cl)) } ACF = acf(x.ret, lag.max = lag.max, plot = FALSE)$acf[,,1] lines(x = 1:lag.max, y = ACF[-1], type = "l", col = "steelblue") lines(x = c(-0.1, 1.1)*lag.max, y = c(+cl, +cl), lty = 3, col = "darkgrey") lines(x = c(-0.1, 1.1)*lag.max, y = c(-cl, -cl), lty = 3, col = "darkgrey") } # log-log Plot of ACF: x = x[y > cl] y = y[y > cl] # log-log: if (length(x) < 10) { Fit = c(NA, NA) hurst = NA cat("\n The time series exhibits no long memory! \n") } else { Fit = lsfit(log(x), log(y)) fit = unlist(Fit)[1:2] hurst = 1 + fit[2]/2 if (type == "both" | type == "hurst") { plot(x = log(x), y = log(y), type = "l", xlab = xlab2, ylab = ylab2, main = main2, col = "steelblue", ...) Text = paste("Hurst Exponent:", signif(hurst, 3)) mtext(Text, side = 4, adj = 0, col = "darkgrey", cex = 0.7) # Grid: if (labels) grid() } ### fit = l1fit(log(x), log(y))$coefficients abline(fit[1], fit[2], col = 1) if (trace) { paste (cat ('\n Plot-Intercept '), cat(fit[1])) paste (cat ('\n Plot-Slope '), cat(fit[2])) paste (cat ('\n Hurst Exponent '), cat(hurst), cat("\n")) } } # Save Results: if (DIM == 1) Fitted = Fit else Fitted[[i]] = Fit Hurst = c(Hurst, hurst) } # Return Value: invisible(list(fit = Fitted, hurst = Hurst)) } # ------------------------------------------------------------------------------ .logpdfPlot = function(x, breaks = "FD", type = c("lin-log", "log-log"), doplot = TRUE, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a pdf plot on logarithmic scale(s) # Details: # Returns a pdf plot on a lin-log scale in # comparison to a Gaussian density plot # and return the break-midpoints and the # counts obtained from the histogram of # the empirical data. # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Select Type: type = match.arg(type) # Labels: if (labels) { if (type == "lin-log") { main = "log PDF" xlab = "x" ylab = "log PDF" } else if (type == "log-log") { main = "log PDF" xlab = "log x" ylab = "log PDF" } } else { main = xlab = ylab = "" } X = x DIM = ncol(X) for (i in 1:DIM) { # Get Data: x = as.vector(X[, i]) if (labels) main = Units[i] # Lin-Log Plot: if (type == "lin-log") { # Histogram PDF: result = hist(x, breaks = breaks, plot = FALSE) prob.counts = result$counts/sum(result$counts) / diff(result$breaks)[1] histogram = list(breaks = result$breaks, counts = prob.counts) # Histogram Count & Break-Midpoints: yh = histogram$counts xh = histogram$breaks xh = xh[1:(length(xh)-1)] + diff(xh)/2 xh = xh[yh > 0] yh = log(yh[yh > 0]) if (doplot) { par(err = -1) plot(xh, yh, type = "p", pch = 19, col = "steelblue", main = main, xlab = xlab, ylab = ylab, ...) Text = "Scales: log-log" mtext(Text, side = 4, adj =0, col = "darkgrey", cex = 0.7) } # Compare with a Gaussian Plot: xg = seq(from = xh[1], to = xh[length(xh)], length = 301) yg = log(dnorm(xg, mean(x), sqrt(var(x)))) if (doplot) { par(err = -1) lines(xg, yg, col = "brown") } # Return Value: result = list(breaks = xh, counts = yh, fbreaks = xg, fcounts = yg) } # Log-Log Plot: if (type == "log-log") { # Histogram PDF: result = hist(x, breaks = breaks, plot = FALSE) prob.counts = result$counts/sum(result$counts) / diff(result$breaks)[1] histogram = list(breaks = result$breaks, counts = prob.counts) # Histogram Count & Breaks: yh = histogram$counts xh = histogram$breaks xh = xh[1:(length(xh)-1)] + diff(xh)/2 xh = xh[yh > 0] yh = yh[yh > 0] yh1 = yh[xh < 0] xh1 = abs(xh[xh < 0]) yh2 = yh[xh > 0] xh2 = xh[xh > 0] if (doplot) { plot(log(xh1), log(yh1), type = "p", pch = 19, col = "darkgreen", main = main, xlab = xlab, ylab = ylab, ...) Text = "Scales: log-log" mtext(Text, side = 4, adj =0, col = "darkgrey", cex = 0.7) par(err = -1) points(log(xh2), log(yh2), col = 2, ...) } # Compare with a Gaussian plot: xg = seq(from = min(xh1[1], xh[2]), to = max(xh1[length(xh1)], xh2[length(xh2)]), length = 301) xg = xg[xg > 0] yg = log(dnorm(xg, mean(x), sqrt(var(x)))) if (doplot) { par(err = -1) lines(log(xg), yg, col = "brown") } # Result: result = list(breaks = c(xh1, xh2), counts = c(yh1, yh2), fbreaks = c(-rev(xg), xg), fcounts = c(-rev(yg), yg)) } # Grid: if (labels) grid() } # Return Value: invisible(result) } # ------------------------------------------------------------------------------ .qqgaussPlot <- function(x, span = 5, col = "steelblue", labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns a simple Quantile-Quantile plot. # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: # if (SPLUSLIKE) splusLikePlot(TRUE) # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Labels: if (labels) { main = "Normal QQ Plot" xlab = "Theoretical Quantiles" ylab = "Sample Quantiles" } else { main = xlab = ylab = "" } X = x DIM = dim(X)[2] for (i in 1:DIM) { # Get Data: x = as.vector(as.matrix(X)[, i]) if (labels) main = Units[i] # Standardized qqnorm(): y = (x-mean(x)) / sqrt(var(x)) # Further Settings: y[abs(y) < span] lim = c(-span, span) # Plot qqnorm: qqnorm(y, main = main, xlab = xlab, ylab = ylab, xlim = lim, ylim = lim, col = col, ...) # Add Line: qqline(y, ...) # Grid: if (labels) grid() } # Return Value: invisible(x) } # ------------------------------------------------------------------------------ .ccfPlot <- function(x, y, lag.max = max(2, floor(10*log10(length(x)))), type = c("correlation", "covariance", "partial"), labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Cross correlation function plot # Arguments: # x - an univariate 'timeSeries' object # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Convert Type: if (class(x) == "timeSeries") stopifnot(isUnivariate(x)) if (class(y) == "timeSeries") stopifnot(isUnivariate(y)) x = as.vector(x) y = as.vector(y) # Labels: if (labels) { main = "Crosscorrelation Function" xlab = "lag" ylab = "CCF" } else { main = xlab = ylab = "" } # Result: # A copy from R's ccf - So you can use it also under SPlus: X = cbind(x = x, y = y) acf.out = acf(X, lag.max = lag.max, plot = FALSE, type = type[1]) lag = c(rev(acf.out$lag[-1, 2, 1]), acf.out$lag[, 1, 2]) y = c(rev(acf.out$acf[-1, 2, 1]), acf.out$acf[, 1, 2]) acf.out$acf = array(y, dim = c(length(y), 1, 1)) acf.out$lag = array(lag, dim = c(length(y), 1, 1)) acf.out$snames = paste(acf.out$snames, collapse = " & ") plot(acf.out, main = main, xlab = xlab, ylab = ylab, ...) # Return Value: invisible(acf.out) } ################################################################################ .stylizedFactsGUI <- function(x, mfrow = c(3, 3)) { # A function implemented by Diethelm Wuertz # Description: # Opens a GUI for stylized facts # FUNCTION: # Refresh Code: stylizedFactsRefreshCode <- function(...) { # Settings: selectedAsset = .tdSliderMenu(no = 1) type = as.integer(.tdSliderMenu(obj.name = "stylizedFactsType")) Unit = colnames(x) # ACF Plot: if (type == 1) { if (selectedAsset == 0) { par(mfrow = mfrow) acfPlot(x) } else { par(mfrow = c(1, 1)) acfPlot(x[, selectedAsset]) } } # PACF Plot: if (type == 2) { if (selectedAsset == 0) { par(mfrow = mfrow) pacfPlot(x) } else { par(mfrow = c(1, 1)) pacfPlot(x[, selectedAsset]) } } # Volatility ACF Plot: if (type == 3) { if (selectedAsset == 0) { par(mfrow = mfrow) acfPlot(abs(x)) } else { par(mfrow = c(1, 1)) acfPlot(abs(x[, selectedAsset])) } } # Taylor Effect Plot: if (type == 4) { if (selectedAsset == 0) { par(mfrow = mfrow) teffectPlot(x) } else { par(mfrow = c(1, 1)) teffectPlot(x[, selectedAsset]) } } # Long Memory ACF: if (type == 5) { if (selectedAsset == 0) { par(mfrow = mfrow) .lmacfPlot(abs(x)) } else { par(mfrow = c(1, 1)) .lmacfPlot(abs(x[, selectedAsset])) } } # Lagged Autocorrelation Plot: if (type == 6) { if (selectedAsset == 0) { par(mfrow = mfrow) lacfPlot(x) } else { par(mfrow = c(1, 1)) lacfPlot(x[, selectedAsset]) } } # PDF plot on lin-log Scale: if (type == 7) { if (selectedAsset == 0) { par(mfrow = mfrow) .logpdfPlot(x) } else { par(mfrow = c(1, 1)) .logpdfPlot(x[, selectedAsset]) } } # PDF plot on log-log Scale: if (type == 8) { if (selectedAsset == 0) { par(mfrow = mfrow) .logpdfPlot(x, type = "log-log") } else { par(mfrow = c(1, 1)) .logpdfPlot(x[, selectedAsset], type = "log-log") } } # Simple Normal Quantile-Quantile Plot if (type == 9) { if (selectedAsset == 0) { par(mfrow = mfrow) .qqgaussPlot(x, pch = 19) } else { par(mfrow = c(1, 1)) .qqgaussPlot(x[, selectedAsset], pch = 19) } } # Scaling Law Plot: if (type == 10) { if (selectedAsset == 0) { par(mfrow = mfrow) scalinglawPlot(x, pch = 19) } else { par(mfrow = c(1, 1)) scalinglawPlot(x[, selectedAsset], pch = 19) } } } nAssets = dim(x)[2] .tdSliderMenu( stylizedFactsRefreshCode, names = c("Selected Asset"), minima = c( 0), maxima = c( nAssets), resolutions = c( 1), starts = c( 0), but.functions = list( function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "1") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "2") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "3") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "4") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "5") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "6") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "7") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "8") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "9") stylizedFactsRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "stylizedFactsType", obj.value = "10") stylizedFactsRefreshCode()} ), but.names = c( "1 ACF Function of Returns", "2 Partial ACF of Returns", "3 ACF of absolute Returns", "4 Taylor Effect", "5 Long Memory ACF of abs Returns", "6 Lagged Autocorrelations", "7 Lin-Log Tail Density Plot", "8 Log-Log Lower Tail Density", "9 Simple Normal QQ Plot", "10 Scaling Law Plot"), title = "Stylized Facts GUI" ) .tdSliderMenu(obj.name = "type", obj.value = "1", no = 1) # return Value: invisible() } ################################################################################ fBasics/R/gui-returnSeries.R0000644000176200001440000001166713202116742015435 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: GRAPHICAL USER INTERFACE: # returnSeriesGUI pens a GUI for return series plots ################################################################################ returnSeriesGUI <- function(x) { # A function implemented by Diethelm Wuertz # Descriptions: # Opens a GUI for return series plots # Arguments: # x - an uni- or multivariate timeSeries object # FUNCTION: # Check: stopifnot(class(x) == "timeSeries") # Settings: N = ceiling(sqrt(ncol(x))) mfrow = c(N, N) returnSeriesRefreshCode <- function(...) { # Settings: selectedAsset = .tdSliderMenu(no = 1) type = as.integer(.tdSliderMenu(obj.name = "returnSeriesType")) Unit = colnames(x) # Print Basic Return Statistics: if (type == 1) { if (selectedAsset == 0) { print(basicStats(x)) } else { print(basicStats(x[, selectedAsset])) } } # Return Series Plot: if (type == 2) { if (selectedAsset == 0) { par(mfrow = mfrow) seriesPlot(x) } else { par(mfrow = c(1, 1)) seriesPlot(x[, selectedAsset]) } } # Cumulate Return Series Plot if (type == 3) { if (selectedAsset == 0) { par(mfrow = mfrow) seriesPlot(100*exp(colCumsums(x))) } else { par(mfrow = c(1, 1)) seriesPlot(100*exp(colCumsums(x[, selectedAsset]))) abline(h = 100, col = "grey") } } # Histogram Plot: if (type == 4) { if (selectedAsset == 0) { par(mfrow = mfrow) histPlot(x, skipZeros = TRUE) } else { par(mfrow = c(1, 1)) histPlot(x[, selectedAsset], skipZeros = TRUE) } } # Density Plot: if (type == 5) { if (selectedAsset == 0) { par(mfrow = mfrow) densityPlot(x) } else { par(mfrow = c(1, 1)) densityPlot(x[, selectedAsset]) } } # Normal QQ Plot: if (type == 6) { if (selectedAsset == 0) { par(mfrow = mfrow) qqnormPlot(x) } else { par(mfrow = c(1, 1)) qqnormPlot(x[, selectedAsset]) } } } nAssets = dim(x)[2] .tdSliderMenu( returnSeriesRefreshCode, names = c("Selected Asset"), minima = c( 0), maxima = c( nAssets), resolutions = c( 1), starts = c( 0), but.functions = list( function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "1") returnSeriesRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "2") returnSeriesRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "3") returnSeriesRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "4") returnSeriesRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "5") returnSeriesRefreshCode()}, function(...){ .tdSliderMenu(obj.name = "returnSeriesType", obj.value = "6") returnSeriesRefreshCode()} ), but.names = c( "1 Basic Return Statistics Table", "2 Return Series Plot", "3 Cumulated Return Series Plot", "4 Histogram Plot", "5 Density Plot", "6 Normal Quantile-Quantile Plot"), title = "Return Series GUI" ) .tdSliderMenu(obj.name = "type", obj.value = "1", no = 1) # Return Value() invisible() } ################################################################################ fBasics/R/utils-as.matrix.ts.R0000644000176200001440000000370713202116742015646 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # as.matrix.ts Converts univariate ts to 1-column matrix # as.matrix.mts Converts multivariate ts to matrix ################################################################################ ## as.matrix.ts <- ## function(x, ...) ## { ## # A function implemented by Diethelm Wuertz ## # Description: ## # Coerces a "ts" object into a matrix ## # FUNCTION: ## # Transform: ## ans = as.matrix.default(unclass(x)) ## attr(ans, "tsp")<-NULL ## rownames(ans)<-NULL ## colnames(ans)<-NULL ## # Return Value: ## ans ## } ## # ------------------------------------------------------------------------------ ## as.matrix.mts <- ## function(x, ...) ## { ## # A function implemented by Diethelm Wuertz ## # Description: ## # Coerces a multivariate "ts" object into a matrix ## # FUNCTION: ## # Transform: ## ans = as.matrix.default(unclass(x)) ## attr(ans, "tsp")<-NULL ## rownames(ans)<-NULL ## colnames(ans)<-NULL ## # Return Value: ## ans ## } ################################################################################ fBasics/R/matrix-posDefinite.R0000644000176200001440000000776013202116742015733 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # isPositiveDefinite Checks if the matrix X is positive definite # makePositiveDefinite Forces the matrix x to be positive definite ################################################################################ isPositiveDefinite <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Checks if the matrix x is positive definite # Arguments: # x - a symmetric matrix or any other rectangular object # describing a covariance matrix which can be converted into # a matrix by the function 'as.matrix'. # FUNCTION: # Transform: x = as.matrix(x) # Check if matrix is positive definite: ans = .is.positive.definite(m = x) # Return Value: ans } # ------------------------------------------------------------------------------ .is.positive.definite <- function(m, tol, method = c("eigen", "chol")) { # Author: # Copyright 2003-05 Korbinian Strimmer # Rank, condition, and positive definiteness of a matrix # GNU General Public License, Version 2 method = match.arg(method) if (!is.matrix(m)) { m = as.matrix(m) } if (method == "eigen") { eval = eigen(m, only.values = TRUE)$values if( missing(tol) ) { tol = max(dim(m))*max(abs(eval))*.Machine$double.eps } if (sum(eval > tol) == length(eval)) { return(TRUE) } else { return(FALSE) } } else if (method == "chol") { val = try(chol(m), silent = TRUE) if (class(val) == "try-error") { return(FALSE) } else { return(TRUE) } } } # ------------------------------------------------------------------------------ makePositiveDefinite <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Forces the matrix x to be positive definite # Arguments: # x - a symmetric matrix or any other rectangular object # describing a covariance matrix which can be converted into # a matrix by the function 'as.matrix'. # FUNCTION: # Make Positive Definite: ans = .make.positive.definite(m = x) # Return Value: ans } # ------------------------------------------------------------------------------ .make.positive.definite <- function(m, tol) { # Author: # Copyright 2003-05 Korbinian Strimmer # Rank, condition, and positive definiteness of a matrix # GNU General Public License, Version 2 # Method by Higham 1988 if (!is.matrix(m)) { m = as.matrix(m) } d = dim(m)[1] if ( dim(m)[2] != d ) { stop("Input matrix is not square!") } es = eigen(m) esv = es$values if (missing(tol)) { tol = d*max(abs(esv))*.Machine$double.eps } delta = 2*tol # factor two is just to make sure the resulting # matrix passes all numerical tests of positive definiteness tau = pmax(0, delta - esv) dm = es$vectors %*% diag(tau, d) %*% t(es$vectors) # print(max(DA)) # print(esv[1]/delta) return( m + dm ) } ################################################################################ fBasics/R/utils-characterTable.R0000644000176200001440000000505313202116742016213 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # characterTable Shows a table of character codes ################################################################################ characterTable <- function(font = 1, cex = 0.7) { # A function implemented by Diethelm Wuertz # Description: # Prints numeric equivalents to all latin characters. # Notes: # The printed version doesn't allways corresponds to the # screen display. The character on line "xy" and column # "z" of the table has code "xyz". These codes can be # used as any other characters. # e.g. title("\347\340 et \340") # Note on S: # As the command line window of Splus can't print special # characters # cat("\347\340 et \340") # will not print the special characters, at least under # 4.5 and under 2000. # Author: # Source from Pierre Joyet, pierre.joyet@bluewin.ch # Example: # for (i in 1:20) characterTable(font = i) # FUNCTION: # Table: v = 40:377 v = v[v %% 100 < 80 & v %% 10 < 8] par(mar = c(5, 5, 4, 2) + 0.1) plot(-1:7, seq(4, 33, length = 9), type = "n", axes = FALSE, xlab = "", ylab = "", cex = cex, main = "Table of Characters") k = 1 for(i in 4:31) for(j in 0:7) { text(j, 35 - i, eval(parse(text = paste("\"\\", v[k], "\"", sep = ""))), font = font, cex = cex) k = k + 1 } text(0:7, rep(33, 7), as.character(0:7), font = 3, cex = cex) text(rep(-1, 28), 31:4, as.character(c(4:7, 10:17, 20:27, 30:37)), font = 3, cex = cex) # Return Value: invisible(font) } ################################################################################ fBasics/R/dist-distErrors.R0000644000176200001440000000306713202116742015255 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ .distStandardErrors <- function(fit, obj, x) { # Add Standard Errors and t-Values: hessian = tsHessian(x = fit$par, fun = obj, y = x, trace = FALSE) colnames(hessian) = rownames(hessian) = names(fit$par) fit$cvar = solve(hessian) fit$se.coef = sqrt(diag(fit$cvar)) if (fit$scale) fit$se.coef = fit$se.coef / fit$scaleParams fit$tval = fit$par/fit$se.coef fit$matcoef = cbind(fit$par, fit$se.coef, fit$tval, 2*(1-pnorm(abs(fit$tval)))) dimnames(fit$matcoef) = list(names(fit$tval), c(" Estimate", " Std. Error", " t value", "Pr(>|t|)")) # Return Value: fit } ################################################################################ fBasics/R/dist-snigFit.R0000644000176200001440000000322213202116741014510 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # snigFit Fits parameters of a standardized NIG density ################################################################################ snigFit = function(x, zeta = 1, rho = 0, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # Update Slots: if (is.null(title)) title = "SNIG Parameter Estimation" # Quick and dirty ... ans = sghFit(x, zeta = zeta, rho = rho, lambda = -0.5, include.lambda = FALSE, scale = scale, doplot = doplot, span = span, trace = trace, title = title, description = description, ...) # Update Slots: ans@call = match.call() ans@model = "Standarized NIG Distribution" # Return Value: ans } ################################################################################ fBasics/R/builtin-glGld.R0000644000176200001440000005675513202116742014665 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # .pgld # .qgld # .qgl.fmkl # .qgl.fm5 # .qgl.rs # .qdgld # .qdgl.rs # .qdgl.fmkl # .qdgl.fm5 # .rgld # .gl.parameter.tidy # .gl.check.lambda ################################################################################ # Code borrowed from # R's contributed package "gld" written by Robert King # Rmetrics: # Note that gmm is not available on Debian as of 2009-11-11. # To run these functions under Debian/Rmetrics we have them # implemented here as a builtin. # Package: gld # Version: 1.8.4 # Date: 2008/10/01 # Title: Estimation and use of the generalised (Tukey) lambda distribution # Author: Robert King # Maintainer: Robert King # Description: The generalised lambda distribution, or Tukey lambda # distribution, provides a wide variety of shapes with one # functional form. This package provides random numbers, # quantiles, probabilities, densities and plots. It also # includes an implementation of the starship estimation method # for the distribution. # License: GPL (>= 2) # URL: http://tolstoy.newcastle.edu.au/~rking/publ/rprogs/information.html # Packaged: 2009-10-14 ################################################################################ .dgld <- function(x, lambda1=0, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL, inverse.eps=1e-8, max.iterations=500) { # Tidy the parameters so gl.check.lambda will work lambdas <- .gl.parameter.tidy(lambda1, lambda2, lambda3, lambda4, param, lambda5) # Check the parameters if(!.gl.check.lambda(lambdas, param=param, vect=TRUE)) { stop(paste("The parameter values", lambdas, "\ndo not produce a proper distribution with the", param, "parameterisation - see \ndocumentation for .gl.check.lambda")) } # calculate u=F(x) numerically, then use qdgl # Unless x is outside the range, then density should be zero extreme <- .qgld(c(0, 1), lambda1=lambdas, param=param) # It may be better to change this to simply # (x <= extreme[2])*(x >= extreme[1]) outside.range <- !as.logical((x<=extreme[2])*(x>=extreme[1])) u <- .pgld(x, lambdas, param=param, inverse.eps=inverse.eps, max.iterations=max.iterations) dens <- .qdgld(u, lambda1=lambdas, param=param) dens[outside.range] <- 0 dens } ################################################################################ .pgld <- function(q, lambda1=0, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL, inverse.eps=1e-8, max.iterations=500) { # Thanks to Steve Su, , for improvements to this code # If lambda1 is a vector, the default value for lambda2 will cause a # problem. # I did have a warning about this, but it will occur too often to make # up for the benefit, so I've deleted it. # Tidy the parameters so gl.check.lambda will work lambdas <- .gl.parameter.tidy(lambda1, lambda2, lambda3, lambda4, param, lambda5) # Check the parameters if(!.gl.check.lambda(lambdas, param=param, vect=TRUE)) { stop(paste("The parameter values", lambda1, lambda2, lambda3, lambda4, "\ndo not produce a proper distribution with the", param, "parameterisation - see \ndocumentation for gl.check.lambda")) } jr <- q; jr[sort.list(q)] <- seq(along=q) order.x<-order(q) xx<-sort(q) # xx has the sorted data, and jr & order.x the information to get back # to theoriginal order. extreme <- .qgld(c(inverse.eps, 1-inverse.eps), lambda1=lambdas, param=param) max.e<-extreme[2] min.e<-extreme[1] ind.min<-xx<=min.e ind.max<-xx>=max.e # This simpler comparison works here because we are using inverse.eps as our # tolerance q<-xx[as.logical((xxmin.e))] # We only want to calculate the probabilities for q values inside # the support length.of.vector <- length(q) # Need a blank u to send to C u <- 0*q result <- switch(param, freimer=, # allows for alternate expressions frm=, # allows for alternate expressions FMKL=, # Notes on .C call - the "numerics", lambdas and inverse.eps # don't need the as.??? call as they are implicitly double fmkl=.C( "gl_fmkl_distfunc", lambdas[1], lambdas[2], lambdas[3], lambdas[4], as.double(0), as.double(1), inverse.eps, as.integer(max.iterations), as.double(q), as.double(u), as.integer(length.of.vector), PACKAGE="fBasics"), ramberg=, # Ramberg & Schmeiser ram=, RS=, rs=.C( "gl_rs_distfunc", lambdas[1], lambdas[2], lambdas[3], lambdas[4], as.double(0), as.double(1), inverse.eps, as.integer(max.iterations), as.double(q), as.double(u), as.integer(length.of.vector), PACKAGE="fBasics"), fm5=.C("gl_fm5_distfunc", lambdas[1], lambdas[2], lambdas[3], lambdas[4], lambdas[5], as.double(0), as.double(1), inverse.eps, as.integer(max.iterations), as.double(q), as.double(u), as.integer(length.of.vector), PACKAGE="fBasics"), stop("Error: Parameterisation must be one of fmkl, fm5 or rs") ) # closes "switch" if (!(is.numeric(result[[1]]))){ stop("Values for quantiles outside range. This shouldn't happen") } if (param=="fm5") { u <- result[[11]] } else { u <- result[[10]] } xx[as.logical((xxmin.e))]<-u xx[ind.min]<-0 xx[ind.max]<-1 # Revert to the original order of the dataset: xx[jr] } ################################################################################ .qgld <- function(p, lambda1, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL) { lambdas <- .gl.parameter.tidy(lambda1, lambda2, lambda3, lambda4, param, lambda5) # Check the values are OK if(!.gl.check.lambda(lambdas, param=param, vect=TRUE)) { stop(paste("The parameter values", paste(lambdas, collapse=" "), "\ndo not produce a proper distribution for the", param, "parameterisation \n - see documentation for gl.check.lambda")) } result <- switch(param, freimer=, # allows for alternate expressions frm=, # allows for alternate expressions FMKL=, fmkl=.qgl.fmkl(p, lambdas), ramberg=, # Ramberg & Schmeiser ram=, RS=, rs=.qgl.rs(p, lambdas), fm5 = .qgl.fm5(p, lambdas), stop("Error: Parameterisation must be fmkl, fm5 or rs") ) # closes "switch" result } # ------------------------------------------------------------------------------ .qgl.fmkl <- function(p, lambdas) { # No checking - use qgl if you want that lambda4 = lambdas[4] lambda3 = lambdas[3] lambda2 = lambdas[2] lambda1 = lambdas[1] p <- as.double(p) # abandoned this for the simpler one below # outside.range <- !as.logical(((p<1)*(p>0))| # (sapply(p, all.equal, 1)=="TRUE")| (sapply(p, all.equal, 0)=="TRUE")) outside.range <- !as.logical((p<=1)*(p>=0)) # u gets only the probabilities in [0, 1] u <- p[!outside.range] # If OK, determine special cases if (lambda3 == 0) { if (lambda4 == 0) { # both log quants <- lambda1 + (log(u) - log(1 - u))/lambda2 } else { # l3 zero, l4 non-zero quants <- lambda1 + (log(u) - ((1 - u)^lambda4 - 1)/lambda4)/lambda2 } } else { # lambda3 non-zero if (lambda4 == 0) { # non-zero, l4 zero quants <- lambda1 + ((u^lambda3 - 1)/lambda3 - log(1 - u))/lambda2 } else { # both non-zero - use usual formula quants <- lambda1 + ( ( u ^ lambda3 - 1) / lambda3 - ( (1-u)^lambda4 - 1) /lambda4 ) / lambda2 } } # Now we have the quantiles for p values inside [0, 1], put them in # the right place in the result vector result <- p*NaN result[!outside.range] <- quants # The remaining "quantiles" are NaN result } # ------------------------------------------------------------------------------ .qgl.fm5 <- function(p, lambdas) { # No parameter value checking. If you want that, use qgl! lambda5 = as.double(lambdas[5]) lambda4 = as.double(lambdas[4]) lambda3 = as.double(lambdas[3]) lambda2 = as.double(lambdas[2]) lambda1 = as.double(lambdas[1]) p <- as.double(p) # abandoned this for the simpler # outside.range <- !as.logical(((p<1)*(p>0))| # (sapply(p, all.equal, 1)=="TRUE")| (sapply(p, all.equal, 0)=="TRUE")) outside.range <- !as.logical((p<=1)*(p>=0)) # u gets only the probabilities in [0, 1] u <- p[!outside.range] # If OK, determine special cases if (lambda3 == 0) { if (lambda4 == 0) { # both log quants <- lambda1 + ((1-lambda5)*log(u) - (1+lambda5)*log(1 - u))/lambda2 } else { # l3 zero, l4 non-zero quants <- lambda1 + ((1-lambda5)*log(u) - (1+lambda5)*((1 - u)^lambda4 - 1)/lambda4)/lambda2 } } else { # lambda3 non-zero if (lambda4 == 0) { # non-zero, l4 zero quants <- lambda1 + ((1-lambda5)*(u^lambda3 - 1)/lambda3 - (1+lambda5)*log(1 - u))/lambda2 } else { # both non-zero - use usual formula quants <- lambda1 + ((1-lambda5)* ( u ^ lambda3 - 1) / lambda3 - (1+lambda5)*( (1-u)^lambda4 - 1) /lambda4 ) / lambda2 } } # Now we have the quantiles for p values inside [0, 1], put them in # the right place in the result vector result <- p*NaN result[!outside.range] <- quants # The remaining "quantiles" are NaN result } # ------------------------------------------------------------------------------ .qgl.rs <- function(p, lambdas) { u <- p # No parameter value checking - use qgl! lambda4 = lambdas[4] lambda3 = lambdas[3] lambda2 = lambdas[2] lambda1 = lambdas[1] # At present, I'm rejecting zero values for l3 and l4, though I think # there are limit results, so one functional form. quants <- lambda1 + ( u ^ lambda3 - (1-u)^lambda4 ) / lambda2 quants } # ------------------------------------------------------------------------------ .qdgld <- function(p, lambda1, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL) { # Don't allow characters in lambda5 - # common error with parameterisation stuff if(is.character(lambda5)) { stop(paste("lambda5=", lambda5, "It should be a number between -1 and 1")) } lambdas <- .gl.parameter.tidy(lambda1, lambda2, lambda3, lambda4, param, lambda5) # Check the values are OK if(!.gl.check.lambda(lambdas, param=param, vect=TRUE)) { stop(paste("The parameter values", paste(lambdas, collapse=" "), "\ndo not produce a proper distribution for the", param, "parameterisation \n - see documentation for gl.check.lambda")) } result <- switch(param, # Different tests apply for each parameterisation freimer=, # allows for alternate expressions frm=, # allows for alternate expressions FMKL=, fmkl=.qdgl.fmkl(p, lambdas), ramberg=, # Ramberg & Schmeiser ram=, RS=, rs=.qdgl.rs(p, lambdas), fm5 = .qdgl.fm5(p, lambdas), stop("Error: Parameterisation must be fmkl, fm5 or rs") ) # closes "switch" result } # ------------------------------------------------------------------------------ .qdgl.rs <- function(p, lambdas) { # Check the values are OK) if(!.gl.check.lambda(lambdas, param="rs", vect=TRUE)) { stop(paste("The parameter values", paste(lambdas, collapse=" "), "\ndo not produce a proper distribution with the RS parameterisation", " - see \ndocumentation for gl.check.lambda")) } outside.range <- !as.logical((p<=1)*(p>=0)) # u gets only the probabilities in [0, 1] u <- p[!outside.range] dens <- lambdas[2]/(lambdas[3] * (p^(lambdas[3] -1)) + lambdas[4] * ((1 - p)^(lambdas[4] -1))) dens } # ------------------------------------------------------------------------------ .qdgl.fmkl <- function(p, lambdas) { # Check the values are OK) if(!.gl.check.lambda(lambdas, param="fmkl", vect=TRUE)) { stop(paste("The parameter values", paste(lambdas, collapse=" "), "\ndo not produce a proper distribution with the FMKL", "parameterisation - see \ndocumentation for gl.check.lambda")) } outside.range <- !as.logical((p<=1)*(p>=0)) # u gets only the probabilities in [0, 1] u <- p[!outside.range] # The density is given by 1/Q'(u) dens <- lambdas[2]/(p^(lambdas[3] - 1) + (1 - p)^(lambdas[4] - 1)) dens } # ------------------------------------------------------------------------------ .qdgl.fm5 <- function(p, lambdas) { # Check the values are OK) if(!.gl.check.lambda(lambdas, param="fm5", vect=TRUE)) { stop(paste("The parameter values", paste(lambdas, collapse=" "), "\ndo not produce a proper distribution with the FM5", "parameterisation - see \ndocumentation for gl.check.lambda")) } outside.range <- !as.logical((p<=1)*(p>=0)) # u gets only the probabilities in [0, 1] u <- p[!outside.range] # The density is given by 1/Q'(u) dens <- lambdas[2]/((1-lambdas[5])*(u^(lambdas[3] - 1)) + (1+lambdas[5])*((1 - u)^(lambdas[4] - 1)) ) dens } ################################################################################ .rgld <- function(n, lambda1=0, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL) { # Check the parameters lambdas <- .gl.parameter.tidy(lambda1, lambda2, lambda3, lambda4, param, lambda5) # Check the values are OK if(!.gl.check.lambda(lambdas, param=param, vect=TRUE)) { stop(paste("The parameter values", lambdas, "\ndo not produce a proper distribution for the", param, "parameterisation \n - see documentation for gl.check.lambda")) } # Produce the uniform data p <- runif(n) # convert to gl res <- .qgld(p, lambda1=lambdas, param=param) res } ################################################################################ .gl.parameter.tidy <- function(lambda1, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL) { # Don't allow characters in lambda5 - common error with parameterisation stuff if(is.character(lambda5)) {stop(paste("lambda5=", lambda5, "It should be a number between -1 and 1"))} # Don't allow numbers in parameterisation - # included as a warning here, so the main one is a stop. if(!is.character(param)) {warning(paste("param=", param, "It shouldn't be a number, ", "it should be a string describing the parameterisation")) } if(length(lambda1) > 1) { # using a vector for the parameters. # Check that there aren't values in the individual lambda arguments if (!(is.null(lambda2) & is.null(lambda3)& is.null(lambda4) & is.null(lambda5)) ) { stop("Call includes vector version of the lambda parameters", "as well as the \nscalar version") } if ((length(lambda1) < 4) | (length(lambda1) > 5 ) ) { stop(paste("argument lambda1 has length", length(lambda1), "\nThis should be 1 (lambda parameters given as seperate ", "arguments), 4 (vector argument \n for RS or FMKL ", "parameterisation) or 5 (vector argument for fm5", "parameterisation")) } if (length(lambda1)== 5) { if (param != "fm5") { stop(paste("argument lambda1 has length", length(lambda1), "which is not valid for the", param, "\nparameterisation")) } # else --- fm5, in vector form, ready for gl.check.lambda } if (length(lambda1)== 4) { if (param == "fm5" ) { stop(paste("argument lambda1 has length 4, which is not", " valid for the fm5 \nparameterisation")) } # else --- 4 parameter versions in vector form, ready for gl.check.lambda } } else { # single parameter arguments - check they are there, # then collect them together if (is.null(lambda2)) { stop("No value for lambda2") } if (is.null(lambda3)) { stop("No value for lambda3") } if (is.null(lambda4)) { stop("No value for lambda4") } if ((is.null(lambda5)) & param=="fm5" ) { stop("No value for lambda5") } if (!(is.null(lambda5)) & param!="fm5") { stop(paste("lambda5=", lambda5, " but there is no lambda 5 for the\n", param, "parameterisation")) } if (param != "fm5") { # A 4 parameter version lambda1 <- c(lambda1, lambda2, lambda3, lambda4) } else { # fm5 lambda1 <- c(lambda1, lambda2, lambda3, lambda4, lambda5) } } # There is now an error if there is the wrong number of parameters, and # lambda1 returned as a vector with 4 or 5 elements # as.double is needed to remove data.frame attributes if lambda1 was # extracted from a data.frame as.double(lambda1) } # ------------------------------------------------------------------------------ .gl.check.lambda <- function(lambdas, lambda2=NULL, lambda3=NULL, lambda4=NULL, param="fmkl", lambda5=NULL, vect=FALSE) { # Checks to see that the lambda values given are allowed. # There is a function called .gl.parameter.tidy that does the tidying # around of parameters. It return a single vector, which contains the # parameters. # If you call this after .gl.parameter.tidy, let it know with the vect=TRUE # argument # If vect=TRUE, we don't need to tidy if (vect) { if (!is.null(lambda3)) { warning("lambda3 should be null because you claim the", " parameters are in a vector") } } else { lambdas <- .gl.parameter.tidy(lambdas, lambda2, lambda3, lambda4, param, lambda5) } if(param=="fm5"){lambda5 = lambdas[5]} lambda4 = lambdas[4] lambda3 = lambdas[3] lambda2 = lambdas[2] lambda1 = lambdas[1] # I did have a check for finite lambdas, but that caused a # problem with data frames, # so I removed it - still need to include the limit results param <- switch(param, # Different tests apply for each parameterisation freimer=, # allows for alternate expressions frm=, # allows for alternate expressions FMKL=, fmkl={ if (lambda2<=0) {return(FALSE)} else {return(TRUE)} }, ramberg=, # Ramberg & Schmeiser ram=, RS=, rs={ if (lambda3*lambda4>0) { # regions 3 and 4 # all values of lambda 3 and lambda 4 OK # check lambda 2 if ((lambda3>0)&(lambda4>0)) { # region 3 - l2 >0 if (lambda2<=0) { ret <- FALSE } else { ret <- TRUE } } if ((lambda3<0)&(lambda4<0)) { # region 4 - l2 <0 if (lambda2>=0) { ret <- FALSE } else { ret <- TRUE } } } else { # other quadrants - lambda 2 must be negative, and lambda3 # lambda 4 values need checking. if (lambda2>=0) {return(FALSE)} # Rectangular regions where RS is not defined if ((lambda3>0)&(lambda3<1)&(lambda4<0)) {return(FALSE)} if ((lambda4>0)&(lambda4<1)&(lambda3<0)) {return(FALSE)} # Different here because there are a # number of ways in which the parameters can fail. # # Curved regions where RS is not defined # change to shorter var names lc <- lambda3 ld <- lambda4 if ((lambda3>-1)&(lambda3<0)&(lambda4>1)) { # region 5 or not? if ( ((1-lc)^(1-lc)*(ld-1)^(ld-1))/((ld-lc)^(ld-lc)) > -lc/ld ) {return(FALSE)} else {return(TRUE)} } # Second curved region if ((lambda4>-1)&(lambda4<0)&(lambda3>1)) { # region 6 or not? if ( ((1-ld)^(1-ld)*(lc-1)^(lc-1))/((lc-ld)^(lc-ld)) > -ld/lc ) {return(FALSE)} else {return(TRUE)} } # There may be some limit results that mean these are not correct, but # I'll check that later # This is not the place where the possible l3, l4 zero values should appear if (lambda3 == 0) { warning('lambda 3 = 0 with RS parameterisation - possible problem') if (lambda4 == 0) {return(FALSE)} else {return(TRUE)} } if (lambda4 == 0) { warning('lambda 5 = 0 with RS parameterisation - possible problem') if (lambda4 == 0) {return(FALSE)} else {return(TRUE)} } # If we get here, then the parameters are OK. ret <- TRUE } }, fm5={ # make lambda5 - in here so it doesn't stuff up the # other parameterisations lambda5 <- lambdas[5] if (lambda2<=0) {ret <- FALSE} else { #Check lambda5 - should be between -1 and 1, but # I haven't checked this against a piece of paper if ((lambda5 >= -1) & (lambda5 <= 1)) { ret <- TRUE } else { ret <- FALSE } } }, stop("Error when checking validity of parameters.\n", " Parameterisation must be fmkl, rs or fm5") ) # closes "switch" ret } ################################################################################ fBasics/R/plot-histPlot.R0000644000176200001440000002263613202116742014741 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: TAILORED DENSITY FUNCTIONS: # histPlot Returns a tailored histogram plot # densityPlot Returns a tailored kernel density estimate plot # logDensityPlot Returns a tailored log kernel density estimate plot # .plot.histogram Replaces here the function plot.histogram ################################################################################ histPlot <- function(x, labels = TRUE, col = "steelblue", fit = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns a probability histogram plot for each column of a # timeSeries object # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) N = NCOL(x) Units = colnames(x) if (length(col) == 1) col = rep(col, times = N) # Histogram Plots: for (i in 1:N) { # Histogram: X = as.vector(x[, i]) if (skip) X = X[X != 0] # Plot: if (labels) { H = hist(x = X, , breaks = "FD", plot = FALSE) .plot.histogram(H, col = col[i], freq = FALSE, ...) box() } else { H = hist(x = X, plot = FALSE, ...) .plot.histogram(H, col = col[i], freq = FALSE, ...) } # Add Title: if(title) { title(main = paste(Units[i], "Histogram"), xlab = "Value", ylab = "Probability") } # Add Fit: if (fit) { mean = mean(X) sd = sd(X) xlim = range(H$breaks) s = seq(xlim[1], xlim[2], length = 201) lines(s, dnorm(s, mean, sd), lwd = 2, col = "brown") } # Add Mean: if (labels) { abline(v = mean, lwd = 2, col = "orange") Text = paste("Mean:", signif(mean, 3)) mtext(Text, side = 4, adj = 0, col = "darkgrey", cex = 0.7) } # Add Grid: if (grid) grid() # Add Zero Line: if(labels) { abline(h = 0, col = "grey") } # Add Rug Plot: if(rug) { rug(X, ticksize = 0.01, quiet = TRUE) } } # Return Value: invisible() } # ------------------------------------------------------------------------------ densityPlot <- function(x, labels = TRUE, col = "steelblue", fit = TRUE, hist = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns density plots for each column of a timeSeries object # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) N = NCOL(x) Units = colnames(x) if (length(col) == 1) col = rep(col, times = N) # Density Plots: for (i in 1:N) { # Density: X = as.vector(x[, i]) if (skip) X = X[X != 0] # Underlay Histogram: if (hist) { H = hist(x = X, , breaks = "FD", plot = FALSE) plot(x = H$mids, y = H$density, type = "h", lwd = 2, main = "", xlab = "", ylab = "", col = "grey") } # Plot Density: D = density(X, ...) if (hist) { lines(D$x, D$y, lwd = 2, col = "brown") } else { plot(D, col = col[i], ann = FALSE, ...) } # Add Title: if (title) { title(main = Units[i], xlab = "Value", ylab = "Density") } # Add Fit: if (fit) { mean = mean(X) sd = sd(X) xlim = range(H$breaks) s = seq(xlim[1], xlim[2], length = 201) lines(s, dnorm(s, mean, sd), lwd = 2, col = "darkgrey") } # Add Mean: if (labels) { abline(v = mean, lwd = 2, col = "orange") Text = paste("Mean:", signif(mean, 3)) mtext(Text, side = 4, adj = 0, col = "darkgrey", cex = 0.7) } # Add Grid: if (grid) { grid() } # Add Zero Line: if(labels) { abline(h = 0, col = "grey") } # Add Rug Plot: if(rug) { rug(X, ticksize = 0.01, quiet = TRUE) } } # Return Value: invisible() } # ------------------------------------------------------------------------------ logDensityPlot <- function(x, labels = TRUE, col = "steelblue", robust = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a pdf plot on logarithmic scale # Details: # Returns a pdf plot on a lin-log scale in comparison to a Gaussian # density plot Two type of fits are available: a normal density with # fitted sample mean and sample standard deviation, or a normal # density with Hubers robust mean and standard deviation corfrected # by the bandwidth of the Kernel estimator. # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) N = NCOL(x) Units = colnames(x) if (length(col) == 1) col = rep(col, times = N) # Log Density: for (i in 1:N) { # Transform Data: X = as.vector(x[, i]) if (skip) X = X[X != 0] # Kernel and Histogram Estimators: Density = density(X, ...) Histogram = hist(X, breaks = "FD", plot = FALSE) # Plot Frame: plot(Histogram$mids, log(Histogram$density), type = "n", ann = FALSE, xlim = range(Density$x), ylim = log(range(Density$y)), ...) # Add Title: if(title) { title(main = paste(Units[i], "Log Density"), xlab = "Value", ylab = "Log Density") } # Add Kernel Density Estimated Points: points(Density$x, log(Density$y), pch = 19, cex = 0.7, col = "grey") # Sample Line Fit: s = seq(min(Density$x), max(Density$x), length = 1001) # Robust Fit: if (robust) { h = MASS::hubers(X) logDensity = log(dnorm(s, mean = h[[1]], sd = sqrt(h[[2]]^2+Density$bw^2))) minLogDensity = log(min(Density$y)) lines( x = s[logDensity > minLogDensity], y = logDensity[logDensity > minLogDensity], col = "red", lwd = 2) # Standard Fit: lines(s, log(dnorm(s, mean(X), sd(X))), col = "orange", lwd = 2) } # Plot Histogram: points(Histogram$mids, log(Histogram$density), pch = 151, col = "steelblue") # Grid: if (grid) { grid() } # Add Rug Plot: if(rug) { rug(x, ticksize = 0.01, quiet = TRUE) } } # Return Value: invisible() } ################################################################################ .plot.histogram <- function(x, freq = equidist, density = NULL, angle = 45, col = NULL, border = "white", lty = NULL, main = NULL, sub = NULL, xlab = NULL, ylab = NULL, xlim = range(x$breaks), ylim = NULL, axes = TRUE, labels = FALSE, add = FALSE, ...) { # This replacement of plot.histogram() suppresses title # printing which would be otherwise not possible! equidist <- if(is.logical(x$equidist)) x$equidist else { h <- diff(x$breaks) ; diff(range(h)) < 1e-7 * mean(h) } if(freq && !equidist) warning("the AREAS in the plot are wrong -- rather use freq=FALSE") y <- if (freq) x$counts else { ## x$density -- would be enough, but ## for back compatibility y <- x$density; if(is.null(y)) x$intensities else y} nB <- length(x$breaks) if(is.null(y) || 0 == nB) stop("'x' is wrongly structured") if(!add) { if(is.null(ylim)) ylim <- range(y, 0) if (missing(ylab)) ylab <- if (!freq) "Density" else "Frequency" plot.new() plot.window(xlim, ylim, "") #-> ylim's default from 'y' # title(main = main, sub = sub, xlab = xlab, ylab = ylab, ...) if(axes) { axis(1, ...) axis(2, ...) } } rect(x$breaks[-nB], 0, x$breaks[-1], y, col = col, border = border, angle = angle, density = density, lty = lty) if((logl <- is.logical(labels) && labels) || is.character(labels)) text(x$mids, y, labels = if(logl) { if(freq) x$counts else round(x$density,3) } else labels, adj = c(0.5, -0.5)) invisible() } ################################################################################ fBasics/R/utils-randLCG.R0000644000176200001440000001242113202116742014556 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: PORTABLE INNOVATIONS: # set.lcgseed Sets initial random seed # get.lcgseed Gets the current valus of the random seed # FUNCTION: PORTABLE RVS GENERATORS: # runif.lcg Generates uniform linear congruational rvs # rnorm.lcg Generates normal linear congruational rvs # rt.lcg Generates Student-t linear congruational rvs ################################################################################ ################################################################################ # set.lcgseed Sets initial random seed # get.lcgseed Gets the current valus of the random seed # .lcg.seed = 4711 # ------------------------------------------------------------------------------ set.lcgseed <- function(seed = 4711) { # A function implemented by Diethelm Wuertz # Description: # Sets the random seed for the linear congruential # random number generator # Notes: # A Simple Portable Random Number Generator for Use in R and Splus # Use this generator only for comparisons of Programs in R and Splus !!! # Method: A linear congruential generator with # LCG(a=13445, c=0, m=2^31-1, X0) # Note, this is a random number generator which passes the bitwise # randomness test. # Reference: # http://csep1.phy.ornl.gov/rn/node13.html # N. S. Altman. ``Bitwise Behavior of Random Number Generators,'' # SIAM J. Sci. Stat. Comput., 9(5), September, pps. 941-949, 1988 # Example: # set.lcgseed(4711) # cbind(runif.lcg(100), rnorm.lcg(100), rt.lcg(100, df=4)) # FUNCTION: # Return Value: # .lcg.seed <<- seed setRmetricsOptions(lcg.seed = seed) } # ------------------------------------------------------------------------------ get.lcgseed <- function() { # A function implemented by Diethelm Wuertz # Description: # Returns the random seed for the linear congruential # random number generator # FUNCTION # Return Value: getRmetricsOptions("lcg.seed") } ################################################################################ # runif.lcg Uniform linear congruational generator # rnorm.lcg Normal linear congruational generator # rt.lcg Student-t linear congruational generator runif.lcg <- function(n, min = 0, max = 1) { # A function implemented by Diethelm Wuertz # Description: # A linear congruential generator for uniform distributed # random numbers # Notes: # Important - Use this generator only for comparisons of # Programs in R and SPlus (and not for production) !!! # Portable Random Numbers: # A linear congruential generator # LCG(a=13445, c=0, m=2^31-1, X0) # This is a random number generator which # passes the bitwise randomness test # References: # http://csep1.phy.ornl.gov/rn/node13.html # N. S. Altman. ``Bitwise Behavior of Random Number Generators,'' # SIAM J. Sci. Stat. Comput., 9(5), September, pps. 941-949, 1988 # FUNCTION: # Initialize: # if(!exists(".lcg.seed")) .lcg.seed <<- 4711 # Generate: r.lcg = rep(0, times = n) a = 13445 c = 0 m = 2^31-1 for (i in 1:n) { lcg.seed <- getRmetricsOptions("lcg.seed") setRmetricsOptions(lcg.seed = (a * lcg.seed + c) %% m) r.lcg[i] = getRmetricsOptions("lcg.seed") / m } r.lcg = (max-min)*r.lcg + min # Return Value: r.lcg } # ------------------------------------------------------------------------------ rnorm.lcg <- function(n, mean = 0, sd = 1) { # A function implemented by Diethelm Wuertz # Description: # A linear congruential generator for normal distributed # random numbers # FUNCTION: # This is slow, but portable between R and SPlus (qnorm(runif.lcg(n = n, min = 0, max = 1)) - mean)/sd^2 } # ------------------------------------------------------------------------------ rt.lcg <- function(n, df) { # A function implemented by Diethelm Wuertz # Description: # A linear congruential generator for Sudent-t distributed # random numbers # FUNCTION: # This is slow, but portable between R and SPlus qt(runif.lcg(n = n, min = 0, max = 1), df = df) } ################################################################################ fBasics/R/test-scaleTest.R0000644000176200001440000001726713202116741015066 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # scaleTest Performs scale tests on two samples # .ansariTest Ansari-Bradley test for differences in scale # .moodTest Mood test for differences in scale ################################################################################ scaleTest <- function(x, y, method = c("ansari", "mood"), title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs Scale Tests # FUNCTION: # Test: method = match.arg(method) if (method == "ansari") { ans = .ansariTest(x, y, title = title, description = description) } if (method == "mood") { ans = .moodTest(x, y, title = title, description = description) } # Return Value: ans } # ------------------------------------------------------------------------------ .ansariTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Ansari-Bradley's test for differences in scale # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Test: two.sided = .ansari2Test(x = x, y = y, alternative = "two.sided", exact = FALSE, conf.int = TRUE, conf.level = 0.95) less = .ansari2Test(x = x, y = y, alternative = "less", exact = FALSE, conf.int = TRUE, conf.level = 0.95) greater = .ansari2Test(x = x, y = y, alternative = "greater", exact = FALSE, conf.int = TRUE, conf.level = 0.95) two.sided.exact = .ansari2Test(x = x, y = y, alternative = "two.sided", exact = TRUE, conf.int = TRUE, conf.level = 0.95) less.exact = .ansari2Test(x = x, y = y, alternative = "less", exact = TRUE, conf.int = TRUE, conf.level = 0.95) greater.exact = .ansari2Test(x = x, y = y, alternative = "greater", exact = TRUE, conf.int = TRUE, conf.level = 0.95) # Statistic: STATISTIC = c(two.sided$statistic) names(STATISTIC) = "AB" test$statistic = STATISTIC # P Values: PVAL = c( two.sided$p.value, two.sided.exact$p.value, less$p.value, less.exact$p.value, greater$p.value, greater.exact$p.value) names(PVAL) = c( "Alternative Two-Sided ", "Alternative Two-Sided | Exact", "Alternative Less ", "Alternative Less | Exact", "Alternative Greater ", "Alternative Greater | Exact") test$p.values = PVAL # Confidence Levels: CONF.INT = cbind( a = two.sided$conf.int, b = two.sided.exact$conf.int, c = less$conf.int, d = less.exact$conf.int, e = greater$conf.int, f = greater.exact$conf.int) # For Splus compatibility use named a CONF.INT # and dimnames instead of colnames! dimnames(CONF.INT)[[2]] = c( "Two-Sided | Asymptotic ", "Two-Sided | Exact ", "Less | Asymptotic ", "Less | Exact ", "Greater | Asymptotic ", "Greater | Exact ") test$conf.int = CONF.INT # Add: if(is.null(title)) title = "Ansari-Bradley Test for Scale" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ .ansari2Test <- function(x, y, alternative = c("two.sided", "less", "greater"), exact = TRUE, conf.int = FALSE, conf.level = 0.95, ...) { # A function implemented by Diethelm Wuertz # Arguments: # x - numeric vector of data values. # y - numeric vector of data values. # alternative - indicates the alternative hypothesis and must # be one of "two.sided", "greater" or "less". You can specify # just the initial letter. # exact - a logical indicating whether an exact p-value should # be computed. # conf.int - a logical,indicating whether a confidence interval # should be computed. # conf.level - confidence level of the interval. # FUNCTION: # Return Value: ansari.test(x, y, alternative, exact, conf.int, conf.level, ...) } # ------------------------------------------------------------------------------ .moodTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs Mood's two-sample test for a difference in # scale parameters. # Arguments: # x, y - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Notes: # A modified copy originally from R's ctest package Version 1.8.1 # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Check Data: m = length(x) n = length(y) s = m + n if (s < 3) stop("not enough observations") # Statistic: r = rank(c(x, y)) # From R: # z = ((sum((r[1:length(x)] - (s + 1) / 2)^2) - m * (s^2 - 1) / 12) # / sqrt(m * n * (s + 1) * (s + 2) * (s - 2) / 180) ) # To run also under S-Plus use ... a = sum( (r[1:length(x)]-0.5*(s+1))^2 ) - m*(s*s-1)/12 b = sqrt(as.numeric(m) * n * (s + 1) * (s + 2) * (s - 2) / 180) STATISTIC = a/b names(STATISTIC) = "Z" test$statistic = STATISTIC # P Values: p = pnorm(STATISTIC) PVAL = c(2 * min(p, 1 - p), p, 1 - p) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater") test$p.value = PVAL # Add: if(is.null(title)) title = "Mood Two-Sample Test of Scale" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/R/dist-nigRobMoments.R0000644000176200001440000000631313202116742015675 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # nigMED Returns true NIG median # nigIQR Returns true NIG inter quartal range # nigSKEW Returns true NIG robust skewness # nigKURT Returns true NIG robust kurtosis ################################################################################ nigMED <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG median # FUNCTION: # NIG Median: Q = .qnigC(p=0.5, alpha, beta, delta, mu) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ nigIQR <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG inter quartal range # FUNCTION: # NIG Inter Quartile Range: Q = numeric() Q[1] = .qnigC(p=0.25, alpha, beta, delta, mu) Q[2] = .qnigC(p=0.75, alpha, beta, delta, mu) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ nigSKEW <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG robust skewness # FUNCTION: # NIG Robust Skewness: Q = numeric() Q[1] = .qnigC(p=0.25, alpha, beta, delta, mu) Q[2] = .qnigC(p=0.50, alpha, beta, delta, mu) Q[3] = .qnigC(p=0.75, alpha, beta, delta, mu) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ nigKURT <- function(alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG robust kurtosis # FUNCTION: # NIG Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, .qnigC(p, alpha, beta, delta, mu)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/test-normalityTest.R0000644000176200001440000006753713202116742016023 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ksnormTest One sample Kolmogorov-Smirnov normality test # shapiroTest Shapiro-Wilk normality test # jarqueberaTest Jarque-Bera normality test # dagoTest D'Agostino normality test # .skewness.test ... internal function called by dagoTest # .kurtosis.test ... internal function called by dagoTest # .omnibus.test ... internal function called by dagoTest # FUNCTION: DESCRIPTION: # normalTest Normality tests S-Plus compatible # FUNCTION: FROM NORTEST PACKAGE: # adTest Anderson-Darling normality test # cvmTest Cramer-von Mises normality test # lillieTest Lilliefors (Kolmogorov-Smirnov) normality test # pchiTest Pearson chi-square normality test # sfTest Shapiro-Francia normality test # FUNCTION ADDON: AUGMENTED FINITE SAMPLE JB TEST: # jbTest Performs finite sample adjusted JB LM and ALM test # .jb.test S3 version type finite sample adjusted JB test ################################################################################ ksnormTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs a one-sample Kolmogorov-Smirnov normality test # Arguments: # x - a numeric vector or an univariate 'timeSeries' object. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # FUNCTION: # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: test = ks.test(x, "pnorm", alternative = "two.sided") less = ks.test(x, "pnorm", alternative = "less") greater = ks.test(x, "pnorm", alternative = "greater") PVAL = c(test$p.value, less$p.value, greater$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater") test$metod = "Kolmogorov - Smirnow One Sample Normality Test" test$p.value = PVAL class(test) = "list" # Add: if (is.null(title)) title = test$method if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ shapiroTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Shapiro-Wilk test for normality. # Arguments: # x - a numeric vector or an univariate 'timeSeries' object. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Note: # A function linked to "stats" # FUNCTION: # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Works both in R and SPlus: test = shapiro.test(x) names(test$p.value) = "" class(test) = "list" # Add: if (is.null(title)) title = "Shapiro - Wilk Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ jarqueberaTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Jarque-Bera Test for Normality # Arguments: # x - a numeric vector or an univariate 'timeSeries' object. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Authors: # from A. Trapletti's tseries Package. # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: n = length(x) m1 = sum(x)/n m2 = sum((x-m1)^2)/n m3 = sum((x-m1)^3)/n m4 = sum((x-m1)^4)/n b1 = (m3/m2^(3/2))^2 b2 = (m4/m2^2) # Statistic: STATISTIC = n*b1/6+n*(b2-3)^2/24 names(STATISTIC) = "X-squared" # P Value: PVAL = 1 - pchisq(STATISTIC,df = 2) names(PVAL) = "Asymptotic p Value" # Method: METHOD = "Jarque Bera Test" # Result: test = list( statistic = STATISTIC, p.value = PVAL, method = METHOD, data.name = DNAME) # Add: if (is.null(title)) title = "Jarque - Bera Normalality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ .skewness.test <- function(x) { # Internal Function for D'Agostino Normality Test: # Note: # D'Agostino Test # http://adela.karlin.mff.cuni.cz/~klaster/vyuka/ # Materi???ly pro cvicen????, kter??? byla v labu, jsou zde: cv01.txt, # cv02.txt, cv03.txt, cv05.txt, cv06.txt, data maths, police a # vysky a makro dagost.r. V????ber nejak????ch pr????kladu ze cvicen???? je # tady. # Program R lze zdarma (GNU General Public Licence) st???hnout z # www.r-project.org. Alespon k letm???mu nahl???dnut???? doporucuji t???? # minimanu??/l An Introduction to R, kter???? roste tamt????. Dal????? # materi???ly vcetne dvou zac???tecnick????ch pr????rucek najdete na # str???nk???ch Dr. Kulicha. # FUNCTION: DNAME = deparse(substitute(x)) if (exists("complete.cases")) { test = complete.cases(x) } else { test = !is.na(x) } x = x[test] n = length(x) if (n < 8) stop("Sample size must be at least 8") meanX = mean(x) s = sqrt(mean((x-meanX)**2)) a3 = mean((x-meanX)**3)/s**3 SD3 = sqrt(6*(n-2)/((n+1)*(n+3))) U3 = a3/SD3 b = (3*(n**2+27*n-70)*(n+1)*(n+3))/((n-2)*(n+5)*(n+7)*(n+9)) W2 = sqrt(2*(b-1))-1 delta = 1/sqrt(log(sqrt(W2))) a = sqrt(2/(W2-1)) Z3 = delta*log((U3/a)+sqrt((U3/a)**2+1)) pZ3 = 2*(1-pnorm(abs(Z3),0,1)) names(Z3) = "Z3" # Result: RVAL = list( statistic = Z3, p.value = pZ3, method = "D'Agostino Skewness Normality Test", data.name = DNAME) # Return Value: class(RVAL) = "htest" RVAL } # ------------------------------------------------------------------------------ .kurtosis.test <- function(x) { # Internal Function for D'Agostino Normality Test: # FUNCTION: DNAME = deparse(substitute(x)) if (exists("complete.cases")) { test = complete.cases(x) } else { test = !is.na(x) } x = x[test] n = length(x) if (n < 20) stop("Sample size must be at least 20") meanX = mean(x) s = sqrt(mean((x-meanX)**2)) a4 = mean((x-meanX)**4)/s**4 SD4 = sqrt(24*(n-2)*(n-3)*n/((n+1)**2*(n+3)*(n+5))) U4 = (a4-3+6/(n+1))/SD4 B = (6*(n*n-5*n+2)/((n+7)*(n+9)))*sqrt((6*(n+3)*(n+5))/(n*(n-2)*(n-3))) A = 6+(8/B)*((2/B)+sqrt(1+4/(B**2))) jm = sqrt(2/(9*A)) pos = ((1-2/A)/(1+U4*sqrt(2/(A-4))))**(1/3) Z4 = (1-2/(9*A)-pos)/jm pZ4 = 2*(1-pnorm(abs(Z4),0,1)) names(Z4) = "Z4" # Result: RVAL = list( statistic = Z4, p.value = pZ4, method = "D'Agostino Kurtosis Normality Test", data.name = DNAME) # Return Value: class(RVAL) = "htest" RVAL } # ------------------------------------------------------------------------------ .omnibus.test <- function(x) { # Internal Function for D'Agostino Normality Test: # FUNCTION: DNAME = deparse(substitute(x)) if (exists("complete.cases")) { test = complete.cases(x) } else { test = !is.na(x) } x = x[test] n = length(x) if (n < 20) stop("sample size must be at least 20") meanX = mean(x) s = sqrt(mean((x-meanX)**2)) a3 = mean((x-meanX)**3)/s**3 a4 = mean((x-meanX)**4)/s**4 SD3 = sqrt(6*(n-2)/((n+1)*(n+3))) SD4 = sqrt(24*(n-2)*(n-3)*n/((n+1)**2*(n+3)*(n+5))) U3 = a3/SD3 U4 = (a4-3+6/(n+1))/SD4 b = (3*(n**2+27*n-70)*(n+1)*(n+3))/((n-2)*(n+5)*(n+7)*(n+9)) W2 = sqrt(2*(b-1))-1 delta = 1/sqrt(log(sqrt(W2))) a = sqrt(2/(W2-1)) Z3 = delta*log((U3/a)+sqrt((U3/a)**2+1)) B = (6*(n*n-5*n+2)/((n+7)*(n+9)))*sqrt((6*(n+3)*(n+5))/(n*(n-2)*(n-3))) A = 6+(8/B)*((2/B)+sqrt(1+4/(B**2))) jm = sqrt(2/(9*A)) pos = ((1-2/A)/(1+U4*sqrt(2/(A-4))))**(1/3) Z4 = (1-2/(9*A)-pos)/jm omni = Z3**2+Z4**2 pomni = 1-pchisq(omni,2) names(omni) = "Chi2" # Result: RVAL = list( statistic = omni, method = "D'Agostino Omnibus Normality Test", p.value = pomni, data.name = DNAME) # Return Value: class(RVAL) = "htest" RVAL } # ------------------------------------------------------------------------------ dagoTest = function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the D'Agostino normality test # Arguments: # x - a numeric vector or an univariate 'timeSeries' object. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Source: # This function was inspired by ... # http://adela.karlin.mff.cuni.cz/~klaster/vyuka/ # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: ans = NA test = .omnibus.test(x) skew = .skewness.test(x) kurt = .kurtosis.test(x) test$data.name = DNAME PVAL = c(test$p.value, skew$p.value, kurt$p.value) names(PVAL) = c( "Omnibus Test", "Skewness Test", "Kurtosis Test") test$p.value = PVAL STATISTIC = c(test$statistic, skew$statistic, kurt$statistic) names(STATISTIC) = c( "Chi2 | Omnibus", "Z3 | Skewness", "Z4 | Kurtosis") test$statistic = STATISTIC class(test) = "list" # Add: if (is.null(title)) title = "D'Agostino Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ normalTest <- function(x, method = c("sw", "jb"), na.rm = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Shapiro-Wilk and Jarque-Bera Test # Notes: # This function is for S-Plus compatibility # FUNCTION: # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) if (na.rm) x = x[!is.na(x)] # Method: # Don't use: method = match.arg(method) method = method[1] # Test: if (method == "sw") { ans = shapiroTest(x) } else if (method == "jb") { ans = jarqueberaTest(x) } # Additional Tests: if (method == "ks") { ans = ksnormTest(x) } if (method == "da") { ans = dagoTest(x) } if (method == "ad") { ans = adTest(x) } # Return Value: ans } ################################################################################ # FROM NORTEST PACKAGE: adTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Anderson-Darling normality test # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Source: # Package: nortest # Title: Tests for Normality # Version: 1.0 # Author: Juergen Gross # Description: 5 omnibus tests for the composite hypothesis of normality # Maintainer: Juergen Gross # License: GPL version 2 or newer # Thanks: # to Spencer Grave for contributions. # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: x = sort(x) n = length(x) if (n < 8) stop("sample size must be greater than 7") var.x <- var(x) if(var.x > 0){ p = pnorm((x - mean(x))/sqrt(var.x)) h = (2 * seq(1:n) - 1) * (log(p) + log(1 - rev(p))) ### DW modified: h = h[is.finite(h)] n = length(h) ### Continue: A = -n - mean(h) AA = (1 + 0.75/n + 2.25/n^2) * A if (AA < 0.2) { PVAL = 1 - exp(-13.436 + 101.14 * AA - 223.73 * AA^2) } else if (AA < 0.34) { PVAL = 1 - exp(-8.318 + 42.796 * AA - 59.938 * AA^2) } else if (AA < 0.6) { PVAL = exp(0.9177 - 4.279 * AA - 1.38 * AA^2) } else { PVAL = exp(1.2937 - 5.709 * AA + 0.0186 * AA^2) } # Result: if (PVAL > 1) { PVAL = 1 # was NA, suggested by Spencer Graves to modify W = NA } } else { A <- Inf PVAL <- 0 } names(PVAL) = "" test = list( statistic = c(A = A), p.value = PVAL, method = "Anderson - Darling Normality Test", data.name = DNAME) # Add: if (is.null(title)) title = "Anderson - Darling Normality Test" if (is.null(description)) description = description() # Return Value: ans = new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description)) } # ------------------------------------------------------------------------------ cvmTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Cramer-von Mises normality test # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Notes: # A copy from contributed R-package 'nortest' # Source: # Package: nortest # Title: Tests for Normality # Version: 1.0 # Author: Juergen Gross # Description: 5 omnibus tests for the composite hypothesis of normality # Maintainer: Juergen Gross # License: GPL version 2 or newer # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: x = sort(x) n = length(x) if (n < 8) stop("sample size must be greater than 7") p = pnorm((x - mean(x))/sqrt(var(x))) W = (1/(12 * n) + sum((p - (2 * seq(1:n) - 1)/(2 * n))^2)) WW = (1 + 0.5/n) * W # P Value: if (WW < 0.0275) { PVAL = 1 - exp(-13.953 + 775.5 * WW - 12542.61 * WW^2) } else if (WW < 0.051) { PVAL = 1 - exp(-5.903 + 179.546 * WW - 1515.29 * WW^2) } else if (WW < 0.092) { PVAL = exp(0.886 - 31.62 * WW + 10.897 * WW^2) } else { PVAL = exp(1.111 - 34.242 * WW + 12.832 * WW^2) } # Result: if (PVAL > 1) { PVAL = 1 W = NA } names(PVAL) = "" test = list( statistic = c(W = W), p.value = PVAL, method = "Cramer - von Mises Test", data.name = DNAME) # Add: if (is.null(title)) title = "Cramer - von Mises Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ lillieTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Lilliefors (Kolmogorov-Smirnov) normality test # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Notes: # A copy from contributed R-package 'nortest' # Source: # Package: nortest # Title: Tests for Normality # Version: 1.0 # Author: Juergen Gross # Description: 5 omnibus tests for the composite hypothesis of normality # Maintainer: Juergen Gross # License: GPL version 2 or newer # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: x = sort(x) n = length(x) if (n < 5) stop("sample size must be greater than 4") p = pnorm((x - mean(x))/sqrt(var(x))) Dplus = max(seq(1:n)/n - p) Dminus = max(p - (seq(1:n) - 1)/n) K = max(Dplus, Dminus) if (n <= 100) { Kd = K nd = n } else { Kd = K * ((n/100)^0.49) nd = 100 } # P Value: PVAL = exp(-7.01256 * Kd^2 * (nd + 2.78019) + 2.99587 * Kd * sqrt(nd + 2.78019) - 0.122119 + 0.974598/sqrt(nd) + 1.67997/nd) if (PVAL > 0.1) { KK = (sqrt(n) - 0.01 + 0.85/sqrt(n)) * K if (KK <= 0.302) { PVAL = 1 } else if (KK <= 0.5) { PVAL = 2.76773 - 19.828315 * KK + 80.709644 * KK^2 - 138.55152 * KK^3 + 81.218052 * KK^4 } else if (KK <= 0.9) { PVAL = -4.901232 + 40.662806 * KK - 97.490286 * KK^2 + 94.029866 * KK^3 - 32.355711 * KK^4 } else if (KK <= 1.31) { PVAL = 6.198765 - 19.558097 * KK + 23.186922 * KK^2 - 12.234627 * KK^3 + 2.423045 * KK^4 } else { PVAL = 0 } } names(PVAL) = "" # Result: test = list( statistic = c(D = K), p.value = PVAL, method = "Lilliefors Test", data.name = DNAME) # Add: if (is.null(title)) title = "Lilliefors (KS) Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ pchiTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Pearson chi-square normality test # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Details: # n.classes - an integer value, the classes are build is such # a way that they are equiprobable under the hypothesis # of normality. We use Moore's default value. # adjust - a logical flag, if TRUE (default), the p-value # is computed from a chi-square distribution with # n.classes-3 degrees of freedom, otherwise from a # chi-square distribution with n.classes-1 degrees of # freedom. We print the results for both # Notes: # A copy from contributed R-package 'nortest' # Source: # Package: nortest # Title: Tests for Normality # Version: 1.0 # Author: Juergen Gross # Description: 5 omnibus tests for the composite hypothesis of normality # Maintainer: Juergen Gross # License: GPL version 2 or newer # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Moore's Default Value: n.classes = ceiling(2 * (length(x)^(2/5))) names(n.classes) = "Number of Classes" # Test: n = length(x) dfd = c(2, 0) names(dfd) = c("TRUE", "FALSE") # adjust num = floor(1 + n.classes * pnorm(x, mean(x), sqrt(var(x)))) count = tabulate(num, n.classes) prob = rep(1/n.classes, n.classes) xpec = n * prob h = ((count - xpec)^2)/xpec P = sum(h) # For Splus compatibility: # pvalue = pchisq(P, n.classes - dfd - 1, lower.tail = FALSE) PVAL = c(1 - pchisq(P, n.classes - dfd[1] - 1), 1 - pchisq(P, n.classes - dfd[2] - 1)) names(PVAL) = c("Adhusted", "Not adjusted") # Return Value: test = list( statistic = c(P = P), p.value = PVAL, method = "Pearson Chi-Square Normality Test", data.name = DNAME, parameter = n.classes) # Add: if (is.null(title)) title = "Pearson Chi-Square Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ sfTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs the Shapiro-Francia normality test # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Notes: # A copy from contributed R-package 'nortest' # Source: # Package: nortest # Title: Tests for Normality # Version: 1.0 # Author: Juergen Gross # Description: 5 omnibus tests for the composite hypothesis of normality # Maintainer: Juergen Gross # License: GPL version 2 or newer # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Call: call = match.call() # Test: x = sort(x) n = length(x) if ((n < 5 || n > 5000)) stop("sample size must be between 5 and 5000") y = qnorm(ppoints(n, a = 3/8)) W = cor(x, y)^2 u = log(n) v = log(u) mu = -1.2725 + 1.0521 * (v - u) sig = 1.0308 - 0.26758 * (v + 2/u) z = (log(1 - W) - mu)/sig # For Splus compatibility: # pval = pnorm(z, lower.tail = FALSE) PVAL = 1 - pnorm(z) names(PVAL) = "" # Test: test = list( statistic = c(W = W), p.value = PVAL, method = "Shapiro-Francia Normality Test", data.name = DNAME) # Add: if (is.null(title)) title = "Shapiro - Francia Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description)) } ################################################################################ # AUGMENTED FINITE SAMPLE JB TEST: .jb.test <- function(x) { # A function implemented by Diethelm Wuertz # Description: # S3 version type finite sample adjusted JB test # Arguments: # Notes: # S3 Version type of test. # See also the Jarque-Bera test in Adrian Trapletti's # contributed "tseries" R package. # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Check: if (NCOL(x) > 1) stop("x is not a vector or univariate time series") if (any(is.na(x))) stop("NAs in x") # LM Coefficients: n = length(x) c1lm = 6/n c2lm = 3 c3lm = 24/n # ALM Coefficients: c1alm = 6*(n-2) / ((n+1)*(n+3)) c2alm = 3*(n-1) / (n+1) c3alm = 24*n*(n-2)*(n-3) / ((n+1)^2*(n+3)*(n+5)) # Statistic: m1 = sum(x)/n m2 = sum((x - m1)^2)/n m3 = sum((x - m1)^3)/n m4 = sum((x - m1)^4)/n b1 = (m3/m2^(3/2)) b2 = (m4/(m2*m2)) STATISTIC = b1*b1/c1lm + ((b2-c2lm)^2)/c3lm ALM = b1*b1/c1alm + ((b2-c2alm)^2)/c3alm names(STATISTIC) = "LM" # The rest goes as parameters ... pvalLM = 1 - .pjb(STATISTIC, N = n, type = "LM") pvalALM = 1 - .pjb(ALM, N = n, type = "ALM") PARAMETER = c(ALM, n, pvalLM, pvalALM) names(PARAMETER) = c( "ALM", "Sample Size", "LM p-value", "ALM p-value" ) # P Values: PVAL = 1 - pchisq(STATISTIC[1], df = 2) names(PVAL) = "" # Method String: METHOD = "Jarque Bera Test" # Result: Digits = 3 RVAL = list( statistic = round(STATISTIC, digits = Digits), parameter = round(PARAMETER, digits = Digits), p.value = round(PVAL, digits = Digits), method = METHOD, data.name = DNAME) # Return Value: class(RVAL) = "htest" RVAL } # ------------------------------------------------------------------------------ jbTest <- function(x, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs finite sample adjusted Jarque-Bera LM and ALM test # Arguments: # x - a univariate timeSeries object or numeric vector # Notes: # S3 Version type of test. # FUNCTION: # Data Set Name: DNAME = deparse(substitute(x)) # Call: call = match.call() # Convert Type: if (class(x) == "fREG") x = residuals(x) x = as.vector(x) # Test: test = .jb.test(x) class(test) = "list" parameter = test$parameter[2] statistic = c(test$statistic, test$parameter[1]) p.value = c(test$parameter[3], test$parameter[4], Asymptotic = test$p.value[[1]]) test$parameter = parameter test$statistic = statistic test$p.value = p.value # Add Title: if (is.null(title)) title = "Jarque - Bera Normality Test" if (is.null(description)) description = description() # Return Value: new("fHTEST", call = call, data = list(x = x), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/R/stats-interpKrige.R0000644000176200001440000000662613202116742015577 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # krigeInterp Kriges irregularly distributed data points # REQUIRE: DESCRIPTION: # spatial Functions for Kriging and Point Pattern ################################################################################ krigeInterp <- function(x, y = NULL, z = NULL, gridPoints = 21, xo = seq(min(x), max(x), length = gridPoints), yo = seq(min(y), max(y), length = gridPoints), extrap = FALSE, polDegree = 6) { # A function implemented by Diethelm Wuertz # Description: # Kriges Irregularly Distributed Data Points # Arguments: # x, y, z - either three numeric vectors of equal length or if # y and z are NULL, a list with entries x, y, a, or named # data.frame with x in the first, y in the second, and z in # the third column. # gridPoints - number of grid points in x and y direction. # xo, yo, a sequence of data points spanning the grid # extrap - a logical, if TRUE then the data points are extrapolated. # polDegree - polynomial degree, an integer ranging between 1 and 6. # Value: # A list with three elements, $x and $y which are vectors of length # 'gridPoints' and $z which is a matrix of size 'gridPoints^2'. # Example: # x <- runif(999)-0.5; y = runif(999)-0.5; z = cos(2*pi*(x^2+y^2)) # ans <- krigeInterp(x, y, z, extrap = FALSE) # persp(ans, theta = -50, phi = 30, col = "steelblue") # Note: # Requires recommended R Package "spatial" # FUNCTION: # Arguments: if (is.data.frame(x)) x <- as.matrix.data.frame(x) else if (is.list(x)) x <- matrix(unlist(x), ncol = 3) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } # Interpolate: krige <- spatial::surf.gls(np = polDegree, covmod = spatial::expcov, x = x, y = y, z = z, d = 0.5, alpha = 1) ans <- spatial::prmat(krige, xl = min(xo), xu = max(xo), yl = min(yo), yu = max(yo), n = gridPoints-1) # Extrapolate ? # - this should be done more efficiently if (!extrap) { E <- akimaInterp(x = x, y = y, z = z, gridPoints = gridPoints, extrap = extrap) ans$z[is.na(E$z)] <- NA } class(ans) <- "gridData" # Return Value: ans } ################################################################################ fBasics/R/matrix-rk.R0000644000176200001440000000261713202116742014072 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # rk Returns the rank of a matrix ################################################################################ rk <- function(x, method = c("qr", "chol")) { # A function implemented by Diethelm Wuertz # Description: # Returns the rank of a matrix # FUNCTION: # Rank: method = method[1] if (method == "chol") { ans = attr(chol(x, pivot = TRUE), "rank") } else { ans = qr(x)$rank } # Return Value: ans } ################################################################################ fBasics/R/dist-gldRobMoments.R0000644000176200001440000001055713202116742015673 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # gldMED Returns true GLD median # gldIQR Returns true GLD inter quartal range # gldSKEW Returns true GLD robust skewness # gldKURT Returns true GLD robust kurtosis ################################################################################ gldMED <- function(lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns true gld median # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # FUNCTION: # gld Median Q = qgld(p=0.5, lambda1, lambda2, lambda3, lambda4) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ gldIQR <- function(lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns true gld inter quartal range # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # FUNCTION: # gld Inter Quartile Range Q = numeric() Q[1] = qgld(p=0.25, lambda1, lambda2, lambda3, lambda4) Q[2] = qgld(p=0.75, lambda1, lambda2, lambda3, lambda4) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ gldSKEW <- function(lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns true gld robust gld skewness # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # FUNCTION: # gld Robust Skewness: Q = numeric() Q[1] = qgld(p=0.25, lambda1, lambda2, lambda3, lambda4) Q[2] = qgld(p=0.50, lambda1, lambda2, lambda3, lambda4) Q[3] = qgld(p=0.75, lambda1, lambda2, lambda3, lambda4) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ gldKURT <- function(lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns true gld robust gld kurtosis # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # FUNCTION: # gld Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, qgld(p, lambda1, lambda2, lambda3, lambda4)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/utils-decor.R0000644000176200001440000000777313202116742014416 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # decor Adds horizontal grid and L shaped box # hgrid Adds horizontal grid lines # vgrid Adds vertical grid lines # boxL Adds L-shaped box # box_ Adds unterlined box # .xrug Adds rugs on x axis # .yrug Adds rugs on y axis # copyright Adds copyright notice ################################################################################ decor <- function() { # A function implemented by Diethelm Wuertz # Description: # Adds a horizontal grid and L shaped box # FUNCTION: # Add: hgrid() boxL() # Return Value: invisible() } ################################################################################ hgrid <- function(ny = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Adds horizontal grid lines # FUNCTION: # Add: grid(NA, ny, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ vgrid <- function(nx = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Adds vertical grid lines # FUNCTION: # Add: grid(nx, NA, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ boxL <- function(col = "white") { # A function implemented by Diethelm Wuertz # Description: # Adds L-shaped box # Add: box() box(bty = "7", col = col) # Return Value: invisible() } # ------------------------------------------------------------------------------ box_ <- function(col = c("white", "black")) { # A function implemented by Diethelm Wuertz # Description: # Adds unterlined box # FUNCTION: # Add: box(bty = "c", col = col[1]) box(bty = "]", col = col[2]) box(bty = "7", col = col[1]) # Return Value: invisible() } # ------------------------------------------------------------------------------ .xrug <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Adds rugs on x axis # FUNCTION: # Add: rug(as.vector(x), ticksize = 0.01, side = 1, quiet = TRUE) # Return Value: invisible() } # ------------------------------------------------------------------------------ .yrug <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Adds rugs on y axis # FUNCTION: # Add: rug(as.vector(x), ticksize = 0.01, side = 2, quiet = TRUE) # Return Value: invisible() } # ------------------------------------------------------------------------------ copyright <- function() { # A function implemented by Diethelm Wuertz # Description: # Adds copyright notice # FUNCTION: # Add: Year = substr(Sys.Date(), 1, 4) mtext(paste("(c) Rmetrics", Year), side = 4, line = 0, adj = 0, font = 1, cex = 0.7*par("cex"), col = "grey") # Return Value: invisible() } ################################################################################ fBasics/R/dist-gldMode.R0000644000176200001440000000364213202116742014467 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # gldMode Computes the Generalized Lambda Distribution mode ################################################################################ gldMode <- function(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) { # A function implemented by Diethelm Wuertz # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Description: # Computes the Generalized Lambda Distribution mode # FUNCTION: # Find Maximum: min = qgld(0.01, lambda1, lambda2, lambda3, lambda4) max = qgld(0.99, lambda1, lambda2, lambda3, lambda4) ans = optimize(f = dgld, interval = c(min, max), lambda1 = lambda1, lambda2 = lambda2, lambda3 = lambda3, lambda4 = lambda4, maximum = TRUE, tol = .Machine$double.eps)$maximum # Return Value: ans } ################################################################################ fBasics/R/utils-colorPalettes.R0000644000176200001440000005673713202116742016146 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: COLOR PALETTES: # rainbowPalette Creates a rainbow color palette # heatPalette Creates a heat color palette # terrainPalette Creates a terrain color palette # topoPalette Creates a topo color palette # cmPalette Creates a cm color palette # greyPalette Creates a grey palette # timPalette Creates a cyan, yellow, to orange palette # FUNCTION: COLOR RAMPS: # rampPalette Creates a color ramp palette # seqPalette Creates a sequential color palette # divPalette Creates a diverging color palette # qualiPalette Creates a qualitative color palette # focusPalette Creates a focus color palette # monoPalette Creates a mono color palette ################################################################################ ################################################################################ # FUNCTION: DESCRIPTION: # rainbowPalette Creates a rainbow color palette # heatPalette Creates a heat color palette # terrainPalette Creates a terrain color palette # topoPalette Creates a topo color palette # cmPalette Creates a cm color palette rainbowPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: rainbow(n = n, ...) } # ------------------------------------------------------------------------------ heatPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: heat.colors(n, ...) } # ------------------------------------------------------------------------------ terrainPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: terrain.colors(n, ...) } # ------------------------------------------------------------------------------ topoPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: topo.colors(n, ...) } # ------------------------------------------------------------------------------ cmPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Return Value: cm.colors(n, ...) } ################################################################################ # FUNCTION: COLOR/GREY PALETTES: # greyPalette Creates a grey palette # timPalette Creates a cyan, yellow, to orange palette greyPalette <- function(n = 64, ...) { # A function implemented by Diethelm Wuertz # Description: # Create a vector of n gamma-corrected gray colors. # Arguments: # n - the number of greys to be constructed # start, end - the range of the color palette # gamma a gamma-correction # Value: # returns a grey palette like rainbow does # for color palettes # FUNCTION: # Compose: ans = gray.colors(n, ...) # Return Value: ans } # ------------------------------------------------------------------------------ timPalette <- function(n = 64) { # A function implemented by Diethelm Wuertz # Description: # Creates a cyan, yellow, to orange palette # Notes: # 'Tim.colors' in 'fields' package goes from blue to red, and passes # through the colors cyan, yellow, and orange. Also known as Jet # color-map in Matlab. You can also easily design your own color map # using 'rgb' function from 'gdDevices'. # From: # FUNCTION: orig = c( "#00008F", "#00009F", "#0000AF", "#0000BF", "#0000CF", "#0000DF", "#0000EF", "#0000FF", "#0010FF", "#0020FF", "#0030FF", "#0040FF", "#0050FF", "#0060FF", "#0070FF", "#0080FF", "#008FFF", "#009FFF", "#00AFFF", "#00BFFF", "#00CFFF", "#00DFFF", "#00EFFF", "#00FFFF", "#10FFEF", "#20FFDF", "#30FFCF", "#40FFBF", "#50FFAF", "#60FF9F", "#70FF8F", "#80FF80", "#8FFF70", "#9FFF60", "#AFFF50", "#BFFF40", "#CFFF30", "#DFFF20", "#EFFF10", "#FFFF00", "#FFEF00", "#FFDF00", "#FFCF00", "#FFBF00", "#FFAF00", "#FF9F00", "#FF8F00", "#FF8000", "#FF7000", "#FF6000", "#FF5000", "#FF4000", "#FF3000", "#FF2000", "#FF1000", "#FF0000", "#EF0000", "#DF0000", "#CF0000", "#BF0000", "#AF0000", "#9F0000", "#8F0000", "#800000") if (n == 64) return(orig) rgb.tim = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , 64) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb.tim[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } ans = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: ans } ################################################################################ # Package: colorRamps # Type: Package # Title: Builds pleasing color tables # Version: 1.0 # Date: 2007-04-05 # Author: Tim Keitt # Maintainer: Tim Keitt # Description: Builds single and double gradient color maps # License: GPL # Packaged: Thu Apr 5 16:34:42 2007; tkeitt .blue2redPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: n2 = ceiling(n / 2) red = rep(c(0, 1), each = n2)[1:n] green = 1 - abs(seq(-1, 1, length.out = n)) blue = rev(red) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ .green2redPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: n2 = ceiling(n / 2) red = rep(c(0, 1), each = n2)[1:n] blue = 1 - abs(seq(-1, 1, length.out = n)) green = rev(red) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ .blue2greenPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: n2 = ceiling(n / 2) green = rep(c(0, 1), each = n2)[1:n] red = 1 - abs(seq(-1, 1, length.out = n)) blue = rev(green) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ .purple2greenPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: red = rep(0.5, length.out = n) green = seq(0, 1, length.out = n) blue = rev(green) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ .blue2yellowPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: red = seq(0, 1, length.out = n) green = red blue = rev(red) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ .cyan2magentaPalette <- function(n) { # A copy from contributed R-package colorRamps # FUNCTION: # Color Ramp: red = seq(0, 1, length.out = n) green = rev(red) blue = rep(1, n) # Return Value: rgb(red, green, blue) } # ------------------------------------------------------------------------------ rampPalette <- function(n, name = c("blue2red", "green2red", "blue2green", "purple2green", "blue2yellow", "cyan2magenta")) { # Description: # Creates a color ramp palette # FUNCTION: # Color Ramp: name = match.arg(name) funPalette = match.fun(paste(".", name, "Palette", sep = "")) ans = funPalette(n) # Return Value: ans } ################################################################################ # Package: RColorBrewer # Version: 1.0-2 # Date: 2007-10-21 # Title: ColorBrewer palettes # Author: Erich Neuwirth # Maintainer: Erich Neuwirth # Depends: R (>= 2.0.0) # Description: The packages provides palettes for drawing nice maps # shaded according to a variable. # License: Apache License 2.0 seqPalette <- function(n, name = c("Blues", "BuGn", "BuPu", "GnBu", "Greens", "Greys", "Oranges", "OrRd", "PuBu", "PuBuGn", "PuRd", "Purples", "RdPu", "Reds", "YlGn", "YlGnBu", "YlOrBr", "YlOrRd")) { # A function implemented by Diethelm Wuertz # Description: # Creates a sequential color palette # FUNCTION: # Color Sets: # Blues, BuGn, BuPu, GnBu, Greens, Greys, Oranges, OrRd, PuBu, # PuBuGn, PuRd, Purples, RdPu, Reds, YlGn, YlGnBu, YlOrBr, YlOrRd. Blues = rgb(c(247,222,198,158,107,66,33,8,8), c(251,235,219,202,174,146,113,81,48), c(255,247,239,225,214,198,181,156,107),maxColorValue=255) BuGn = rgb(c(247,229,204,153,102,65,35,0,0), c(252,245,236,216,194,174,139,109,68), c(253,249,230,201,164,118,69,44,27),maxColorValue=255) BuPu = rgb(c(247,224,191,158,140,140,136,129,77), c(252,236,211,188,150,107,65,15,0), c(253,244,230,218,198,177,157,124,75),maxColorValue=255) GnBu = rgb(c(247,224,204,168,123,78,43,8,8), c(252,243,235,221,204,179,140,104,64), c(240,219,197,181,196,211,190,172,129),maxColorValue=255) Greens = rgb(c(247,229,199,161,116,65,35,0,0), c(252,245,233,217,196,171,139,109,68), c(245,224,192,155,118,93,69,44,27),maxColorValue=255) Greys = rgb(c(255,240,217,189,150,115,82,37,0), c(255,240,217,189,150,115,82,37,0), c(255,240,217,189,150,115,82,37,0),maxColorValue=255) Oranges = rgb(c(255,254,253,253,253,241,217,166,127), c(245,230,208,174,141,105,72,54,39), c(235,206,162,107,60,19,1,3,4),maxColorValue=255) OrRd = rgb(c(255,254,253,253,252,239,215,179,127), c(247,232,212,187,141,101,48,0,0), c(236,200,158,132,89,72,31,0,0),maxColorValue=255) PuBu = rgb(c(255,236,208,166,116,54,5,4,2), c(247,231,209,189,169,144,112,90,56), c(251,242,230,219,207,192,176,141,88),maxColorValue=255) PuBuGn = rgb(c(255,236,208,166,103,54,2,1,1), c(247,226,209,189,169,144,129,108,70), c(251,240,230,219,207,192,138,89,54),maxColorValue=255) PuOr = rgb(c(127,179,224,253,254,247,216,178,128,84,45), c(59,88,130,184,224,247,218,171,115,39,0), c(8,6,20,99,182,247,235,210,172,136,75),maxColorValue=255) PuRd = rgb(c(247,231,212,201,223,231,206,152,103), c(244,225,185,148,101,41,18,0,0), c(249,239,218,199,176,138,86,67,31),maxColorValue=255) Purples = rgb(c(252,239,218,188,158,128,106,84,63), c(251,237,218,189,154,125,81,39,0), c(253,245,235,220,200,186,163,143,125),maxColorValue=255) RdPu = rgb(c(255,253,252,250,247,221,174,122,73), c(247,224,197,159,104,52,1,1,0), c(243,221,192,181,161,151,126,119,106),maxColorValue=255) Reds = rgb(c(255,254,252,252,251,239,203,165,103), c(245,224,187,146,106,59,24,15,0), c(240,210,161,114,74,44,29,21,13),maxColorValue=255) YlGn = rgb(c(255,247,217,173,120,65,35,0,0), c(255,252,240,221,198,171,132,104,69), c(229,185,163,142,121,93,67,55,41),maxColorValue=255) YlGnBu = rgb(c(255,237,199,127,65,29,34,37,8), c(255,248,233,205,182,145,94,52,29), c(217,177,180,187,196,192,168,148,88),maxColorValue=255) YlOrBr = rgb(c(255,255,254,254,254,236,204,153,102), c(255,247,227,196,153,112,76,52,37), c(229,188,145,79,41,20,2,4,6),maxColorValue=255) YlOrRd = rgb(c(255,255,254,254,253,252,227,189,128), c(255,237,217,178,141,78,26,0,0), c(204,160,118,76,60,42,28,38,38),maxColorValue=255) # Compose: name = match.arg(name) orig = eval(parse(text = name)) rgb = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , length(orig)) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } palette = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: palette } # ------------------------------------------------------------------------------ divPalette <- function(n, name = c("BrBG", "PiYG", "PRGn", "PuOr", "RdBu", "RdGy", "RdYlBu", "RdYlGn", "Spectral")) { # A function implemented by Diethelm Wuertz # Description: # Creates a diverging color palette # FUNCTION: # Color Sets: # BrBG, PiYG, PRGn, PuOr, RdBu, RdGy, RdYlBu, RdYlGn, Spectral. BrBG = rgb(c(84,140,191,223,246,245,199,128,53,1,0), c(48,81,129,194,232,245,234,205,151,102,60), c(5,10,45,125,195,245,229,193,143,94,48),maxColorValue=255) PiYG = rgb(c(142,197,222,241,253,247,230,184,127,77,39), c(1,27,119,182,224,247,245,225,188,146,100), c(82,125,174,218,239,247,208,134,65,33,25),maxColorValue=255) PRGn = rgb(c(64,118,153,194,231,247,217,166,90,27,0), c(0,42,112,165,212,247,240,219,174,120,68), c(75,131,171,207,232,247,211,160,97,55,27),maxColorValue=255) PuOr = rgb(c(127,179,224,253,254,247,216,178,128,84,45), c(59,88,130,184,224,247,218,171,115,39,0), c(8,6,20,99,182,247,235,210,172,136,75),maxColorValue=255) RdBu = rgb(c(103,178,214,244,253,247,209,146,67,33,5), c(0,24,96,165,219,247,229,197,147,102,48), c(31,43,77,130,199,247,240,222,195,172,97),maxColorValue=255) RdGy = rgb(c(103,178,214,244,253,255,224,186,135,77,26), c(0,24,96,165,219,255,224,186,135,77,26), c(31,43,77,130,199,255,224,186,135,77,26),maxColorValue=255) RdYlBu = rgb(c(165,215,244,253,254,255,224,171,116,69,49), c(0,48,109,174,224,255,243,217,173,117,54), c(38,39,67,97,144,191,248,233,209,180,149),maxColorValue=255) RdYlGn = rgb(c(165,215,244,253,254,255,217,166,102,26,0), c(0,48,109,174,224,255,239,217,189,152,104), c(38,39,67,97,139,191,139,106,99,80,55),maxColorValue=255) Spectral = rgb(c(158,213,244,253,254,255,230,171,102,50,94), c(1,62,109,174,224,255,245,221,194,136,79), c(66,79,67,97,139,191,152,164,165,189,162),maxColorValue=255) # Compose: name = match.arg(name) orig = eval(parse(text = name)) rgb = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , length(orig)) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } palette = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: palette } # ------------------------------------------------------------------------------ qualiPalette <- function(n, name = c("Accent", "Dark2", "Paired", "Pastel1", "Pastel2", "Set1", "Set2", "Set3")) { # A function implemented by Diethelm Wuertz # Description: # Creates a qualitative color palette # FUNCTION: # Color Sets: Accent = rgb(c(127,190,253,255,56,240,191,102), c(201,174,192,255,108,2,91,102), c(127,212,134,153,176,127,23,102),maxColorValue=255) Dark2 = rgb(c(27,217,117,231,102,230,166,102), c(158,95,112,41,166,171,118,102), c(119,2,179,138,30,2,29,102),maxColorValue=255) Paired = rgb(c(166,31,178,51,251,227,253,255,202,106,255,177), c(206,120,223,160,154,26,191,127,178,61,255,89), c(227,180,138,44,153,28,111,0,214,154,153,40),maxColorValue=255) Pastel1 = rgb(c(251,179,204,222,254,255,229,253,242), c(180,205,235,203,217,255,216,218,242), c(174,227,197,228,166,204,189,236,242),maxColorValue=255) Pastel2 = rgb(c(179,253,203,244,230,255,241,204), c(226,205,213,202,245,242,226,204), c(205,172,232,228,201,174,204,204),maxColorValue=255) Set1 = rgb(c(228,55,77,152,255,255,166,247,153), c(26,126,175,78,127,255,86,129,153), c(28,184,74,163,0,51,40,191,153),maxColorValue=255) Set2 = rgb(c(102,252,141,231,166,255,229,179), c(194,141,160,138,216,217,196,179), c(165,98,203,195,84,47,148,179),maxColorValue=255) Set3 = rgb(c(141,255,190,251,128,253,179,252,217,188,204,255), c(211,255,186,128,177,180,222,205,217,128,235,237), c(199,179,218,114,211,98,105,229,217,189,197,111),maxColorValue=255) # Compose: name = match.arg(name) orig = eval(parse(text = name)) rgb = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , length(orig)) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } palette = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: palette } ################################################################################ # Package: PerformanceAnalytics # Type: Package # Title: Econometric tools for performance and risk analysis. # Version: 0.9.5 # Date: 2007-06-29 # Author: Peter Carl, Brian G. Peterson # Maintainer: Brian G. Peterson # Description: Library of econometric functions for performance and risk # analysis. This library aims to aid practitioners and researchers in # utilizing the latest research in analysis of non-normal return streams. # In general, this library is most tested on return (rather than price) # data on a monthly scale, but most functions will work with daily or # irregular return data as well. # Depends: R (>= 2.4.0), fExtremes, fPortfolio, quadprog, tseries, Hmisc # License: GPL # URL: http://braverock.com/R/ # Packaged: Tue Jul 10 04:30:47 2007 focusPalette <- function(n, name = c("redfocus", "greenfocus", "bluefocus")) { # A function implemented by Diethelm Wuertz # Description: # Creates a color palette for graphs # Source: # Contributed R package PerformanceAnalytics # Details: # This is not a function, per se, but a way to set up specific color # pallets for use in the charts we use. These pallets have been # designed to create readable, comparable line and bar graphs with # specific objectives outlined before each category below. # We use this approach rather than generating them on the fly for two # reasons: 1) fewer dependencies on libraries that don't need to be # called dynamically; and 2) to guarantee the color used for the n-th # column of data. # # FOCUS PALETTE # Colorsets designed to provide focus to the data graphed as the first # element. This palette is best used when there is clearly an important # data set for the viewer to focus on, with the remaining data being # secondary, tertiary, etc. Later elements graphed in diminishing # values of gray. These were generated with RColorBrewer, using the 8 # level "grays" palette and replacing the darkest with the focus color. # For best results, replace the highlight color with the first color # of the equal weighted palette from below. This will coordinate # charts with different purposes. # # MONOCHROME PALETTES: # Colorsets for monochrome color displays. # FUNCTION: # Match Arguments: name = match.arg(name) # Focus Palettes: redfocus = c( "#CB181D", "#252525", "#525252", "#737373", "#969696", "#BDBDBD", "#D9D9D9", "#F0F0F0") greenfocus = c( "#41AB5D", "#252525", "#525252", "#737373", "#969696", "#BDBDBD", "#D9D9D9", "#F0F0F0") bluefocus = c( "#0033FF", "#252525", "#525252", "#737373", "#969696", "#BDBDBD", "#D9D9D9", "#F0F0F0") # Compose: orig = eval(parse(text = name)) rgb = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , length(orig)) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } palette = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: palette } # ------------------------------------------------------------------------------ monoPalette <- function(n, name = c("redmono", "greenmono", "bluemono")) { # A function implemented by Diethelm Wuertz # Description: # Creates a mono color palette # Source: # Contributed R package PerformanceAnalytics # FUNCTION: # Match Arguments: name = match.arg(name) # Monochrome Palettes: redmono = c( "#99000D", "#CB181D", "#EF3B2C", "#FB6A4A", "#FC9272", "#FCBBA1", "#FEE0D2", "#FFF5F0") greenmono = c( "#005A32", "#238B45", "#41AB5D", "#74C476", "#A1D99B", "#C7E9C0", "#E5F5E0", "#F7FCF5") bluemono = c( "#084594", "#2171B5", "#4292C6", "#6BAED6", "#9ECAE1", "#C6DBEF", "#DEEBF7", "#F7FBFF") # Compose: orig = eval(parse(text = name)) rgb = t(col2rgb(orig)) temp = matrix(NA, ncol = 3, nrow = n) x = seq(0, 1, , length(orig)) xg = seq(0, 1, , n) for (k in 1:3) { hold = spline(x, rgb[, k], n = n)$y hold[hold < 0] = 0 hold[hold > 255] = 255 temp[, k] = round(hold) } palette = rgb(temp[, 1], temp[, 2], temp[, 3], maxColorValue = 255) # Return Value: palette } ################################################################################ fBasics/R/plot-seriesPlot.R0000644000176200001440000001044613202116741015257 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # seriesPlot Dispalys a time Series Plot # cumulatedPlot Displays a cumulated series given the returns # returnPlot Displays returns given the cumulated series # drawdownPlot Displays drawdown series from returns ################################################################################ seriesPlot <- function(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Dispalys a time Series Plot # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) N = NCOL(x) Units = colnames(x) if (length(col) == 1) col = rep(col, times = N) # Series Plots: for (i in 1:N) { X = x[, i] plot(x = X, type = type, col = col[i], ann = FALSE, ...) # Add Title: if (title) { title(main = Units[i], xlab = "Time", ylab = "Value") } else { title(...) } # Add Grid: if(grid) grid() # Add Box: if(box) box() # Add Rugs: if(rug) rug(as.vector(X), ticksize = 0.01, side = 2, quiet = TRUE) } # Return Value: invisible() } # ------------------------------------------------------------------------------ cumulatedPlot <- function(x, index = 100, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a cumulated series given the returns # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) x = index * exp(colCumsums(x)) seriesPlot(x, labels = labels, type = type, col = col, title = title, grid = grid, box = box, rug = rug, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ returnPlot <- function(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays returns given the cumulated series # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) x = returns(x, ...) seriesPlot(x, labels = labels, type = type, col = col, title = title, grid = grid, box = box, rug = rug, ...) # Return Value: invisible() } # ------------------------------------------------------------------------------ drawdownPlot <- function(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays drawdowns given the return series # FUNCTION: # timeSeries: stopifnot(is.timeSeries(x)) x = drawdowns(x, ...) seriesPlot(x, labels = labels, type = type, col = col, title = title, grid = grid, box = box, rug = rug, ...) # Return Value: invisible() } ################################################################################ fBasics/R/stats-interpLinear.R0000644000176200001440000001224413202116742015741 0ustar liggesusers# This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: BIVARIATE GRIDDED INTERPOLATION: # linearInterp Interpolates linearly irregularly spaced data points # linearInterpp Interpolates linearly pointwise ################################################################################ linearInterp <- function(x, y = NULL, z = NULL, gridPoints = 21, xo = seq(min(x), max(x), length = gridPoints), yo = seq(min(y), max(y), length = gridPoints)) { # A function implemented by Diethelm Wuertz # Description: # Interpolates Linearly Irregularly Distributed Data Points # Arguments: # x, y, z - either three numeric vectors of equal length or if # y and z are NULL, a list with entries x, y, a, or named # data.frame with x in the first, y in the second, and z in # the third column. # gridPoints - number of grid points in x and y direction. # xo, yo, a sequence of data points spanning the grid # Note: # Extrapolation is not possible in the case of linear interpolation. # Value: # A list with three elements, $x and $y which are vectors of length # 'gridPoints' and $z which is a matrix of size 'gridPoints^2'. # Requirements: # akima Builtin Fortran Code. # Example: # set.seed(1953) # x = runif(999)-0.5; y = runif(999)-0.5; z = cos(2*pi*(x^2+y^2)) # ans = linearInterp(x, y, z) # persp(ans, theta = -50, phi = 30, col = "steelblue") # Note: # Uses Fortran akima Builtin # FUNCTION: if (!requireNamespace("akima", quietly = TRUE)) stop("Needs Package 'akima' which is not auto-installed because of a different licence\n") # Arguments: if (is.data.frame(x)) x <- as.matrix.data.frame(x) else if (is.list(x)) x <- matrix(unlist(x), ncol = 3) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } # Interpolation: ans <- akima::interp(x, y, z, xo, yo, linear = TRUE, extrap = FALSE, duplicate = "median", dupfun = NULL) colnames(ans$z) <- as.character(signif(ans$x, round(log(gridPoints), 0))) rownames(ans$z) <- as.character(signif(ans$y, round(log(gridPoints), 0))) class(ans) <- "gridData" # Return Value: ans } # ------------------------------------------------------------------------------ linearInterpp <- function(x, y = NULL, z = NULL, xo, yo) { # A function implemented by Diethelm Wuertz # Description: # Interpolates Linearly Irregularly Distributed Data Points # Arguments: # x, y, z - either three numeric vectors of equal length or if # y and z are NULL, a list with entries x, y, a, or named # data.frame with x in the first, y in the second, and z in # the third column. # gridPoints - number of grid points in x and y direction. # xo, yo, a sequence of data points for pointwise interpolation # Note: # Extrapolation is not possible in the case of linear interpolation. # Value: # A list with three elements, $x and $y which are vectors of length # 'gridPoints' and $z which is a matrix of size 'gridPoints^2'. # Requirements: # akima Builtin Fortran Code. # Example: # set.seed(1953) # x = runif(999)-0.5; y = runif(999)-0.5; z = cos(2*pi*(x^2+y^2)) # ans = linearInterpp(x, y, z, c(mean(x), 0, 100), c(mean(y), 0, 100)) # persp(ans, theta = -50, phi = 30, col = "steelblue") # Note: # Uses Fortran akima Builtin # FUNCTION: if (!requireNamespace("akima", quietly = TRUE)) stop("Needs Package 'akima' which is not auto-installed because of a different licence\n") # Arguments: if (is.data.frame(x)) x <- as.matrix.data.frame(x) else if (is.list(x)) x <- matrix(unlist(x), ncol = 3) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } # Interpolation: interpp <- eval(parse(text=paste0("akima",":::","interpp"))) ans <- interpp(x, y, z, xo, yo, linear = TRUE, extrap = FALSE, duplicate = "median", dupfun = NULL) ## Return data.frame(x = ans$x, y = ans$y, z = ans$z) } ################################################################################ fBasics/R/builtin-gmmGmm.R0000644000176200001440000004521513202116742015042 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # .gmm # .HAC # .weightsAndrews2 # .bwAndrews2 # .summary.gmm # .lintest ################################################################################ # Code borrowed from # R's contributed package "gmm" written by Pierre Chausse. # Rmetrics: # Note that gmm is not available on Debian as of 2009-04-28. # To run these functions under Debian/Rmetrics we have them # implemented here as a builtin. # We also made modifications for tailored usage with Rmetrics. # Note that the dependences in the original package requires zoo # which may create conflicts with Rmetrics timeDate/timeSeries. # Package: gmm # Version: 1.0-4 # Date: 2009-03-10 # Title: Generalized Method of Moments and Generalized Empirical Likelihood # Author: Pierre Chausse # Maintainer: Pierre Chausse # Description: It is a complete suite to estimate models based on moment # conditions. It includes the two step Generalized method of moments # (GMM) of Hansen(1982), the iterated GMM and continuous updated # estimator (CUE) of Hansen-Eaton-Yaron(1996) and several methods that # belong to the Generalized Empirical Likelihood (GEL) family of estimators, # as presented by Smith(1997), Kitamura(1997), Newey-Smith(2004) and # Anatolyev(2005). # Depends: R (>= 2.0.0), sandwich, tseries, mvtnorm # Imports: stats # License: GPL (>= 2) # ------------------------------------------------------------------------------ .gmm <- function(g, x, t0=NULL, gradv=NULL, type=c("twoStep","cue","iterative"), wmatrix = c("optimal","ident"), vcov=c("HAC","iid"), kernel=c("Quadratic Spectral","Truncated", "Bartlett", "Parzen", "Tukey-Hanning"),crit=10e-7,bw = .bwAndrews2, prewhite = FALSE, ar.method = "ols", approx="AR(1)",tol = 1e-7, itermax=100,intercept=TRUE,optfct=c("optim","optimize"), ...) { type <- match.arg(type) kernel <- match.arg(kernel) vcov <- match.arg(vcov) wmatrix <- match.arg(wmatrix) optfct <- match.arg(optfct) typeg=0 if (is(g,"formula")) { typeg=1 dat <- .get_dat(g,x,intercept=intercept) x <- dat$x g <- function(tet,x,ny=dat$ny,nh=dat$nh,k=dat$k) { tet <- matrix(tet,ncol=k) if (intercept) { e <- x[,1:ny] - x[,(ny+1):(ny+k)]%*%t(tet) gt <- e for (i in 2:nh) { gt <- cbind(gt,e*x[,(ny+k+i)]) } } if (!intercept) e <- x[,1:ny] - x[,(ny+1):(ny+k)]%*%t(tet) gt <- e*x[,ny+k+1] if (nh > 1) { for (i in 2:nh) { gt <- cbind(gt,e*x[,(ny+k+i)]) } } return(gt) } gradv <- function(x,ny=dat$ny,nh=dat$nh,k=dat$k) { dgb <- -(t(x[,(ny+k+1):(ny+k+nh)])%*%x[,(ny+1):(ny+k)])%x% diag(rep(1,ny))/nrow(x) return(dgb) } tetlin <- function(x,w,ny=dat$ny,nh=dat$nh,k=dat$k) { n <- nrow(x) ym <- as.matrix(x[,1:ny]) xm <- as.matrix(x[,(ny+1):(ny+k)]) hm <- as.matrix(x[,(ny+k+1):(ny+k+nh)]) whx <- solve(w,(crossprod(hm,xm)%x%diag(ny))) wvecyh <- solve(w,matrix(crossprod(ym,hm),ncol=1)) dg <- gradv(x) xx <- crossprod(dg,whx) par <- solve(xx,crossprod(dg,wvecyh)) gb <- matrix(colSums(g(par,x))/n,ncol=1) value <- crossprod(gb,solve(w,gb)) res <- list(par=par,value=value) return(res) } } if (optfct == "optimize") { n = nrow(g(t0[1],x)) q = ncol(g(t0[1],x)) k = 1 k2 <- k df <- q-k } else { if (typeg) { k <- dat$k k2 <- k*dat$ny n <- nrow(x) q <- dat$ny*dat$nh df <- q-k*dat$ny } else { n = nrow(g(t0,x)) q = ncol(g(t0,x)) k = length(t0) k2 <- k df <- q-k } } obj1 <- function(thet) { gt <- g(thet,x) gbar <- as.vector(colMeans(gt)) obj <- crossprod(gbar,solve(w,gbar)) return(obj) } iid <- function(thet) { gt <- g(thet,x) v <- crossprod(gt,gt)/n return(v) } Gf <- function(thet) { myenv <- new.env() assign('x',x,envir=myenv) assign('thet',thet,envir=myenv) barg <- function(x,thet) { gt <- g(thet,x) gbar <- as.vector(colMeans(gt)) return(gbar) } G <- attr(numericDeriv(quote(barg(x,thet)),"thet",myenv),"gradient") return(G) } if (q == k2 | wmatrix == "ident") { if (typeg) { w <- diag(q) res <- tetlin(x,w) z = list(par=res$par,objective=res$value) } else { w=diag(rep(1,q)) if (optfct == "optim") res <- optim(t0,obj1, ...) else { res <- optimize(obj1,t0, ...) res$par <- res$minimum res$value <- res$objective } z = list(par=res$par,objective=res$value) } } else { if (type=="twoStep") { w=diag(rep(1,q)) if (typeg) { res1 <- tetlin(x,w) } else { if (optfct == "optim") res1 <- optim(t0,obj1, ...) else { res1 <- optimize(obj1,t0, ...) res1$par <- res1$minimum res1$value <- res1$objective } } if (vcov == "iid") w <- iid(res1$par) if (vcov == "HAC") w <- .HAC(g(res1$par,x), kernel=kernel, bw=bw, prewhite=prewhite,ar.method=ar.method,approx=approx,tol=tol) if (typeg) { res2 <- tetlin(x,w) } else { if (optfct == "optim") res2 <- optim(res1$par,obj1, ...) else { res2 <- optimize(obj1,t0, ...) res2$par <- res2$minimum res2$value <- res2$objective } } z = list(par=res2$par,objective=res2$value) } if (type=="cue") { obj_cue <- function(thet) { gt <- g(thet,x) gbar <- as.vector(colMeans(gt)) if (vcov == "iid") w2 <- iid(thet) if (vcov == "HAC") w2 <- .HAC(g(thet,x), kernel=kernel, bw=bw, prewhite=prewhite,ar.method=ar.method,approx=approx,tol=tol) obj <- crossprod(gbar,solve(w2,gbar)) return(obj) } if (typeg) { if (is.null(t0)) t0 <- tetlin(x,diag(rep(1,q)))$par if (optfct == "optim") { res2 <- optim(t0,obj_cue, ...) } else { res2 <- optimize(obj_cue,t0, ...) res2$par <- res2$minimum res2$value <- res2$objective } } else { if (optfct == "optim") res2 <- optim(t0,obj_cue, ...) else { res2 <- optimize(obj_cue,t0, ...) res2$par <- res2$minimum res2$value <- res2$objective } } z = list(par=res2$par,objective=res2$value) } if (type=="iterative") { w=diag(rep(1,q)) if (typeg) res <- tetlin(x,w) else { if (optfct == "optim") res <- optim(t0,obj1, ...) else { res <- optimize(obj1,t0, ...) res$par <- res$minimum res$value <- res$objective } } ch <- 100000 j <- 1 while(ch>crit) { tet <- res$par if (vcov == "iid") w2 <- iid(tet) if (vcov == "HAC") w2 <- .HAC(g(tet,x), kernel=kernel, bw=bw, prewhite=prewhite,ar.method=ar.method,approx=approx,tol=tol) if (typeg) res <- tetlin(x,w2) else { if (optfct == "optim") res <- optim(tet,obj1, ...) else { res <- optimize(obj1,t0, ...) res$par <- res$minimum res$value <- res$objective } } ch <- crossprod(abs(tet-res$par)/tet,abs(tet-res$par)/tet) if (j>itermax) { cat("No convergence after ",itermax," iterations") ch <- crit } j <- j+1 } z = list(par=res$par,objective=res$value) } } if (!is.function(gradv)) G <- Gf(z$par) else if (typeg) G <- gradv(x) else G <- gradv(z$par,x) if (vcov == "iid") v <- iid(z$par)/n else v <- .HAC(g(z$par,x), kernel=kernel, bw=bw,prewhite=prewhite, ar.method=ar.method,approx=approx,tol=tol)/n if (wmatrix == "optimal") { z$vcov <- solve(crossprod(G,solve(v,G))) } else { GGG <- solve(crossprod(G),t(G)) z$vcov <- GGG%*%v%*%t(GGG) } z$gt <- g(z$par,x) if (typeg==0) names(z$par) <- paste("Theta[",1:k,"]",sep="") if (typeg == 1) { namex <- colnames(dat$x[,(dat$ny+1):(dat$ny+dat$k)]) nameh <- colnames(dat$x[,(dat$ny+dat$k+1):(dat$ny+dat$k+dat$nh)]) if (dat$ny > 1) { namey <- colnames(dat$x[,1:dat$ny]) names(z$par) <- paste(rep(namey,dat$k),"_",rep(namex,rep(dat$ny,dat$k)),sep="") colnames(z$gt) <- paste(rep(namey,dat$nh),"_",rep(nameh,rep(dat$ny,dat$nh)),sep="") } if (dat$ny == 1) { names(z$par) <- namex colnames(z$gt) <- nameh } } dimnames(z$vcov) <- list(names(z$par),names(z$par)) z$df <- df z$k <- k z$n <- n z$met <- type z$kernel <- kernel class(z) <- "gmm" z } # ------------------------------------------------------------------------------ .HAC <- function(x, weights = .weightsAndrews2, bw = .bwAndrews2, prewhite = FALSE, ar.method = "ols", kernel=c("Quadratic Spectral", "Truncated", "Bartlett", "Parzen", "Tukey-Hanning"), approx="AR(1)", tol = 1e-7) { n.orig <- n <- nrow(x) k <- ncol(x) kernel=match.arg(kernel) if(prewhite > 0) { var.fit <- ar(x, order.max = prewhite, demean = FALSE, aic = FALSE, method = ar.method) if(k > 1) D <- solve(diag(ncol(x)) - apply(var.fit$ar, 2:3, sum)) else D <- as.matrix(1/(1 - sum(var.fit$ar))) x <- as.matrix(na.omit(var.fit$resid)) n <- n - prewhite } weights <- weights(x, ar.method = ar.method,kernel=kernel,bw=bw, approx = approx, prewhite = 1, tol = tol) if (length(weights) > n) { warning("more weights than observations, only first n used") weights <- weights[1:n] } utu <- 0.5 * crossprod(x) * weights[1] wsum <- n * weights[1]/2 w2sum <- n * weights[1]^2/2 if (length(weights) > 1) { for (ii in 2:length(weights)) { utu <- utu + weights[ii] * crossprod(x[1:(n - ii + 1), , drop = FALSE], x[ii:n, , drop = FALSE]) wsum <- wsum + (n - ii + 1) * weights[ii] w2sum <- w2sum + (n - ii + 1) * weights[ii]^2 } } utu <- utu + t(utu) if(prewhite > 0) { utu <- crossprod(t(D), utu) %*% t(D) } wsum <- 2 * wsum w2sum <- 2 * w2sum bc <- n^2/(n^2 - wsum) df <- n^2/w2sum rval <- utu/n.orig return(rval) } # ------------------------------------------------------------------------------ .weightsAndrews2 <- function(x, bw = .bwAndrews2, kernel = c("Quadratic Spectral", "Truncated", "Bartlett", "Parzen", "Tukey-Hanning"), approx = c("AR(1)", "ARMA(1,1)"), prewhite = 1, ar.method = "ols", tol = 1e-7, verbose = FALSE) { kernel <- match.arg(kernel) approx=match.arg(approx) if (is.function(bw)) bw <- bw(x, kernel = kernel, prewhite = prewhite, ar.method = ar.method, approx=approx) n <- NROW(x) weights <- .kweights(0:(n - 1)/bw, kernel = kernel) weights <- weights[1:max(which(abs(weights) > tol))] return(weights) } # ------------------------------------------------------------------------------ .bwAndrews2 <- function(x, kernel = c("Quadratic Spectral", "Truncated", "Bartlett", "Parzen", "Tukey-Hanning"), approx = c("AR(1)", "ARMA(1,1)"), prewhite = 1, ar.method = "ols") { kernel <- match.arg(kernel) approx <- match.arg(approx) n <- nrow(x) k <- ncol(x) if (approx == "AR(1)") { fitAR1 <- function(x) { rval <- ar(x, order.max = 1, aic = FALSE, method = "ols") rval <- c(rval$ar, sqrt(rval$var.pred)) names(rval) <- c("rho", "sigma") return(rval) } ar.coef <- apply(x, 2, fitAR1) denum <- sum((ar.coef["sigma", ]/(1 - ar.coef["rho", ]))^4) alpha2 <- sum(4 * ar.coef["rho", ]^2 * ar.coef["sigma", ]^4/(1 - ar.coef["rho", ])^8)/denum alpha1 <- sum(4 * ar.coef["rho", ]^2 * ar.coef["sigma", ]^4/((1 - ar.coef["rho", ])^6 * (1 + ar.coef["rho", ])^2))/denum } else { fitARMA11 <- function(x) { rval <- arima(x, order = c(1, 0, 1), include.mean = FALSE) rval <- c(rval$coef, sqrt(rval$sigma2)) names(rval) <- c("rho", "psi", "sigma") return(rval) } arma.coef <- apply(x, 2, fitARMA11) denum <- sum(((1 + arma.coef["psi", ]) * arma.coef["sigma", ]/(1 - arma.coef["rho", ]))^4) alpha2 <- sum(4 * ((1 + arma.coef["rho", ] * arma.coef["psi", ]) * (arma.coef["rho", ] + arma.coef["psi", ]))^2 * arma.coef["sigma", ]^4/(1 - arma.coef["rho", ])^8)/denum alpha1 <- sum(4 * ((1 + arma.coef["rho", ] * arma.coef["psi", ]) * (arma.coef["rho", ] + arma.coef["psi", ]))^2 * arma.coef["sigma", ]^4/((1 - arma.coef["rho", ])^6 * (1 + arma.coef["rho", ])^2))/denum } rval <- switch(kernel, Truncated = { 0.6611 * (n * alpha2)^(1/5) }, Bartlett = { 1.1447 * (n * alpha1)^(1/3) }, Parzen = { 2.6614 * (n * alpha2)^(1/5) }, "Tukey-Hanning" = { 1.7462 * (n * alpha2)^(1/5) }, "Quadratic Spectral" = { 1.3221 * (n * alpha2)^(1/5) }) return(rval) } # ------------------------------------------------------------------------------ .summary.gmm <- function(object, interval=FALSE, ...) { z <- object se <- sqrt(diag(z$vcov)) par <- z$par tval <- par/se j <- z$objective*z$n ans <- list(met=z$met,kernel=z$kernel,algo=z$algo) names(ans$met) <- "GMM method" names(ans$kernel) <- "kernel for cov matrix" ans$par <- round(cbind(par,se, tval, 2 * pnorm(abs(tval), lower.tail = FALSE)),5) dimnames(ans$par) <- list(names(z$par), c("Estimate", "Std. Error", "t value", "Pr(>|t|)")) ans$J_test <- noquote(paste("Test-J degrees of freedom is ",z$df,sep="")) ans$j <- noquote(cbind(j,ifelse(z$df>0,pchisq(j,z$df,lower.tail = FALSE),"*******"))) dimnames(ans$j) <- list("Test E(g)=0: ",c("J-test","Pz(>j)")) if (interval != FALSE) { zs <- qnorm((1-interval)/2,lower.tail=FALSE) ch <- zs*se ans$interval <- cbind(par-ch,par+ch) dimnames(ans$interval) <- list(names(par),c("Theta_lower","Theta_upper")) } class(ans) <- "summary.gmm" ans } # ------------------------------------------------------------------------------ .lintest <- function(object,R,c) { z <- object dl <- nrow(R) rest <- R%*%z$par - c if (class(z)=="gmm") vcov_par <- z$vcov else vcov_par <- z$vcov_par vcov <- R%*%vcov_par%*%t(R) h0 <- matrix(rep(NA,nrow(R)),ncol=1) for (i in 1:nrow(R)) { testnames <- names(z$par)[R[i,]!=0] rn <- R[i,][R[i,]!=0] if (rn[1] != 1) h0[i] <- paste(rn[1],"*",testnames[1],sep="") else h0[i] <- testnames[1] if (length(rn) > 1) { for (j in 2:length(rn)) { if (rn[j] >= 0) { if (rn[j] != 1) h0[i] <- paste(h0[i]," + ",rn[j],"*",testnames[j],sep="") else h0[i] <- paste(h0[i]," + ",testnames[j],sep="") } else { if (abs(rn[j]) != 1) h0[i] <- paste(h0[i]," - ",abs(rn[j]),"*",testnames[j],sep="") else h0[i] <- paste(h0[i]," - ",testnames[j],sep="") } } } h0[i] <- paste(h0[i]," = ",c[i],sep="") } rh <- solve(vcov,rest) ans <- list(description <- "Wald test for H0: R(Theta)=c") ans$H0 <- noquote(h0) colnames(ans$H0) <- "Null Hypothesis" wt <- crossprod(rest,rh) pv <- pchisq(wt,dl,lower.tail=FALSE) res <- cbind(wt,pv) dimnames(res) <- list("Wald test", c("Statistics","P-Value")) ans$result <- res ans } ################################################################################ fBasics/R/test-jbTable.R0000644000176200001440000001457313202116741014477 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .jbTable Finite sample p values for the Jarque Bera test # .jbPlot Plots probabilities # .pjb Returns probabilities for JB given quantiles # .qjb Returns quantiles for JB given probabilities ################################################################################ .jbTable <- function(type = c("LM", "ALM"), size = c("mini", "small", "all")) { # A function implemented by Diethelm Wuertz # Description: # Finite sample p values for the Jarque Bera test # Details: # The function jbTable() returns a data.frame with rows denoting # size and columns denoting probabilities 0 < p < 1. # Note: # x=-3:0; y=0:3; z=outer(x,y,"*"); rownames(z)=x; colnames(z)=y; z # Example: # .jbTable() # FUNCTION: # Check Arguments: type = match.arg(type) size = match.arg(size) # Create Table: if (type == "LM") { Table = t(.jbLM()) } else if (type == "ALM") { Table = t(.jbALM()) } # Select Size: if (size == "small") { Table = t(Table) n = dim(Table)[1] Table = Table[c(matrix(1:(n-2), byrow = TRUE, ncol = 22)[, 1], n), ] Table = Table[-(1:17),] Table = t(Table) } else if (size == "mini") { p = c( "0.01", "0.0251189", "0.05", "0.1", "0.9", "0.95", "0.9751687", "0.99") Table = Table[, p] Table = rbind(Table, qchisq(as.numeric(p), df = 2)) Table = round(Table, 3) colnames(Table) = substr(colnames(Table), 1, 5) nRows = dim(Table)[1] rownames(Table)[nRows] = "Inf" } ans = list( x = as.numeric(rownames(Table)), y = as.numeric(colnames(Table)), z = Table) # Add Control: attr(ans, "control") <- c(table = "jb", type = type, size = size) # Return Value: class(ans) = "gridData" ans } # ------------------------------------------------------------------------------ .jbPlot <- function(type = c("LM", "ALM")) { # A function implemented by Diethelm Wuertz # Match Arguments: type = match.arg(type) # Load Table: Y = .jbTable(size = "small") X = cbind(expand.grid(x = Y$x, y = Y$y), z = as.vector(Y$z)) x = X[, 1] # N y = X[, 3] # q-Stat z = X[, 2] # p-Value # Interpolate: ans = akimaInterp(log(x), log(y), z, gridPoints = 101, extrap = FALSE) persp(ans, theta = 40, xlab = "log(N)", ylab = "log(q)", zlab = "p", main = paste(type, "Jarque Bera")) # Return Value: invisible(NULL) } # ------------------------------------------------------------------------------ .pjb <- function(q, N = Inf, type = c("LM", "ALM")) { # A function implemented by Diethelm Wuertz # Description: # Returns probabilities for the JB Test given quantiles # Arguments: # q = quantiles (0.020 < q < 12) # N = sample sizes # Details: # Uses "small" table for interpolation. # Example: # q=c(0.03,1,5,9); for (N in c(4,1000,50000,Inf)) print(.pjb(q, N)) # FUNCTION: # Match Arguments: type = match.arg(type) # Check N: stopifnot(length(N) == 1) # Grid Points: Y = .jbTable(type = type, size = "small") if (N < 10000) { # Interpolate on log-Scale: X = cbind(expand.grid(x = Y$x, y = Y$y), z = as.vector(Y$z)) x = log(X[, 1]) # N y = log(X[, 3]) # q-Stat z = X[, 2] # p-Value # Out Points: xo = rep(log(N), times = length(q)) yo = log(q) # Interpolate: p = linearInterpp(x, y, z, xo = xo, yo = yo)[, 3] } else if (N > 10000) { p = pchisq(as.numeric(q), df = 2) } # Result: if (N < 5) controlN = "< 5" if (N >= 5 & N <= 10000) controlN = as.character(N) if (N > 10000) controlN = "> 10000" if (!is.finite(N)) controlN = "Inf" names(p) = as.character(q) attr(p, "control") <- c(N = controlN) # Return Value: p } # ------------------------------------------------------------------------------ .qjb <- function(p, N = Inf, type = c("LM", "ALM")) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles for the ADF Test given probabilities # Arguments: # p = probabilities (0.01 < p < 0.99) # N = sample sizes # Details: # Uses "small" table for interpolation. # Example: # p=(1:9)/10; for (N in c(4,1000,50000,Inf)) print(.qjb(p, N)) # FUNCTION: # Match Arguments: type = match.arg(type) statistic = match.arg(statistic) # Check N: stopifnot(length(N) == 1) # Grid Points: Y = .jbTable(type = type, size = "small") if (N < 10000) { # Interpolate on log-Scale: X = cbind(expand.grid(x = Y$x, y = Y$y), z = as.vector(Y$z)) x = log(X[, 1]) # N y = X[, 2] # p-Value z = X[, 3] # q-Stat # Out Points: xo = rep(log(N), times = length(p)) yo = p # Interpolate - Scaling Required: xStd = sqrt(var(x)) q = linearInterpp(x/xStd, y, z, xo = xo/xStd, yo = yo)[, 3] } else { # Asymptotic Limit: q = qchisq(as.numeric(p), df = 2) } # Result: if (N < 5) controlN = "< 5" if (N >= 5 & N <= 10000) controlN = as.character(N) if (N > 10000) controlN = "> 10000" if (!is.finite(N)) controlN = "Inf" names(q) = as.character(p) attr(q, "control") <- c(N = controlN) # Return Value: q } ################################################################################ fBasics/R/matrix-gridVector.R0000644000176200001440000000427713202116742015572 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # gridVector Creates from two vectors rectangular grid coordinates ################################################################################ gridVector <- function(x, y = NULL) { # A function implemented by Diethelm Wuertz # Description: # Creates from two vectors rectangular grid coordinates # Arguments: # x, y - two numeric vectors of length m and n which span the # rectangular grid of size m times n. # Details: # The two vectors x and y span a rectangular grid with nx=length(x) # times ny=length(y) points which are returned as a matrix of size # (nx*ny) times 2. # Value: # returns a list with two elements X and Y each of length m # times n # Example: # > gridVector(1:3, 1:2) # [,1] [,2] # [1,] 1 1 # [2,] 2 1 # [3,] 3 1 # [4,] 1 2 # [5,] 2 2 # [6,] 3 2 # FUNCTION: # DW: if (is.null(y)) y = x # Prepare for Input: nx = length(x) ny = length(y) xoy = cbind(rep(x, ny), as.vector(matrix(y, nx, ny, byrow = TRUE))) X = matrix(xoy, nx * ny, 2, byrow = FALSE) # Return Value: list(X = X[,1], Y = X[,2]) } ################################################################################ fBasics/R/matrix-vech.R0000644000176200001440000000373413202116741014403 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # Function: DESCRIPTION: # vec Stacks a matrix as column vector # vech Stacks a lower triangle matrix ################################################################################ vec <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Stacks a matrix as column vector # Details: # vec(X) = (X11, X21, ..., XN1, X12, X22, ..., XNN)' # Note: # Example for a 3x3 Matrix: # X11, X21, X22, X31, X32, X33 # FUNCTION: # Return Value: t(t(as.vector(x))) } # ------------------------------------------------------------------------------ vech <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Stacks a lower triangle matrix # Details: # vech is the operator that stacks the lower triangle # of a NxN matrix as an N(N+1)/2x1 vector: # vech(X) =(X11, X21, X22, X31, ..., XNN)' # Note: # Example for a 3x3 Matrix: # X11, X21, X22, X31, X32, X33 # FUNCTION: # Return Value: t(x[!upper.tri(x)]) } ################################################################################ fBasics/R/00fBasics-Package.R0000644000176200001440000000144513202116741015214 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ############################################################################### fBasics/R/test-jbALM.R0000644000176200001440000172071613202116741014065 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # DATA: DESCRIPTION: # .jbALM Jarque Bera Augmented Lagrange Multiplier Data ################################################################################ .jbALM <- function() { structure(list("5" = c(3.6559e-05, 3.6676e-05, 3.8408e-05, 3.9805e-05, 4.0283e-05, 4.0549e-05, 4.062e-05, 4.1218e-05, 4.2351e-05, 4.2355e-05, 4.2797e-05, 4.3593e-05, 4.3764e-05, 4.3945e-05, 4.4328e-05, 4.4677e-05, 4.4694e-05, 4.5125e-05, 4.5133e-05, 4.5314e-05, 4.5404e-05, 4.6125e-05, 4.7878e-05, 4.791e-05, 4.8059e-05, 4.8158e-05, 4.8537e-05, 4.8671e-05, 4.9346e-05, 5.2005e-05, 5.2045e-05, 5.2874e-05, 5.4154e-05, 5.4401e-05, 5.6475e-05, 5.7065e-05, 5.7268e-05, 5.7759e-05, 5.8145e-05, 5.8421e-05, 5.8544e-05, 5.9025e-05, 6.1431e-05, 6.2246e-05, 6.2726e-05, 6.3127e-05, 6.4263e-05, 6.5175e-05, 6.558e-05, 6.5867e-05, 6.7439e-05, 6.7628e-05, 6.8728e-05, 6.9229e-05, 6.9781e-05, 7.047e-05, 7.4419e-05, 7.52e-05, 7.5643e-05, 7.6625e-05, 7.7835e-05, 7.8056e-05, 8.0169e-05, 8.0525e-05, 8.1766e-05, 8.2566e-05, 8.3138e-05, 8.445e-05, 8.5821e-05, 8.653e-05, 8.688e-05, 8.7287e-05, 8.8008e-05, 8.9306e-05, 8.9998e-05, 9.0808e-05, 9.0994e-05, 9.2429e-05, 9.4441e-05, 9.7687e-05, 9.8294e-05, 9.9436e-05, 9.9811e-05, 0.000100384, 0.000101058, 0.000102205, 0.000103164, 0.000103798, 0.000104172, 0.000106155, 0.000106266, 0.000108068, 0.000109299, 0.000110262, 0.000110657, 0.000113396, 0.000114168, 0.000114691, 0.000115894, 0.000118261, 0.000118738, 0.00012071, 0.00012185, 0.000122411, 0.000122816, 0.000123872, 0.000124869, 0.000125712, 0.000127507, 0.000129113, 0.000129633, 0.000130914, 0.000132618, 0.000134974, 0.000137935, 0.000138358, 0.000140343, 0.000142789, 0.000143747, 0.000145185, 0.00014727, 0.000149816, 0.000151305, 0.00015328, 0.000156449, 0.000157562, 0.000158683, 0.000160049, 0.000161523, 0.000164733, 0.000166998, 0.000169417, 0.000171718, 0.000174539, 0.000176047, 0.000178368, 0.000179273, 0.000180695, 0.000181991, 0.000182821, 0.000184236, 0.000186803, 0.000188006, 0.000191383, 0.000192252, 0.000195411, 0.000197557, 0.000199396, 0.000203267, 0.000206478, 0.000208246, 0.00021081, 0.00021277, 0.000214432, 0.000216338, 0.000219331, 0.000221487, 0.000223769, 0.000225692, 0.000229045, 0.000232534, 0.000236029, 0.000237355, 0.000238839, 0.000241658, 0.000243651, 0.000247937, 0.000251439, 0.000254616, 0.00025698, 0.000259024, 0.000263569, 0.000266388, 0.000268836, 0.000270824, 0.000275006, 0.000277729, 0.000280224, 0.000283939, 0.000286056, 0.00028816, 0.000291164, 0.000295574, 0.000297855, 0.000301406, 0.000303802, 0.000306588, 0.000309147, 0.000312405, 0.000316706, 0.000320339, 0.00032635, 0.000328857, 0.000332809, 0.00033598, 0.00033906, 0.000343894, 0.000347044, 0.000352935, 0.000356722, 0.000360606, 0.000363624, 0.000366725, 0.000371637, 0.000377895, 0.000380807, 0.000387119, 0.000391195, 0.00039438, 0.000398039, 0.000402309, 0.00040665, 0.000412242, 0.00041689, 0.000421805, 0.000426133, 0.000429776, 0.000435604, 0.000442123, 0.000445948, 0.000450778, 0.000456309, 0.000460125, 0.000465173, 0.00047096, 0.000478304, 0.000482793, 0.0004886, 0.000492719, 0.000500311, 0.000505597, 0.000512136, 0.000517525, 0.000521164, 0.000526838, 0.000530932, 0.000538273, 0.000543949, 0.000547949, 0.000557152, 0.000561684, 0.000566815, 0.000572831, 0.000578346, 0.000583322, 0.000588881, 0.000594856, 0.000604063, 0.000611878, 0.000616038, 0.000625048, 0.000632283, 0.000638615, 0.000646415, 0.000656107, 0.000663472, 0.000669256, 0.0006775, 0.000686414, 0.000697483, 0.000704603, 0.000709929, 0.000719191, 0.000728828, 0.000736136, 0.000742434, 0.000753303, 0.000761699, 0.000771737, 0.000781114, 0.000790353, 0.000800866, 0.00081076, 0.000818651, 0.000830237, 0.000839178, 0.000849784, 0.000858741, 0.000867707, 0.000878672, 0.000889377, 0.000898416, 0.000907651, 0.000919457, 0.000930054, 0.000945049, 0.000956511, 0.000965677, 0.000979332, 0.000988167, 0.00100013, 0.001014508, 0.001027825, 0.001035209, 0.001047369, 0.001058546, 0.0010707, 0.001079348, 0.001088831, 0.001103408, 0.001116266, 0.00113147, 0.001140678, 0.001154093, 0.001165199, 0.001181722, 0.001194202, 0.001213794, 0.001231295, 0.001246247, 0.001258361, 0.001274188, 0.001290861, 0.001306783, 0.001320243, 0.001333606, 0.001354469, 0.001375078, 0.001389923, 0.001405028, 0.001420399, 0.001437746, 0.001453279, 0.001471657, 0.001486939, 0.00150243, 0.001520999, 0.001541187, 0.001560932, 0.001582043, 0.001596843, 0.001612566, 0.001631022, 0.001653752, 0.001674666, 0.001695299, 0.001711676, 0.001725655, 0.00175016, 0.001764389, 0.001779125, 0.001783268, 0.001804581, 0.001823921, 0.001844709, 0.001865129, 0.001886846, 0.001909372, 0.001927753, 0.001952632, 0.001976229, 0.002013512, 0.002039507, 0.002062143, 0.002082904, 0.002100875, 0.002127102, 0.002153903, 0.002180398, 0.002205838, 0.002227415, 0.002251702, 0.002274242, 0.002296068, 0.002322629, 0.002351514, 0.002378494, 0.002404313, 0.002435294, 0.002466558, 0.002497381, 0.002520757, 0.002555872, 0.002586149, 0.002620634, 0.002648223, 0.002684808, 0.002717046, 0.002743266, 0.002777663, 0.0028076, 0.002838148, 0.002865398, 0.002894208, 0.002924336, 0.002964645, 0.003004024, 0.00303525, 0.003075351, 0.003113435, 0.003150581, 0.003188933, 0.003223459, 0.003254621, 0.003287804, 0.003325633, 0.003360841, 0.003400504, 0.003428985, 0.003463445, 0.003500397, 0.003542617, 0.003584709, 0.003628508, 0.003670112, 0.003716181, 0.003760418, 0.003807062, 0.003845951, 0.003889573, 0.003937353, 0.003977666, 0.00401694, 0.004072232, 0.004118754, 0.00416505, 0.004214084, 0.004260224, 0.004310062, 0.004355524, 0.00440579, 0.004455118, 0.004511028, 0.004561812, 0.004611664, 0.00466489, 0.004720059, 0.004775932, 0.004833971, 0.004890741, 0.004944213, 0.005005854, 0.00505933, 0.005120248, 0.005168977, 0.005232266, 0.005295132, 0.005348358, 0.005422287, 0.005483878, 0.005544922, 0.005605788, 0.005665343, 0.005734263, 0.005802923, 0.0058766, 0.005941258, 0.006009913, 0.006073892, 0.006144848, 0.006219229, 0.0063024, 0.006371055, 0.006450011, 0.006522412, 0.006599935, 0.006681315, 0.006760397, 0.006839474, 0.006915885, 0.006993508, 0.007068701, 0.0071574, 0.007231024, 0.007312241, 0.007391797, 0.007481554, 0.00756224, 0.007648281, 0.007734631, 0.007817361, 0.007917345, 0.008001533, 0.008083505, 0.008174944, 0.008280894, 0.008384592, 0.008487807, 0.008569222, 0.008657994, 0.008750164, 0.008858198, 0.008958549, 0.009072711, 0.009183631, 0.009288004, 0.009387484, 0.009487533, 0.009592086, 0.009694136, 0.009805331, 0.009916848, 0.010020197, 0.010142106, 0.010262439, 0.010384808, 0.010507209, 0.01062309, 0.010738243, 0.010865318, 0.010995926, 0.011133057, 0.011254801, 0.011389623, 0.011528398, 0.011666389, 0.011808989, 0.011937685, 0.012078173, 0.012219025, 0.012374169, 0.012527662, 0.012664523, 0.012818783, 0.012971324, 0.013128624, 0.013279506, 0.013432013, 0.01359048, 0.013747251, 0.013916016, 0.014075929, 0.014237417, 0.014409722, 0.01457517, 0.014738734, 0.014903102, 0.01507266, 0.015242032, 0.015432491, 0.015608658, 0.015778218, 0.015956313, 0.016135642, 0.016320512, 0.016504368, 0.01669306, 0.016887745, 0.017067288, 0.017257689, 0.017458599, 0.017618047, 0.017654392, 0.017850886, 0.018055074, 0.018256924, 0.018471204, 0.018691827, 0.018911858, 0.019132161, 0.019370125, 0.019601175, 0.0198019, 0.020023205, 0.020247257, 0.020483355, 0.020718216, 0.02096615, 0.021213161, 0.021444918, 0.02168673, 0.021943998, 0.022189844, 0.022438014, 0.022692875, 0.022953768, 0.023194174, 0.023466894, 0.023741721, 0.024003462, 0.024273669, 0.024548145, 0.024832661, 0.025123599, 0.025413644, 0.025713194, 0.02601006, 0.026311145, 0.026601403, 0.026907793, 0.027223156, 0.027520955, 0.02782744, 0.028161537, 0.028479236, 0.028782152, 0.029112315, 0.029444583, 0.029766705, 0.030123068, 0.030485933, 0.030857724, 0.031210782, 0.031567092, 0.031915004, 0.032263462, 0.032645941, 0.033012303, 0.033392447, 0.033756059, 0.034129974, 0.034521928, 0.03490533, 0.035304913, 0.035729048, 0.036145387, 0.036570441, 0.036989106, 0.037418021, 0.037851025, 0.038265821, 0.038690539, 0.039133699, 0.03958711, 0.040020153, 0.040497763, 0.040962912, 0.041423189, 0.0419003, 0.042392843, 0.042871775, 0.043339449, 0.04384165, 0.044348869, 0.044833052, 0.045360822, 0.045888484, 0.046420857, 0.046937915, 0.047488362, 0.048039346, 0.048603466, 0.049158463, 0.049693169, 0.050272649, 0.050840273, 0.051430164, 0.05198366, 0.052557767, 0.053164899, 0.053777287, 0.054405409, 0.055013734, 0.055632139, 0.056265096, 0.056922861, 0.057542263, 0.058216067, 0.058849992, 0.059524279, 0.060200388, 0.060877299, 0.06154046, 0.062244876, 0.062939094, 0.063664605, 0.064385143, 0.065100718, 0.065819771, 0.066573088, 0.067351128, 0.068140771, 0.0688953, 0.0696671, 0.070465232, 0.071261676, 0.072078251, 0.072883268, 0.073711564, 0.074567365, 0.07542192, 0.076259147, 0.077137372, 0.077985882, 0.078867069, 0.079771519, 0.080677168, 0.081583181, 0.082529855, 0.083441874, 0.084396566, 0.085339836, 0.086325387, 0.087318889, 0.088289864, 0.089263867, 0.090260613, 0.091245464, 0.092283721, 0.093309256, 0.094372035, 0.095455169, 0.096523546, 0.097616397, 0.098683139, 0.099755491, 0.100884681, 0.102045793, 0.103192646, 0.104378571, 0.105545575, 0.106778666, 0.107947284, 0.109160163, 0.110364112, 0.111557532, 0.11281333, 0.114094046, 0.115375528, 0.116664101, 0.117980128, 0.119260457, 0.120615258, 0.121921045, 0.123273521, 0.124665084, 0.126109963, 0.127548186, 0.128973472, 0.130398775, 0.131875454, 0.133349175, 0.134797574, 0.136330065, 0.137839837, 0.139393438, 0.140900964, 0.142464936, 0.144034355, 0.145642255, 0.147296223, 0.14890239, 0.15054162, 0.152200565, 0.153891336, 0.155563442, 0.157199276, 0.158911532, 0.160702021, 0.162481332, 0.164252507, 0.16604854, 0.167455813, 0.167835743, 0.169646917, 0.17148661, 0.173385494, 0.175241662, 0.1771372, 0.17905781, 0.180999398, 0.182956279, 0.184955185, 0.186974091, 0.189022823, 0.191037098, 0.193148419, 0.195206647, 0.197277391, 0.199355381, 0.201460009, 0.203645814, 0.205829662, 0.208047197, 0.210236284, 0.21247216, 0.214723947, 0.217015038, 0.219382442, 0.221686073, 0.224076367, 0.226476662, 0.228877142, 0.23129064, 0.233715918, 0.236188279, 0.238663389, 0.241217406, 0.24377106, 0.24636134, 0.248979605, 0.251597868, 0.254271087, 0.25693589, 0.259607447, 0.26232757, 0.265049731, 0.267817998, 0.270607806, 0.273456083, 0.276296098, 0.279147813, 0.282039394, 0.284960107, 0.287879685, 0.290796251, 0.293758423, 0.29677992, 0.299799993, 0.30287189, 0.305944694, 0.309053736, 0.312240621, 0.315392445, 0.318586034, 0.321785946, 0.325000891, 0.328269661, 0.331561527, 0.334816618, 0.338108058, 0.341347357, 0.344717983, 0.348110507, 0.351506647, 0.35489934, 0.358322916, 0.36175357, 0.365181081, 0.368676051, 0.372181411, 0.375682156, 0.379189192, 0.38267535, 0.386233732, 0.389732671, 0.393255781, 0.396773897, 0.400191642, 0.403621087, 0.407080955, 0.410587809, 0.414089443, 0.4176846, 0.421263562, 0.42500382, 0.428701138, 0.432484759, 0.436314009, 0.437129936, 0.440170684, 0.444088594, 0.448041803, 0.452085706, 0.456203167, 0.460330988, 0.464584055, 0.468785407, 0.473099838, 0.477436708, 0.481915165, 0.486393483, 0.490917553, 0.495466923, 0.50018802, 0.504887294, 0.509687129, 0.514541049, 0.519476109, 0.524544804, 0.52961961, 0.534683885, 0.539891003, 0.545214329, 0.550583655, 0.55167832, 0.555960002, 0.561414672, 0.566957344, 0.572538034, 0.5782339, 0.584027025, 0.589969188, 0.595893181, 0.601880301, 0.607975492, 0.614155629, 0.620443132, 0.626830721, 0.633250968, 0.639830353, 0.646450941, 0.653147649, 0.659971221, 0.666876303, 0.673860173, 0.680951186, 0.688225806, 0.695558795, 0.702920456, 0.710350724, 0.717983159, 0.725646298, 0.733459857, 0.741297232, 0.74929371, 0.757447067, 0.765714116, 0.773982596, 0.782442721, 0.791086879, 0.794735839, 0.799767722, 0.808591422, 0.817531539, 0.826498955, 0.835666556, 0.845033809, 0.854484607, 0.864122465, 0.873895621, 0.883795433, 0.893826403, 0.904018922, 0.914338122, 0.924807826, 0.935348082, 0.946080121, 0.957004636, 0.968120733, 0.979293621, 0.990710669, 1.002152242, 1.013938448, 1.025836324, 1.037968805, 1.050379702, 1.055510632, 1.062940458, 1.075761536, 1.088713978, 1.102037733, 1.11551473, 1.129153826, 1.143193984, 1.157441488, 1.171817283, 1.186501413, 1.201283837, 1.216374545, 1.231720581, 1.247168716, 1.2630186, 1.279144542, 1.29549473, 1.311920698, 1.328714083, 1.342254692, 1.37276528, 1.389734605, 1.406376996, 1.422858586, 1.439261387, 1.455559995, 1.471701219, 1.487624216, 1.504099111, 1.520962322, 1.537927972, 1.554957242, 1.572170121, 1.589748625, 1.60733102, 1.62501999, 1.642645517, 1.660150481, 1.670594148, 1.677755435, 1.695494183, 1.713110716, 1.730813853, 1.74844742, 1.766158693, 1.783694196, 1.801198584, 1.81882292, 1.836349178, 1.853861575, 1.871252549, 1.888808531, 1.906178158, 1.923555864, 1.940772901, 1.958078526, 1.975126557, 1.992199957, 2.009170137, 2.026089156, 2.042907185, 2.059687801, 2.076413749, 2.093014696, 2.102564189, 2.10952883, 2.125734251, 2.142035196, 2.158254424, 2.174484512, 2.190435419, 2.206415883, 2.222261112, 2.238041843, 2.253790013, 2.270125665, 2.2869378, 2.304000168, 2.321251373, 2.338715982, 2.356567111, 2.374565281, 2.392621909, 2.410829225, 2.429360718, 2.447821355, 2.466577153, 2.485541683, 2.504538568, 2.52388001, 2.543186692, 2.562646018, 2.582183464, 2.602012007, 2.622035545, 2.642375485, 2.662798792, 2.683120273, 2.70389943, 2.724580066, 2.741279991, 2.745695705, 2.766849489, 2.788026793, 2.809441135, 2.831283085, 2.853173826, 2.87531901, 2.897677823, 2.92051093, 2.943731731, 2.967106264, 2.991164615, 3.01561854, 3.040090934, 3.065436019, 3.090857625, 3.11792974, 3.145702342, 3.174686803, 3.206109241, 3.242212091, 3.279958988, 3.318669125, 3.35675389, 3.395459013, 3.425303655, 3.433755192, 3.471795255, 3.510981667, 3.548931951, 3.587523562, 3.626248745, 3.664812295, 3.703558356, 3.741761853, 3.780723526, 3.819654249, 3.857261047, 3.895989087, 3.934687348, 3.973056781, 4.011760826, 4.050490209, 4.088920944, 4.12721078, 4.165607436, 4.204421231, 4.243107593, 4.281935771, 4.321020017, 4.359378514, 4.398161397, 4.436673459, 4.475346417, 4.514077787, 4.552779139, 4.590818137, 4.628936666, 4.667406302, 4.705245663, 4.743356005, 4.781670633, 4.819955615, 4.858219507, 4.89560808, 4.93398262, 4.971425302, 5.009823753, 5.047578472, 5.085366075, 5.122947747, 5.159754386, 5.197300653, 5.234401093, 5.271903615, 5.30932371, 5.346110494, 5.383855278, 5.420643283, 5.45691495, 5.49388409, 5.530876045, 5.568373272, 5.605020768, 5.641716765, 5.678631587, 5.714879842, 5.751399892, 5.787478902, 5.823324743, 5.859400263, 5.89573311, 5.931866309, 5.967315962, 6.002580034, 6.037343653, 6.073066232, 6.108606441, 6.143113798, 6.178860221, 6.213273289, 6.247685564, 6.282528508, 6.316634316, 6.350582099, 6.384855859, 6.419133886, 6.453196623, 6.486968657, 6.520390854, 6.553850781, 6.58762841, 6.62072357, 6.654454683, 6.687042747, 6.720140895, 6.753075689, 6.786007897, 6.818330672, 6.850696084, 6.882542584, 6.914514778, 6.920744908, 6.946062613, 6.977247848, 7.008693225, 7.040543945, 7.072631739, 7.104919678, 7.136144364, 7.167093211, 7.197721754, 7.228185563, 7.259591738, 7.290630867, 7.320765425, 7.350420099, 7.380729583, 7.410480922, 7.440375107, 7.470130295, 7.499675875, 7.528809622, 7.558227233, 7.587029086, 7.616504966, 7.646071742, 7.675216172, 7.704100494, 7.732842997, 7.761607755, 7.790020541, 7.818283308, 7.845561353, 7.873713836, 7.900969888, 7.928157082, 7.955739041, 7.982874476, 8.009472991, 8.036645365, 8.063401152, 8.089832337, 8.116336355, 8.142869001, 8.17025125, 8.197095154, 8.222808316, 8.24874018, 8.273764856, 8.300440508, 8.326219988, 8.35176005, 8.377491624, 8.402435997, 8.427633164, 8.452325953, 8.477645638, 8.501716175, 8.525995915, 8.550201563, 8.574298136, 8.59843595, 8.621858836, 8.646143919, 8.67026502, 8.693772789, 8.717514433, 8.740145234, 8.763226511, 8.786932128, 8.810492184, 8.834823494, 8.857786718, 8.880190171, 8.902835238, 8.925810872, 8.947944605, 8.970204753, 8.991645846, 9.013430866, 9.034996353, 9.057113423, 9.07825175, 9.100504593, 9.121696445, 9.141974576, 9.162970039, 9.183334749, 9.204625212, 9.225603258, 9.246304542, 9.266736556, 9.287121497, 9.307729444, 9.328254872, 9.348347609, 9.367479725, 9.38786811, 9.407259712, 9.42673883, 9.446466403, 9.46557218, 9.485179078, 9.504749436, 9.524648668, 9.54293282, 9.561606294, 9.580496174, 9.59886285, 9.616491842, 9.635072574, 9.652969972, 9.671613141, 9.689034598, 9.70668887, 9.724031018, 9.74136574, 9.759116461, 9.777243599, 9.794866027, 9.811702549, 9.828521612, 9.844996506, 9.8616524, 9.878359138, 9.895180109, 9.912174651, 9.928179671, 9.94417254, 9.960673555, 9.976505496, 9.993406667, 10.009538752, 10.025753523, 10.041218527, 10.057201878, 10.072975631, 10.088614439, 10.104376473, 10.119590128, 10.135119874, 10.150882156, 10.165525367, 10.180417733, 10.194456372, 10.208753399, 10.22415649, 10.238400653, 10.253334916, 10.267356154, 10.28210723, 10.296336821, 10.310601345, 10.324935848, 10.338546803, 10.352776139, 10.366328338, 10.380284198, 10.393722178, 10.407099142, 10.42045738, 10.433365467, 10.447003241, 10.460593603, 10.47386568, 10.486927719, 10.498756024, 10.511531486, 10.524387582, 10.536882423, 10.548527626, 10.559648315, 10.570929166, 10.583391389, 10.595693271, 10.608067665, 10.62078206, 10.633188921, 10.644967279, 10.656031985, 10.667287819, 10.679087849, 10.690858076, 10.701695364, 10.712756851, 10.723045825, 10.734107949, 10.744611979, 10.755455037, 10.765965181, 10.777344592, 10.787781083, 10.798300089, 10.809227923, 10.819885359, 10.830846769, 10.840959665, 10.850784263, 10.859543045, 10.870194004, 10.880517957, 10.890061988, 10.89168529, 10.899771969, 10.909850907, 10.919490066, 10.929393884, 10.939043845, 10.948618931, 10.958295406, 10.968500347, 10.977998034, 10.987921108, 10.997532215, 11.006245954, 11.015476259, 11.024436626, 11.033370529, 11.041720773, 11.050045983, 11.0588774, 11.067330795, 11.076222292, 11.084880651, 11.093373352, 11.101687884, 11.109735978, 11.118289799, 11.126544854, 11.135637301, 11.144071032, 11.151828526, 11.159715303, 11.167161328, 11.174210972, 11.182480422, 11.190805113, 11.19875723, 11.206380996, 11.214922734, 11.221970046, 11.229348718, 11.236955829, 11.244222973, 11.251366929, 11.258770994, 11.266545261, 11.273657295, 11.280772842, 11.28811669, 11.294854833, 11.302478746, 11.309885333, 11.316523137, 11.323968751, 11.330713822, 11.337383463, 11.343992931, 11.350677552, 11.357642953, 11.364173773, 11.371159633, 11.378051491, 11.383806287, 11.389921657, 11.396705783, 11.402669756, 11.408633341, 11.415186452, 11.421165969, 11.426853434, 11.432273971, 11.438219106, 11.444554247, 11.451025914, 11.45696375, 11.463144051, 11.46904288, 11.474695084, 11.48071666, 11.48649488, 11.492379023, 11.497818848, 11.503649658, 11.508979531, 11.515022769, 11.520822264, 11.526789423, 11.533095325, 11.537919384, 11.543665853, 11.548865279, 11.553872003, 11.55864614, 11.563567127, 11.568388872, 11.573499955, 11.578913886, 11.583699882, 11.588243417, 11.592840986, 11.597966989, 11.602540464, 11.607639707, 11.612704392, 11.617439798, 11.622121866, 11.627121148, 11.631635279, 11.635050587, 11.639619272, 11.644076607, 11.647965112, 11.652341674, 11.656825259, 11.661720021, 11.666116593, 11.670753873, 11.675386303, 11.679152753, 11.683427101, 11.68761985, 11.691626984, 11.69602507, 11.700012695, 11.703674537, 11.707790994, 11.711953543, 11.716118663, 11.720709495, 11.724531684, 11.729097126, 11.732718966, 11.736733319, 11.740221506, 11.744020131, 11.747476446, 11.751837503, 11.755516125, 11.759256374, 11.763848731, 11.767239744, 11.771003887, 11.774936939, 11.778854116, 11.782648785, 11.785813552, 11.788990487, 11.792570748, 11.795924586, 11.79921413, 11.802408092, 11.805632093, 11.809186896, 11.81237092, 11.816021202, 11.819252806, 11.822448544, 11.826063892, 11.829670577, 11.832480832, 11.835469398, 11.838410273, 11.841293234, 11.844588347, 11.847104181, 11.849819607, 11.852890845, 11.856338286, 11.858991833, 11.861917869, 11.864778526, 11.867177281, 11.870228201, 11.873394798, 11.87638001, 11.879076471, 11.882044134, 11.885158075, 11.888082014, 11.890913514, 11.893170553, 11.895773593, 11.898124843, 11.900852511, 11.903289533, 11.905326539, 11.907902742, 11.910533308, 11.913553032, 11.915425503, 11.917671543, 11.920271324, 11.922935745, 11.925046526, 11.92747901, 11.929552435, 11.931732513, 11.933890218, 11.936161678, 11.939125542, 11.941633946, 11.944317733, 11.944839283, 11.946642755, 11.948507574, 11.950721877, 11.95232785, 11.954469619, 11.956887419, 11.959088347, 11.961262874, 11.963483908, 11.965558582, 11.967777326, 11.969750876, 11.971889937, 11.973826349, 11.975993186, 11.977993291, 11.980559967, 11.982998958, 11.984676614, 11.986882544, 11.988906996, 11.990627954, 11.992339515, 11.994140723, 11.99611366, 11.997936976, 11.999313313, 12.00078635, 12.002758376, 12.0045195, 12.006181924, 12.008206282, 12.010124401, 12.012084316, 12.013776784, 12.015409671, 12.017028808, 12.018417237, 12.020709917, 12.022546222, 12.02469638, 12.02633059, 12.028035333, 12.029396351, 12.030815478, 12.032528913, 12.034182196, 12.03545008, 12.037521823, 12.039183931, 12.041100911, 12.043122247, 12.044126667, 12.045457052, 12.047272456, 12.048988151, 12.050479656, 12.052016453, 12.053189401, 12.05464071, 12.055909128, 12.057186844, 12.057981798, 12.059420399, 12.060698348, 12.061876957, 12.063203118, 12.064891897, 12.066407561, 12.067420731, 12.068841843, 12.069685773, 12.071027635, 12.072317558, 12.073661757, 12.074845525, 12.076196753, 12.077598994, 12.078759512, 12.079983522, 12.081136295, 12.082789495, 12.083706977, 12.085259971, 12.086598381, 12.087548508, 12.088395038, 12.089482956, 12.090848552, 12.092192865, 12.093646172, 12.094470638, 12.095606161, 12.096772426, 12.09800063, 12.09942223, 12.100432654, 12.101428001, 12.102580101, 12.103609614, 12.104508214, 12.105899357, 12.106785153, 12.10775748, 12.108510362, 12.109476402, 12.110026756, 12.111082444, 12.112167034, 12.112991932, 12.114333712, 12.114928301, 12.116055919, 12.116721871, 12.117732397, 12.11884389, 12.11959541, 12.120530849, 12.121327681, 12.122068343, 12.122904473, 12.123409116, 12.12437726, 12.12542487, 12.126716395, 12.12777665, 12.128533811, 12.129230101, 12.130401991, 12.131541121, 12.132351733, 12.133045223, 12.133855134, 12.134785778, 12.135422587, 12.136074632, 12.13699641, 12.137888432, 12.138430212, 12.139422156, 12.139754324, 12.140701545, 12.141457708, 12.142606578, 12.143388033, 12.144133098, 12.144713033, 12.145435051, 12.146154356, 12.147036904, 12.148170127, 12.148453467, 12.14957943, 12.150441591, 12.151307603, 12.152437939, 12.152898164, 12.153353196, 12.15384459, 12.154590847, 12.155571826, 12.156155956, 12.156980789, 12.157615521, 12.158254376, 12.159022041, 12.159593026, 12.160416237, 12.161072634, 12.16200385, 12.162330447, 12.162980004, 12.163542662, 12.164175299, 12.164594985, 12.165190881, 12.16583361, 12.166210132, 12.166843129, 12.167625381, 12.168217752, 12.168658755, 12.16937553, 12.169799289, 12.17066088, 12.171702806, 12.171893359, 12.172603872, 12.173156918, 12.173938245, 12.174375685, 12.174689971, 12.175546494, 12.176120808, 12.176617496, 12.1770984, 12.177406497, 12.177977614, 12.17881195, 12.179805638, 12.180206143, 12.180688186, 12.180956316, 12.181325746, 12.181798968, 12.182965421, 12.183929354, 12.184479075, 12.184643527, 12.185140212, 12.185515954, 12.186039097, 12.186313845, 12.186978215, 12.187548552, 12.188467088, 12.1890111, 12.189568472, 12.18972195, 12.190223168, 12.190326266, 12.190778274, 12.190958881, 12.191588233, 12.191886642, 12.192104822, 12.192583484, 12.192931218, 12.19327084, 12.193527812, 12.194158978, 12.194648394, 12.194840662, 12.195569546, 12.196055701, 12.196239325, 12.196482815, 12.196835701, 12.197062238, 12.197269344, 12.197636324, 12.197902937, 12.198609671, 12.198898657, 12.199142544, 12.199346771, 12.199454728, 12.199843578, 12.200170625, 12.200548667, 12.201544611, 12.202700425, 12.202890685, 12.203221392, 12.203392576, 12.203803964, 12.204178636, 12.204495409, 12.204963434, 12.205253187, 12.205367933, 12.20551096, 12.205614496, 12.205977088, 12.206192557, 12.207018414, 12.20722794, 12.207628233, 12.207958388, 12.208287022, 12.208518169, 12.20860066, 12.209043961, 12.20926696, 12.209560283, 12.209843851, 12.210170631, 12.210404496, 12.210748197, 12.211071123, 12.211443952, 12.211841725, 12.2118983, 12.212017228, 12.212255364, 12.212579705, 12.212956036, 12.212961761, 12.213025412, 12.213711974, 12.213935289, 12.214304625, 12.214827171, 12.215180751, 12.215255984, 12.215736858, 12.215969605, 12.216021249, 12.216374261, 12.216910076, 12.216945196, 12.217198752, 12.217282665, 12.217497456, 12.217508068, 12.218441066, 12.218616399, 12.218885129, 12.219043, 12.219227705, 12.219339207, 12.219832854, 12.220223861, 12.22031109, 12.220495629, 12.220579302, 12.220664422, 12.220711628, 12.220853979, 12.220945108, 12.221080935, 12.221500277, 12.221973279, 12.222450244, 12.222635942, 12.222766767, 12.22285714, 12.222883223, 12.223183593, 12.223373956, 12.223523855, 12.223634285, 12.223913065, 12.22395152, 12.223995485, 12.224191992, 12.224262452, 12.224509264, 12.224589308, 12.224610402), "6" = c(3.1358e-05, 3.199e-05, 3.2215e-05, 3.2604e-05, 3.2964e-05, 3.43e-05, 3.4741e-05, 3.4961e-05, 3.5372e-05, 3.5422e-05, 3.5568e-05, 3.5881e-05, 3.6385e-05, 3.6488e-05, 3.6659e-05, 3.7058e-05, 3.7107e-05, 3.7398e-05, 3.7499e-05, 3.8212e-05, 3.8752e-05, 3.8811e-05, 3.8866e-05, 4.0702e-05, 4.0805e-05, 4.0869e-05, 4.115e-05, 4.1226e-05, 4.2528e-05, 4.2867e-05, 4.2897e-05, 4.5052e-05, 4.5384e-05, 4.5909e-05, 4.6076e-05, 4.6386e-05, 4.6524e-05, 4.6802e-05, 4.7191e-05, 4.7556e-05, 4.8027e-05, 4.8352e-05, 4.8502e-05, 4.9601e-05, 5.0181e-05, 5.0304e-05, 5.1075e-05, 5.1409e-05, 5.1589e-05, 5.249e-05, 5.3015e-05, 5.3929e-05, 5.421e-05, 5.4614e-05, 5.5116e-05, 5.5548e-05, 5.6369e-05, 5.7154e-05, 5.7758e-05, 5.8629e-05, 5.925e-05, 6.0019e-05, 6.1106e-05, 6.1425e-05, 6.1855e-05, 6.224e-05, 6.3563e-05, 6.407e-05, 6.5906e-05, 6.6758e-05, 6.7046e-05, 6.7223e-05, 6.8348e-05, 6.8514e-05, 6.9641e-05, 7.0231e-05, 7.1479e-05, 7.2577e-05, 7.3317e-05, 7.3954e-05, 7.4817e-05, 7.5618e-05, 7.5813e-05, 7.7122e-05, 7.8087e-05, 7.9237e-05, 8.012e-05, 8.0243e-05, 8.1779e-05, 8.231e-05, 8.4462e-05, 8.5127e-05, 8.5905e-05, 8.7885e-05, 8.9497e-05, 9.1079e-05, 9.2526e-05, 9.3303e-05, 9.4744e-05, 9.5542e-05, 9.6375e-05, 9.8544e-05, 9.902e-05, 9.9332e-05, 0.000100327, 0.000101334, 0.000101843, 0.000105041, 0.00010553, 0.000106943, 0.000108932, 0.000111273, 0.000112326, 0.000113296, 0.000114312, 0.00011713, 0.000120026, 0.000122239, 0.000124341, 0.000125049, 0.000125785, 0.00012669, 0.000127089, 0.00012754, 0.00012958, 0.000130862, 0.000131803, 0.000133833, 0.000134431, 0.000136624, 0.000137298, 0.000138366, 0.000139129, 0.000140502, 0.000142434, 0.000145286, 0.000146587, 0.000147148, 0.000149636, 0.000150534, 0.000153821, 0.000155387, 0.000157036, 0.000158884, 0.000160799, 0.000162778, 0.000164749, 0.000166989, 0.000169952, 0.000170893, 0.00017248, 0.000174911, 0.000176752, 0.000178576, 0.000181883, 0.000185364, 0.000187306, 0.000188943, 0.000190169, 0.000191289, 0.000194582, 0.000196643, 0.000199103, 0.000200883, 0.000202463, 0.000205172, 0.000209269, 0.000211035, 0.000214002, 0.000217027, 0.000219418, 0.000221686, 0.000224033, 0.000226431, 0.000228844, 0.000232905, 0.000234994, 0.000236859, 0.000239332, 0.000242202, 0.000244334, 0.000248079, 0.000251063, 0.000253493, 0.000257094, 0.000258939, 0.000263413, 0.00026642, 0.00026928, 0.000272847, 0.000275031, 0.000279454, 0.000282502, 0.000287279, 0.000288813, 0.000292289, 0.000295726, 0.000298568, 0.000300983, 0.000305033, 0.000309459, 0.000311539, 0.000313804, 0.000317825, 0.000324706, 0.000327784, 0.000330988, 0.000333835, 0.000337482, 0.000342636, 0.000346308, 0.000350424, 0.000354095, 0.000356466, 0.000361552, 0.000367086, 0.000370716, 0.000376316, 0.000382317, 0.00038593, 0.000391478, 0.000397068, 0.000399942, 0.000405609, 0.000409808, 0.000414337, 0.000419119, 0.000422939, 0.00042844, 0.000433489, 0.000438026, 0.000442673, 0.000447499, 0.00045592, 0.000460823, 0.000468677, 0.000473994, 0.000477837, 0.000481731, 0.000486912, 0.000494621, 0.000502888, 0.000510092, 0.000516883, 0.000524098, 0.000530554, 0.000536137, 0.000540917, 0.000546026, 0.000551482, 0.000558451, 0.000563719, 0.000571731, 0.000577546, 0.000584718, 0.000594017, 0.000600639, 0.000611098, 0.000618041, 0.000625433, 0.000633574, 0.000639748, 0.000648174, 0.000654127, 0.000663736, 0.000670907, 0.000678348, 0.000687715, 0.000694103, 0.00070408, 0.000713057, 0.000721742, 0.000731484, 0.000738256, 0.000747753, 0.000756947, 0.000767129, 0.000775268, 0.00078463, 0.000797949, 0.000806928, 0.000815876, 0.000826115, 0.000836937, 0.000847243, 0.000855766, 0.000863722, 0.000875365, 0.000882285, 0.000895156, 0.000901138, 0.000911201, 0.000922752, 0.00093168, 0.000942428, 0.000953781, 0.000966221, 0.000980283, 0.000988012, 0.001004412, 0.001015536, 0.001026814, 0.001042387, 0.001052762, 0.001062743, 0.001073587, 0.001086986, 0.001100474, 0.001114898, 0.001127425, 0.00114134, 0.00115469, 0.001168244, 0.00118286, 0.001197807, 0.001211545, 0.001226369, 0.001242923, 0.001253856, 0.00127046, 0.001284516, 0.001302275, 0.001321528, 0.001334926, 0.001352586, 0.001369274, 0.001386095, 0.001401396, 0.001415442, 0.001434787, 0.001448325, 0.001465383, 0.001478626, 0.001493416, 0.001512424, 0.001531111, 0.001550665, 0.001566872, 0.001585362, 0.001603616, 0.001618772, 0.001622189, 0.0016379, 0.001660578, 0.00167862, 0.00169572, 0.001717002, 0.001737744, 0.001755432, 0.001775606, 0.001798234, 0.001819496, 0.001839298, 0.001857857, 0.001882414, 0.001907021, 0.001926812, 0.001949346, 0.001974211, 0.001996867, 0.002021221, 0.002046505, 0.002070506, 0.002092403, 0.002118607, 0.002139654, 0.002165837, 0.002185864, 0.002207371, 0.002233436, 0.002260244, 0.002285607, 0.002313696, 0.002337864, 0.00236019, 0.002388151, 0.002415846, 0.00244324, 0.002473226, 0.002494795, 0.002521855, 0.00255456, 0.002584934, 0.002614476, 0.002642928, 0.002674447, 0.002708406, 0.002744966, 0.002780954, 0.002810208, 0.002838564, 0.002868369, 0.002909759, 0.002939206, 0.002973684, 0.003010544, 0.003043807, 0.003084327, 0.003116059, 0.003160138, 0.003195558, 0.003230986, 0.003267562, 0.003312263, 0.003358702, 0.003397273, 0.003433537, 0.003470614, 0.003518371, 0.003556198, 0.003592701, 0.003635947, 0.00368405, 0.00372651, 0.003762686, 0.003807754, 0.00385522, 0.003899725, 0.003946888, 0.003983832, 0.00402626, 0.004068371, 0.004114358, 0.004164022, 0.004213087, 0.004256585, 0.00430583, 0.004358012, 0.004410824, 0.004463931, 0.00452143, 0.004573049, 0.004629808, 0.004682287, 0.004731446, 0.004784838, 0.004838168, 0.004897421, 0.004956533, 0.005006963, 0.005066982, 0.00512283, 0.005181988, 0.005250067, 0.00530931, 0.005377239, 0.005434665, 0.005499989, 0.005563998, 0.00562873, 0.005690858, 0.005760167, 0.005828701, 0.005891394, 0.005962076, 0.006033243, 0.006097639, 0.006164996, 0.006237171, 0.006303471, 0.006379314, 0.006461709, 0.006534404, 0.006597755, 0.006671983, 0.006752468, 0.006827253, 0.006913804, 0.006998163, 0.007077921, 0.007164246, 0.007239587, 0.007326362, 0.007414885, 0.007508986, 0.007594542, 0.007685408, 0.007777279, 0.007864146, 0.007953763, 0.008046213, 0.008134679, 0.008219248, 0.008311884, 0.008408814, 0.008507289, 0.008602258, 0.008702739, 0.008812805, 0.008912228, 0.009017911, 0.009125268, 0.009238558, 0.009341648, 0.009444282, 0.009557411, 0.009674552, 0.009783983, 0.009893443, 0.010013104, 0.010133875, 0.010255026, 0.010370431, 0.010490746, 0.010624207, 0.010752412, 0.010881084, 0.010997724, 0.01111531, 0.011249304, 0.011386856, 0.011513152, 0.011649222, 0.011777298, 0.011912488, 0.012056016, 0.012192791, 0.012333772, 0.012475704, 0.01262172, 0.012785768, 0.012942093, 0.013097827, 0.013242494, 0.013393291, 0.013542815, 0.013687881, 0.013859042, 0.014000969, 0.014161072, 0.014307929, 0.014469906, 0.014643222, 0.014816175, 0.014998539, 0.015170773, 0.015337204, 0.015501237, 0.015672485, 0.015858415, 0.016030623, 0.016178362, 0.016215504, 0.016396593, 0.016591613, 0.016768061, 0.016980079, 0.017166765, 0.017355176, 0.017542901, 0.017740399, 0.017948503, 0.018152207, 0.018355998, 0.01856894, 0.018775423, 0.018999371, 0.019219394, 0.019425251, 0.01965511, 0.019888081, 0.020111296, 0.020329606, 0.020559568, 0.020789629, 0.021030006, 0.021284409, 0.021526297, 0.021771246, 0.022025405, 0.022272097, 0.022527079, 0.02280131, 0.023049242, 0.023310727, 0.023599445, 0.023864264, 0.024126937, 0.024396768, 0.024656958, 0.02493037, 0.025231085, 0.025517073, 0.025813018, 0.026105055, 0.026402359, 0.026706853, 0.02701713, 0.02732196, 0.027647032, 0.027948432, 0.028259155, 0.028579215, 0.028887198, 0.02922414, 0.029545817, 0.029877508, 0.030211525, 0.030568475, 0.030921872, 0.031268224, 0.031629401, 0.03199219, 0.032354484, 0.032711846, 0.033067724, 0.033446489, 0.033825924, 0.034210033, 0.034595255, 0.034972531, 0.03536243, 0.035759053, 0.036177683, 0.036579119, 0.036993551, 0.037424256, 0.037839047, 0.038276011, 0.038707558, 0.03914052, 0.039583098, 0.040033056, 0.040477639, 0.0409489, 0.041424137, 0.041866004, 0.042322992, 0.042795923, 0.043280602, 0.043757681, 0.044252212, 0.044763138, 0.045290131, 0.045784271, 0.046297535, 0.046823264, 0.047321812, 0.047851715, 0.048406534, 0.048953948, 0.049513915, 0.050070172, 0.050620642, 0.051158871, 0.051754218, 0.052312307, 0.052895072, 0.053477214, 0.054065234, 0.054675623, 0.055272491, 0.055880665, 0.056525101, 0.057148377, 0.057772583, 0.058426521, 0.059047357, 0.059700687, 0.060364097, 0.061015297, 0.061684283, 0.062374565, 0.063071958, 0.06377796, 0.064486051, 0.065189431, 0.065900462, 0.066620365, 0.067353583, 0.068095393, 0.06885572, 0.069633721, 0.070398052, 0.07119047, 0.071974699, 0.072745245, 0.07353188, 0.074317254, 0.075147921, 0.075951652, 0.076799269, 0.077633025, 0.07847584, 0.079325042, 0.08016444, 0.081028111, 0.081912885, 0.082801627, 0.083662253, 0.084552999, 0.085465385, 0.086382252, 0.08731652, 0.08821957, 0.089188922, 0.090138972, 0.091087401, 0.092071924, 0.093010932, 0.093986333, 0.094977364, 0.095965325, 0.096946211, 0.097962154, 0.099016624, 0.100044234, 0.101071376, 0.102108951, 0.103151843, 0.104169369, 0.105247715, 0.106337643, 0.107425966, 0.108549681, 0.109627863, 0.110764897, 0.111881418, 0.113048363, 0.114192813, 0.115365123, 0.116568379, 0.117785141, 0.119002019, 0.120214328, 0.121452633, 0.122674801, 0.123963044, 0.125253194, 0.1265536, 0.127851731, 0.129150895, 0.130452499, 0.131809665, 0.133148279, 0.134563422, 0.135935853, 0.137323133, 0.138743161, 0.140178673, 0.141643681, 0.143102921, 0.14428474, 0.144585384, 0.146064633, 0.147561724, 0.149135387, 0.150705516, 0.152289702, 0.153864596, 0.155436416, 0.15703033, 0.158684074, 0.160321311, 0.16199507, 0.163653702, 0.165327975, 0.167032974, 0.168739884, 0.170508516, 0.172268812, 0.174082475, 0.17585731, 0.177653481, 0.179501595, 0.181365929, 0.183233655, 0.18514769, 0.187101056, 0.189053639, 0.191023557, 0.192996216, 0.195030979, 0.197037404, 0.199012936, 0.201055581, 0.20315131, 0.205301021, 0.207410864, 0.209560116, 0.211799714, 0.214001306, 0.216263103, 0.218517794, 0.220788348, 0.223149574, 0.225526093, 0.227864271, 0.230260082, 0.232756763, 0.235188929, 0.237615219, 0.240098053, 0.242593152, 0.245147146, 0.247704284, 0.250344004, 0.252983703, 0.255704915, 0.258415153, 0.261139904, 0.26384025, 0.266656355, 0.269454278, 0.272283524, 0.275145342, 0.278025202, 0.280889228, 0.283907731, 0.286889664, 0.289941041, 0.293025842, 0.296117632, 0.299274712, 0.302508502, 0.305717984, 0.308926548, 0.312183529, 0.315486499, 0.318839891, 0.322245719, 0.325677067, 0.329172868, 0.332679828, 0.336207989, 0.339830293, 0.343411755, 0.34710179, 0.350806107, 0.354604019, 0.358376402, 0.362228052, 0.366069705, 0.369972243, 0.373867225, 0.377838246, 0.381831872, 0.385894652, 0.390046521, 0.390953072, 0.394198849, 0.398395836, 0.402627118, 0.40693311, 0.41125517, 0.415677971, 0.420141956, 0.424685307, 0.429267491, 0.433878042, 0.43847912, 0.44317343, 0.447887243, 0.452750497, 0.457633927, 0.462528327, 0.467533505, 0.47254767, 0.477597885, 0.482681923, 0.487823623, 0.493109727, 0.498454262, 0.503816645, 0.509230077, 0.510331876, 0.514627251, 0.520179694, 0.525797963, 0.53147953, 0.537149791, 0.54296638, 0.548862868, 0.554770919, 0.560744408, 0.566745705, 0.572901181, 0.579082664, 0.585332978, 0.591630761, 0.598046446, 0.604514322, 0.611098711, 0.617663425, 0.624332178, 0.631150707, 0.637879773, 0.644802997, 0.651688685, 0.658762193, 0.665889952, 0.673092478, 0.680292824, 0.687653482, 0.69508272, 0.702522201, 0.710090337, 0.717724366, 0.725483682, 0.733276872, 0.741123631, 0.744523772, 0.749175397, 0.757277375, 0.765389464, 0.773655983, 0.782006515, 0.790446221, 0.799037926, 0.807683152, 0.816419795, 0.825256251, 0.834246655, 0.843184506, 0.852261068, 0.861466906, 0.870751333, 0.880148681, 0.889716656, 0.899284005, 0.908896767, 0.918673285, 0.92854399, 0.938557144, 0.948585361, 0.958797206, 0.969190839, 0.973484459, 0.979672605, 0.990340093, 1.001161981, 1.012232096, 1.023425326, 1.034719518, 1.04632504, 1.058102299, 1.070011444, 1.082016031, 1.09435498, 1.106828199, 1.119507516, 1.132378671, 1.145303223, 1.1586069, 1.172015508, 1.185814255, 1.199950723, 1.211416412, 1.237306978, 1.251620409, 1.266094463, 1.280472648, 1.294774315, 1.309095562, 1.323301903, 1.337403375, 1.351625445, 1.365843858, 1.380071923, 1.394102256, 1.408186104, 1.422139982, 1.436258509, 1.45009706, 1.464005663, 1.477886583, 1.485998056, 1.491718409, 1.505608823, 1.519537746, 1.533418291, 1.547250357, 1.56096935, 1.574742824, 1.588467967, 1.602065274, 1.615773508, 1.629438976, 1.643074893, 1.656703826, 1.67048235, 1.684233943, 1.69778449, 1.711562168, 1.72519738, 1.738668346, 1.752408779, 1.766076353, 1.779790481, 1.793478187, 1.807169555, 1.820927716, 1.828851938, 1.834686993, 1.848371903, 1.862132179, 1.875943096, 1.889803931, 1.903730641, 1.91773716, 1.931715216, 1.945909864, 1.96012055, 1.974432486, 1.988819792, 2.003513476, 2.018211964, 2.033064261, 2.048389851, 2.064290158, 2.080517128, 2.09698635, 2.113989373, 2.131773028, 2.149857908, 2.168221376, 2.187099741, 2.206256945, 2.225851721, 2.246143178, 2.266609177, 2.287541484, 2.308922044, 2.331149519, 2.353651111, 2.377131243, 2.400908312, 2.425503795, 2.445511057, 2.450716679, 2.476638497, 2.50318257, 2.530272291, 2.557373435, 2.58493795, 2.612547438, 2.640463784, 2.669055946, 2.697861363, 2.72683001, 2.756300212, 2.785901668, 2.815934923, 2.846487264, 2.87737797, 2.90873349, 2.940263634, 2.972317062, 3.004688958, 3.037740406, 3.071353862, 3.105044443, 3.139214207, 3.174109478, 3.201823877, 3.209645293, 3.245716528, 3.282321457, 3.319329941, 3.356381173, 3.394201368, 3.433189924, 3.472424453, 3.511674264, 3.552420325, 3.593752095, 3.635291202, 3.67816185, 3.721014471, 3.763902505, 3.806975119, 3.850802463, 3.894095564, 3.937724678, 3.981477856, 4.026035245, 4.070352726, 4.114677704, 4.158596113, 4.203519252, 4.248606135, 4.293796242, 4.339020451, 4.384867763, 4.429742788, 4.475340175, 4.52148588, 4.567099339, 4.61317506, 4.659170489, 4.705563915, 4.751717005, 4.797306822, 4.843493425, 4.889480644, 4.936329448, 4.982966613, 5.029465536, 5.076526251, 5.122685421, 5.169865319, 5.216677718, 5.263712172, 5.311416797, 5.358789973, 5.406044187, 5.454000023, 5.500891196, 5.548564306, 5.596105395, 5.643472319, 5.692336717, 5.739869868, 5.787590522, 5.835452346, 5.883585915, 5.931261383, 5.979539234, 6.027380898, 6.075539533, 6.122902428, 6.171343447, 6.219081584, 6.267387505, 6.31543678, 6.363637609, 6.412609318, 6.459467785, 6.507645468, 6.556056258, 6.60355698, 6.651697034, 6.699711034, 6.747802459, 6.795248344, 6.84348736, 6.890704669, 6.938877503, 6.987358116, 7.036737005, 7.086255639, 7.134403227, 7.181532981, 7.230241034, 7.278177513, 7.326222116, 7.374200679, 7.422932132, 7.470005553, 7.51792501, 7.565439937, 7.574942038, 7.612558751, 7.660462506, 7.708477531, 7.754314487, 7.800808873, 7.849413885, 7.896443451, 7.944262058, 7.992587911, 8.039199322, 8.08591291, 8.13287917, 8.180237704, 8.227605582, 8.273691108, 8.321146435, 8.368347903, 8.413756924, 8.460510392, 8.507186518, 8.553309921, 8.600598262, 8.64744457, 8.694813423, 8.742570063, 8.789992211, 8.835152611, 8.88169509, 8.927965199, 8.974749292, 9.020500773, 9.066379533, 9.111963751, 9.159341348, 9.205783305, 9.250785576, 9.295622262, 9.342452185, 9.386786681, 9.431732322, 9.476260519, 9.521087114, 9.567043405, 9.612224461, 9.657189095, 9.702061099, 9.747191368, 9.791898059, 9.837009982, 9.88089322, 9.924135071, 9.967877366, 10.011109361, 10.056155434, 10.099599942, 10.143672807, 10.185499409, 10.228488011, 10.272368989, 10.315804865, 10.35983312, 10.403601461, 10.445774596, 10.488111719, 10.530833139, 10.573090363, 10.616459487, 10.658021896, 10.700152911, 10.743135262, 10.784125758, 10.825967949, 10.868603742, 10.909381005, 10.951435069, 10.992962297, 11.035257103, 11.076445774, 11.118304837, 11.158790196, 11.198999805, 11.240475958, 11.282442942, 11.323467823, 11.365433206, 11.405102891, 11.445151842, 11.485050939, 11.524204281, 11.561770464, 11.601193241, 11.641225482, 11.680781889, 11.719315097, 11.758645823, 11.797076224, 11.835749634, 11.875272649, 11.91278869, 11.952315678, 11.991285442, 12.028392465, 12.065397742, 12.103283918, 12.13986447, 12.178211411, 12.215436532, 12.251972379, 12.289632573, 12.327255127, 12.364407016, 12.40245052, 12.439478085, 12.476892999, 12.515170273, 12.551108151, 12.587855993, 12.62568361, 12.661234996, 12.69846867, 12.733031371, 12.770519767, 12.805812585, 12.841980406, 12.876973641, 12.911692418, 12.946238474, 12.980166022, 13.013471219, 13.048670018, 13.083841984, 13.11711976, 13.150714025, 13.184355568, 13.219024484, 13.252616183, 13.284961911, 13.319329111, 13.353231794, 13.386229098, 13.420905995, 13.452826108, 13.485346055, 13.519188365, 13.551998247, 13.585617934, 13.618141954, 13.650848499, 13.683106042, 13.715673292, 13.750399783, 13.782960783, 13.814283336, 13.845678265, 13.875794035, 13.905837791, 13.936702963, 13.967240936, 13.999207995, 14.031790859, 14.061778301, 14.092673621, 14.121659084, 14.1527083, 14.182485426, 14.213159169, 14.243000971, 14.273048605, 14.302563757, 14.331968411, 14.361632026, 14.39326471, 14.422626988, 14.451310207, 14.479986595, 14.509250852, 14.537722527, 14.567453181, 14.597467987, 14.626244329, 14.654681756, 14.683477498, 14.710888154, 14.738242368, 14.76692133, 14.795145266, 14.822718596, 14.850056694, 14.876576984, 14.90625144, 14.93414322, 14.959979689, 14.987092731, 15.012830461, 15.037120239, 15.062627933, 15.088482875, 15.116580408, 15.142875307, 15.168014967, 15.173175383, 15.194140158, 15.220682107, 15.248913729, 15.274293804, 15.301620624, 15.326225018, 15.349587202, 15.374260652, 15.39901838, 15.424383051, 15.450016588, 15.475083315, 15.501929227, 15.528635719, 15.551885627, 15.577342621, 15.601116995, 15.626797741, 15.650473911, 15.67380756, 15.697750772, 15.721586895, 15.746769288, 15.770218185, 15.795552211, 15.817566257, 15.842167215, 15.867048587, 15.888656193, 15.910736274, 15.933287741, 15.95600103, 15.979191671, 16.000590741, 16.022690176, 16.045633872, 16.068144385, 16.089615365, 16.111788391, 16.132191982, 16.153911828, 16.174505806, 16.197898553, 16.218112875, 16.240067172, 16.261699782, 16.283676834, 16.304367881, 16.326151781, 16.347341553, 16.368338311, 16.389025864, 16.40898225, 16.42744778, 16.445121285, 16.463814913, 16.482823531, 16.502912573, 16.522139051, 16.54345999, 16.563114059, 16.582710025, 16.602521548, 16.622217503, 16.640595781, 16.659082694, 16.679101469, 16.698794772, 16.717263719, 16.738028218, 16.755786152, 16.772081148, 16.789092209, 16.807565951, 16.82628045, 16.844605617, 16.863315635, 16.882110912, 16.899998036, 16.919035008, 16.936451778, 16.95386839, 16.974376646, 16.991082742, 17.008976222, 17.027245826, 17.044832081, 17.060835654, 17.080133535, 17.095761574, 17.115368094, 17.132343087, 17.149452636, 17.167334456, 17.185074055, 17.200586724, 17.218287343, 17.236346858, 17.253543795, 17.269716518, 17.285332207, 17.300761435, 17.31524487, 17.332690356, 17.346599086, 17.360626661, 17.3755371, 17.390862409, 17.404333159, 17.4190408, 17.434268738, 17.448927874, 17.465744779, 17.480802774, 17.499558918, 17.514786495, 17.531388122, 17.54909607, 17.56246693, 17.578254932, 17.594646452, 17.60988222, 17.625054914, 17.639335725, 17.653051928, 17.666224688, 17.679884514, 17.694084818, 17.709567309, 17.723563382, 17.738162464, 17.749922381, 17.76434886, 17.778498012, 17.791996104, 17.806420418, 17.82051673, 17.833523458, 17.846410401, 17.860503107, 17.87277778, 17.884837162, 17.898057968, 17.909021697, 17.92109648, 17.933589843, 17.946094622, 17.958736104, 17.96924387, 17.981464751, 17.992149466, 18.001987361, 18.014865349, 18.028235553, 18.040001197, 18.051186397, 18.062810946, 18.077065269, 18.086610612, 18.099308386, 18.110762952, 18.123326584, 18.133501947, 18.146537603, 18.157609657, 18.16895237, 18.181858243, 18.193637066, 18.204363544, 18.215889602, 18.22608638, 18.237327209, 18.247365324, 18.259188041, 18.271868913, 18.282116515, 18.292461586, 18.302295659, 18.312705869, 18.32509411, 18.337313209, 18.347481497, 18.356990282, 18.36684485, 18.378741097, 18.389415564, 18.40176925, 18.413421702, 18.422770719, 18.432889755, 18.441935978, 18.45338354, 18.466252281, 18.476196349, 18.488254874, 18.497697056, 18.509148473, 18.518985249, 18.527443759, 18.537977035, 18.539255886, 18.54595779, 18.554225986, 18.56287057, 18.573434601, 18.580269074, 18.590529938, 18.601775633, 18.611533741, 18.621507406, 18.629178951, 18.636110465, 18.644253967, 18.651786682, 18.662290895, 18.672452103, 18.680970838, 18.690778396, 18.699598866, 18.70819452, 18.714922057, 18.722849945, 18.731540757, 18.741295652, 18.749460393, 18.75856011, 18.767572894, 18.774551068, 18.783624088, 18.790850001, 18.798093074, 18.805584057, 18.816138662, 18.822468611, 18.830264074, 18.837481755, 18.846194734, 18.854074943, 18.859546229, 18.866051476, 18.871934708, 18.879769437, 18.887815052, 18.895745955, 18.903857637, 18.912650662, 18.92109785, 18.930456501, 18.93856076, 18.94747826, 18.954991725, 18.962747609, 18.97161652, 18.981063187, 18.987968724, 18.995455809, 19.000547029, 19.01047806, 19.016565238, 19.02465525, 19.030917333, 19.038013472, 19.04360459, 19.053117023, 19.058621601, 19.067517934, 19.076029748, 19.084042003, 19.090689661, 19.097079234, 19.104895179, 19.111042085, 19.118765764, 19.125627678, 19.133113557, 19.14031122, 19.145591381, 19.151579804, 19.157342784, 19.162798891, 19.171185234, 19.178233253, 19.184394533, 19.190429796, 19.195330823, 19.200271143, 19.205294138, 19.211547063, 19.216687486, 19.223146455, 19.229741886, 19.235181702, 19.243026474, 19.246856429, 19.252820461, 19.257340864, 19.260110082, 19.26500096, 19.272385536, 19.277298107, 19.283493591, 19.288401485, 19.292190536, 19.298108736, 19.305366553, 19.312991988, 19.31799428, 19.322395086, 19.328938498, 19.335072376, 19.340673446, 19.346078737, 19.351111145, 19.355398334, 19.360416096, 19.365708284, 19.369963149, 19.374551567, 19.378388782, 19.381543874, 19.387131349, 19.391142472, 19.398205213, 19.403951196, 19.411908639, 19.416011971, 19.420416503, 19.427128261, 19.430960108, 19.436183075, 19.440020194, 19.443441682, 19.44736406, 19.452223123, 19.455131591, 19.459474399, 19.46439275, 19.468459022, 19.471899205, 19.475355788, 19.479658404, 19.482249201, 19.485787749, 19.488041613, 19.492108141, 19.496696468, 19.501411647, 19.505846332, 19.508593368, 19.511266183, 19.514412194, 19.520130413, 19.523648143, 19.527435941, 19.529259501, 19.533427353, 19.536353512, 19.54224703, 19.546546825, 19.551361256, 19.555176304, 19.557115172, 19.562452156, 19.565730142, 19.568428247, 19.572462325, 19.575795225, 19.579071097, 19.583196925, 19.586494152, 19.58970746, 19.593056804, 19.596392369, 19.598789025, 19.603090899, 19.605910909, 19.608510973, 19.612225167, 19.615806019, 19.619662278, 19.62471347, 19.629282793, 19.633059436, 19.636846656, 19.639239743, 19.641020978, 19.647307512, 19.649423254, 19.650670073, 19.653680881, 19.656097037, 19.661159574, 19.664227598, 19.66734563, 19.669786912, 19.672452073, 19.676458095, 19.67819949, 19.679317961, 19.681669146, 19.684379576, 19.687946555, 19.691300451, 19.697548615, 19.700021226, 19.703673975, 19.705679137, 19.709832946, 19.712101766, 19.715656714, 19.718154876, 19.722325284, 19.72728388, 19.729672549, 19.731440481, 19.733560773, 19.737496326, 19.742843246, 19.744603838, 19.748654559, 19.75215159, 19.754520733, 19.757883357, 19.762410442, 19.765649411, 19.769292818, 19.770329963, 19.774106234, 19.778137536, 19.779885715, 19.78353691, 19.788532389, 19.791349877, 19.794897663, 19.797144684, 19.800203091, 19.801406131, 19.803085318, 19.806866775, 19.809642835, 19.812811466, 19.813253626, 19.818408266, 19.82218051, 19.825508862, 19.82811557, 19.833280911, 19.835106408, 19.838272913, 19.838838997, 19.844974336, 19.846656933, 19.848470314, 19.850671524, 19.852145568, 19.854877295, 19.858323009, 19.859226693, 19.8628968, 19.867283932, 19.870901899, 19.872972253, 19.876780473, 19.87886444, 19.879503669, 19.882044698, 19.884276432, 19.887518847, 19.888947756, 19.890883933, 19.891270276, 19.892829635, 19.897592751, 19.900369866, 19.900686529, 19.903289775, 19.904145471, 19.905207785, 19.905491685, 19.905921869, 19.906523517, 19.909574827, 19.911872845, 19.912724239, 19.91406781, 19.917057504, 19.918558906, 19.923833697, 19.925668188, 19.926230825, 19.92661756, 19.927152421, 19.929193425, 19.933772942, 19.935571024, 19.937695, 19.937985544, 19.942888699, 19.943748712, 19.94573214, 19.947220359, 19.947262021, 19.948872397, 19.950069197, 19.954000708, 19.954939627, 19.957210624, 19.958495312, 19.962567108, 19.963864689, 19.965915548, 19.966076808, 19.968001694, 19.9699005, 19.970797977, 19.971578762, 19.974282802, 19.975223833, 19.975260904, 19.97788226, 19.977949761, 19.979601496, 19.979641128, 19.981626192, 19.98346117, 19.984539273, 19.988127415, 19.988484237, 19.989670448, 19.98975718, 19.991561826, 19.993875471, 19.995170837, 19.997050402, 19.999600556, 20.001787308, 20.003113118, 20.004403039, 20.006901764, 20.007012622, 20.007909499), "8" = c(2.28e-05, 2.2812e-05, 2.316e-05, 2.3589e-05, 2.3888e-05, 2.4379e-05, 2.4737e-05, 2.4778e-05, 2.5034e-05, 2.5156e-05, 2.5391e-05, 2.5695e-05, 2.6095e-05, 2.6302e-05, 2.6341e-05, 2.6589e-05, 2.6728e-05, 2.69e-05, 2.6984e-05, 2.6996e-05, 2.7315e-05, 2.7389e-05, 2.7931e-05, 2.8255e-05, 2.851e-05, 2.8572e-05, 2.9144e-05, 2.919e-05, 2.957e-05, 2.9795e-05, 3.0015e-05, 3.0514e-05, 3.0957e-05, 3.0997e-05, 3.1479e-05, 3.1998e-05, 3.2246e-05, 3.2506e-05, 3.2689e-05, 3.3107e-05, 3.3609e-05, 3.3755e-05, 3.4042e-05, 3.4218e-05, 3.4358e-05, 3.4636e-05, 3.5106e-05, 3.5403e-05, 3.6139e-05, 3.6653e-05, 3.7016e-05, 3.7077e-05, 3.7884e-05, 3.8473e-05, 3.8942e-05, 3.9446e-05, 3.9851e-05, 4.0185e-05, 4.0489e-05, 4.1271e-05, 4.2231e-05, 4.2292e-05, 4.2846e-05, 4.3953e-05, 4.4846e-05, 4.5216e-05, 4.669e-05, 4.6805e-05, 4.8851e-05, 4.9228e-05, 4.9977e-05, 5.03e-05, 5.0763e-05, 5.2006e-05, 5.2528e-05, 5.4103e-05, 5.4594e-05, 5.5708e-05, 5.5897e-05, 5.64e-05, 5.6779e-05, 5.6942e-05, 5.7181e-05, 5.7937e-05, 5.8445e-05, 5.8784e-05, 5.9804e-05, 5.9958e-05, 6.0329e-05, 6.0695e-05, 6.1292e-05, 6.1952e-05, 6.307e-05, 6.3676e-05, 6.3951e-05, 6.5394e-05, 6.622e-05, 6.7122e-05, 6.7834e-05, 6.8521e-05, 7.0807e-05, 7.197e-05, 7.2642e-05, 7.3535e-05, 7.4161e-05, 7.6889e-05, 7.7603e-05, 7.8046e-05, 7.9375e-05, 8.0694e-05, 8.1491e-05, 8.2901e-05, 8.4528e-05, 8.4747e-05, 8.6876e-05, 8.8619e-05, 8.9506e-05, 9.1724e-05, 9.2358e-05, 9.3294e-05, 9.3665e-05, 9.4659e-05, 9.5959e-05, 9.6425e-05, 9.8345e-05, 9.9889e-05, 0.000100734, 0.000101445, 0.000102842, 0.000103659, 0.000105404, 0.000106238, 0.000107681, 0.000108286, 0.000110072, 0.000113073, 0.000114914, 0.000115967, 0.00011756, 0.000119455, 0.000120604, 0.00012227, 0.000123697, 0.000125357, 0.00012738, 0.000128337, 0.000129308, 0.000130703, 0.000132948, 0.000134258, 0.000135436, 0.000136896, 0.000138019, 0.00013941, 0.000140199, 0.000142829, 0.000144537, 0.000146235, 0.000148098, 0.000148963, 0.000149817, 0.000151312, 0.000153105, 0.000154607, 0.000156262, 0.000158941, 0.000161954, 0.000163595, 0.000165669, 0.000167183, 0.000169026, 0.000172253, 0.000173808, 0.000175941, 0.000177368, 0.000179305, 0.000181655, 0.000184148, 0.000186981, 0.000189283, 0.00019147, 0.000194023, 0.000197172, 0.000200484, 0.000203957, 0.000206211, 0.00020853, 0.000211897, 0.000216437, 0.000220409, 0.000222992, 0.000227507, 0.000231039, 0.000238991, 0.0002441, 0.000245779, 0.000247753, 0.000251293, 0.000254987, 0.000258395, 0.000260914, 0.000263864, 0.000265529, 0.000268109, 0.000270642, 0.000274252, 0.000276678, 0.000279451, 0.000282856, 0.000286136, 0.000288264, 0.000291791, 0.000296206, 0.00030079, 0.000304837, 0.000308009, 0.000314644, 0.000318984, 0.000323568, 0.000327327, 0.000332652, 0.00033579, 0.000338794, 0.000342813, 0.000345529, 0.000349641, 0.000353068, 0.000356047, 0.000358884, 0.000364317, 0.000368672, 0.000376388, 0.000379608, 0.000383847, 0.000387733, 0.000392518, 0.000397242, 0.000402386, 0.000408323, 0.000413784, 0.000418106, 0.000423652, 0.000428782, 0.000433451, 0.000437227, 0.000441753, 0.000446415, 0.000453371, 0.000457261, 0.000461481, 0.000468733, 0.000474327, 0.000479882, 0.000486549, 0.000492131, 0.000497539, 0.000504322, 0.000509915, 0.000515301, 0.000520851, 0.00052529, 0.000530835, 0.000537487, 0.0005431, 0.000548461, 0.000553975, 0.000560102, 0.000566405, 0.000572429, 0.000576488, 0.000582965, 0.00058882, 0.000595591, 0.000603294, 0.000611435, 0.000619107, 0.000626033, 0.000631185, 0.000636856, 0.00064634, 0.000654157, 0.000659826, 0.000664616, 0.000671269, 0.000677559, 0.000687098, 0.000694363, 0.000704079, 0.000713013, 0.000722547, 0.000732275, 0.000741766, 0.000750262, 0.000757802, 0.000764858, 0.000774529, 0.000784203, 0.000794508, 0.000802347, 0.000809793, 0.000818032, 0.000825956, 0.000834302, 0.00084253, 0.000849624, 0.000858686, 0.000868091, 0.000875481, 0.000887881, 0.00089623, 0.000904161, 0.00091556, 0.000924772, 0.00093569, 0.000947029, 0.000958888, 0.000968894, 0.000979329, 0.000992942, 0.001002606, 0.00101525, 0.001028405, 0.00103714, 0.001047028, 0.001060727, 0.001072586, 0.001090096, 0.001105159, 0.001120077, 0.001130928, 0.001142876, 0.001153758, 0.001166803, 0.001178538, 0.00119154, 0.001205293, 0.001218295, 0.001235437, 0.001249549, 0.001266396, 0.001275109, 0.001279743, 0.001294749, 0.001309518, 0.001321721, 0.001335911, 0.00135704, 0.001374593, 0.001389789, 0.001403727, 0.001418646, 0.0014373, 0.001455954, 0.001468745, 0.001484978, 0.001505553, 0.001522318, 0.001543129, 0.001559723, 0.001577728, 0.001596804, 0.001613726, 0.001631539, 0.001651259, 0.00167007, 0.001690471, 0.001711182, 0.001732451, 0.001754733, 0.001774663, 0.001796811, 0.001816174, 0.001838106, 0.001856437, 0.001876273, 0.001894254, 0.001912697, 0.001936009, 0.001957601, 0.001983866, 0.002008425, 0.002030555, 0.00205563, 0.002080617, 0.002102259, 0.002128004, 0.002152091, 0.002179772, 0.002205539, 0.002230916, 0.002257038, 0.00228153, 0.002309921, 0.002341933, 0.002367517, 0.002396025, 0.002419084, 0.002443645, 0.002473349, 0.002500988, 0.002530566, 0.002558867, 0.002592188, 0.002622773, 0.002653688, 0.002685852, 0.002710527, 0.002739292, 0.002771013, 0.002805532, 0.002841148, 0.002876093, 0.002908327, 0.002938022, 0.0029698, 0.003007237, 0.003046334, 0.003084801, 0.003117196, 0.003158254, 0.003191937, 0.00323091, 0.003273591, 0.003307939, 0.003346203, 0.003385846, 0.003422344, 0.003462461, 0.003499154, 0.003542888, 0.003580298, 0.003623424, 0.003660788, 0.003700015, 0.003746697, 0.003787726, 0.003829095, 0.003874217, 0.003919546, 0.003967354, 0.004012355, 0.004054909, 0.004104023, 0.00415392, 0.004201728, 0.00425125, 0.00430143, 0.004359122, 0.004407716, 0.004465701, 0.004516568, 0.004572003, 0.0046245, 0.004681527, 0.004736385, 0.004789013, 0.004845169, 0.004905531, 0.004960046, 0.00501498, 0.005066878, 0.005129343, 0.005185114, 0.005246013, 0.00529813, 0.005368111, 0.005427317, 0.005494596, 0.005563752, 0.005624566, 0.005687943, 0.005758409, 0.005822882, 0.005885038, 0.005953048, 0.006011803, 0.006085703, 0.006157038, 0.006222489, 0.006292354, 0.006362848, 0.006446602, 0.006523488, 0.006599065, 0.006668189, 0.006748726, 0.00683206, 0.006911043, 0.006984767, 0.007071469, 0.007148739, 0.007237793, 0.007318618, 0.007406666, 0.007488542, 0.007573191, 0.007658232, 0.007743015, 0.007830551, 0.007926813, 0.008014895, 0.008106883, 0.008193565, 0.008292405, 0.008394328, 0.008490269, 0.008590922, 0.008684052, 0.008786946, 0.008888797, 0.008982092, 0.009085557, 0.009201545, 0.009317563, 0.009422259, 0.009528887, 0.009625833, 0.009737365, 0.009852084, 0.009969622, 0.010088275, 0.010214621, 0.010326395, 0.010442125, 0.010553572, 0.010675566, 0.010788799, 0.010912427, 0.011040804, 0.011161991, 0.011294114, 0.011429435, 0.011562774, 0.01169382, 0.011817902, 0.01195551, 0.012082375, 0.012212543, 0.012353415, 0.01247507, 0.012621953, 0.012740155, 0.012770497, 0.012924713, 0.013067629, 0.013217593, 0.013367214, 0.013524067, 0.01368398, 0.013839744, 0.014004594, 0.014164991, 0.014337402, 0.014498624, 0.014660024, 0.014831457, 0.0149965, 0.015171485, 0.01534538, 0.015519828, 0.015692661, 0.015872933, 0.016053339, 0.016247976, 0.016431603, 0.016610825, 0.016806979, 0.016995114, 0.017192221, 0.017383511, 0.017583131, 0.017779577, 0.017983183, 0.018193519, 0.018387818, 0.018603722, 0.018826885, 0.01902499, 0.019246945, 0.019475961, 0.019695832, 0.019935096, 0.020165852, 0.020398797, 0.020630761, 0.020876896, 0.021112362, 0.021350738, 0.021593713, 0.021842834, 0.022090315, 0.022348177, 0.022597325, 0.022837385, 0.023115431, 0.023375345, 0.023648672, 0.023919933, 0.024196619, 0.024471426, 0.02475858, 0.02503864, 0.02532454, 0.025615194, 0.025919009, 0.026214867, 0.026510541, 0.026820288, 0.027123303, 0.027433286, 0.027733259, 0.028048981, 0.028369867, 0.028692202, 0.029016199, 0.029359406, 0.029694839, 0.03004354, 0.03039204, 0.030750588, 0.03109654, 0.031468257, 0.031825775, 0.032192117, 0.032561958, 0.032928156, 0.033309912, 0.033688603, 0.034070003, 0.034478652, 0.034867347, 0.035266087, 0.035661144, 0.036082008, 0.036504751, 0.036915964, 0.037336354, 0.037766036, 0.038201777, 0.038655974, 0.03908616, 0.039522686, 0.039970521, 0.040432871, 0.040897518, 0.04136469, 0.041838371, 0.042352158, 0.04284733, 0.04333027, 0.043826524, 0.044325448, 0.044836305, 0.045366177, 0.045882503, 0.046419001, 0.046956281, 0.047506174, 0.048052495, 0.048597493, 0.049141686, 0.049676446, 0.050264859, 0.050829934, 0.05140503, 0.051992186, 0.052588573, 0.053180573, 0.053781028, 0.054411726, 0.055009341, 0.055641297, 0.056281961, 0.056915064, 0.057567706, 0.058206095, 0.058829746, 0.059509998, 0.060193007, 0.06087266, 0.061569807, 0.062273044, 0.062997686, 0.063704762, 0.064443165, 0.065189993, 0.065934644, 0.066714981, 0.067509749, 0.068287634, 0.069081928, 0.069854008, 0.070630272, 0.071445561, 0.072280944, 0.07311026, 0.073957586, 0.074810048, 0.075642144, 0.076487533, 0.077373621, 0.078261148, 0.079147319, 0.080051452, 0.080943571, 0.081871586, 0.082803329, 0.083754969, 0.084705812, 0.085674887, 0.086642654, 0.087639976, 0.088627287, 0.089630189, 0.090646962, 0.091692892, 0.09274723, 0.093785038, 0.094849889, 0.095940257, 0.09699651, 0.098098452, 0.099200314, 0.100313497, 0.101444759, 0.102590136, 0.103762256, 0.104931346, 0.106096838, 0.107269783, 0.108468145, 0.109662826, 0.110910582, 0.112150573, 0.113411571, 0.114709742, 0.115973007, 0.117297362, 0.118646767, 0.11997447, 0.121334815, 0.122702891, 0.123811264, 0.124091098, 0.125460014, 0.126836251, 0.128271774, 0.129732614, 0.13120427, 0.132700762, 0.134209249, 0.135697013, 0.137217508, 0.13876452, 0.140332145, 0.141915971, 0.143528749, 0.145152896, 0.146784733, 0.148426499, 0.15008857, 0.151745556, 0.153435501, 0.155166311, 0.15690568, 0.158673514, 0.160443631, 0.162239034, 0.164076456, 0.165898749, 0.167775507, 0.169631601, 0.171525509, 0.173423735, 0.175382242, 0.177356872, 0.179356041, 0.181334604, 0.183339916, 0.18538738, 0.187431289, 0.189534436, 0.191652065, 0.193778518, 0.195897525, 0.198069218, 0.200272874, 0.202500957, 0.204731841, 0.206968297, 0.209256512, 0.211551608, 0.213879199, 0.21625388, 0.218646052, 0.221081823, 0.223491829, 0.225904585, 0.228393825, 0.230855618, 0.233419678, 0.235922216, 0.238515877, 0.24112284, 0.243787269, 0.246436373, 0.249114734, 0.251855348, 0.254579343, 0.257339068, 0.260101942, 0.262887423, 0.265705025, 0.268596005, 0.271514714, 0.274435041, 0.277391723, 0.280400208, 0.283434247, 0.286513739, 0.289590669, 0.292745725, 0.295891591, 0.29910332, 0.302339495, 0.30558642, 0.308917798, 0.312250308, 0.315640385, 0.319024184, 0.322481136, 0.325991074, 0.329465732, 0.333014956, 0.336589853, 0.340251984, 0.343921276, 0.347652578, 0.351395388, 0.352223076, 0.355135629, 0.35889926, 0.362728103, 0.366602715, 0.370521613, 0.374510156, 0.3784952, 0.382515305, 0.386630048, 0.390720381, 0.39487372, 0.399072776, 0.403324165, 0.407680189, 0.412044191, 0.416424216, 0.42087254, 0.425349544, 0.4298866, 0.434461227, 0.439133077, 0.443858952, 0.448612554, 0.453464061, 0.45833582, 0.459340398, 0.463240006, 0.468239589, 0.473249248, 0.478353892, 0.483447263, 0.488605375, 0.493848314, 0.49914226, 0.50445842, 0.509797407, 0.515257646, 0.520758271, 0.526345922, 0.531995482, 0.537674239, 0.543466823, 0.549325584, 0.555217013, 0.561197693, 0.567218139, 0.573297922, 0.579429007, 0.58573467, 0.592088199, 0.598437085, 0.604883223, 0.611417736, 0.618031619, 0.624736154, 0.631531172, 0.638340611, 0.64524873, 0.652244124, 0.659396918, 0.66659139, 0.669693571, 0.673860961, 0.681161295, 0.688531458, 0.696060367, 0.703660043, 0.711292447, 0.71903071, 0.726895704, 0.734903451, 0.742980308, 0.751208295, 0.759530752, 0.76787455, 0.776325622, 0.784826863, 0.793472292, 0.80233292, 0.811201683, 0.820197899, 0.829370213, 0.83862362, 0.848075532, 0.857569334, 0.867244348, 0.877052678, 0.881125049, 0.886997791, 0.897086448, 0.907314384, 0.91764927, 0.928094389, 0.938789897, 0.9494957, 0.960471449, 0.9717454, 0.983043016, 0.994536694, 1.00623505, 1.01805901, 1.030071146, 1.042364196, 1.054833285, 1.067607186, 1.080494646, 1.093636132, 1.104208989, 1.128514748, 1.141849832, 1.155273898, 1.168635055, 1.181934262, 1.195128327, 1.208390682, 1.221525066, 1.234648393, 1.247778324, 1.260835405, 1.273916462, 1.286924958, 1.29993269, 1.312930855, 1.32587909, 1.338847585, 1.351744329, 1.35928479, 1.364602862, 1.377499658, 1.390501709, 1.403427833, 1.416456057, 1.429317455, 1.442223848, 1.455145222, 1.468055254, 1.481015905, 1.493925624, 1.506857933, 1.519891146, 1.532870507, 1.545807336, 1.558924153, 1.572000845, 1.585037352, 1.598378866, 1.611668453, 1.62500304, 1.638344802, 1.651667122, 1.665097756, 1.6784059, 1.686115499, 1.691950252, 1.70562696, 1.719208488, 1.732876058, 1.746723304, 1.760610133, 1.77457915, 1.788646797, 1.802967043, 1.81714276, 1.831518608, 1.846147803, 1.860718234, 1.875500359, 1.890478124, 1.905523315, 1.9206989, 1.936118981, 1.951599892, 1.967286231, 1.98322145, 1.999286893, 2.01546844, 2.031802281, 2.048507608, 2.065456366, 2.082614107, 2.099976765, 2.117457182, 2.135290297, 2.153707001, 2.172289301, 2.191162162, 2.210281363, 2.2297733, 2.245233808, 2.24937258, 2.269666369, 2.290525076, 2.311572538, 2.332950881, 2.354495335, 2.376657697, 2.399216036, 2.422201856, 2.446010365, 2.470131093, 2.494904357, 2.519944342, 2.545749213, 2.572222917, 2.599346458, 2.626872735, 2.655344595, 2.683835387, 2.71367832, 2.743919656, 2.774904028, 2.80645133, 2.83850512, 2.871095262, 2.897347095, 2.904805399, 2.938388435, 2.972606078, 3.007603777, 3.042966878, 3.078456584, 3.115381366, 3.1518634, 3.1885622, 3.226642441, 3.26497256, 3.303695076, 3.342723113, 3.38243581, 3.421985981, 3.462304637, 3.503262773, 3.544286157, 3.585931455, 3.62785329, 3.670227411, 3.71248119, 3.755155794, 3.797933435, 3.841259643, 3.885894408, 3.929759129, 3.974307798, 4.019265401, 4.064949543, 4.110839474, 4.156890455, 4.203011213, 4.249113168, 4.29582669, 4.34202474, 4.389252724, 4.437448524, 4.485236909, 4.533934036, 4.582040199, 4.630614132, 4.678946381, 4.727792117, 4.777624257, 4.827000112, 4.877098933, 4.927114639, 4.977449769, 5.029108475, 5.079627796, 5.131269581, 5.182610188, 5.234167394, 5.285883798, 5.339287246, 5.390871571, 5.444862974, 5.497240035, 5.551432762, 5.604435786, 5.657284109, 5.711124623, 5.765909445, 5.820480502, 5.87518186, 5.929168871, 5.984423069, 6.040735393, 6.096393157, 6.152094095, 6.208344398, 6.264740426, 6.321072694, 6.377352402, 6.433127284, 6.490200214, 6.548706793, 6.606396788, 6.664173006, 6.722126424, 6.780992697, 6.838719769, 6.896715776, 6.956449206, 7.016184606, 7.075981253, 7.135544407, 7.195796704, 7.254557196, 7.312283326, 7.372379292, 7.433183134, 7.493902012, 7.554415423, 7.614870247, 7.627272752, 7.675837577, 7.736288252, 7.796884518, 7.858257025, 7.919406985, 7.981752905, 8.045213429, 8.108003412, 8.170588748, 8.232430468, 8.297021984, 8.359506065, 8.421736347, 8.484464073, 8.547927283, 8.611065047, 8.675095554, 8.738886031, 8.801602707, 8.865358206, 8.929622916, 8.994218326, 9.059126885, 9.123386265, 9.188268908, 9.253014946, 9.318797396, 9.382738531, 9.448285827, 9.513255395, 9.578791771, 9.644017333, 9.709347562, 9.77525105, 9.841709815, 9.907989365, 9.973245417, 10.038507623, 10.105614193, 10.172042382, 10.238949119, 10.302905127, 10.367532086, 10.43600332, 10.502185766, 10.56872062, 10.635909227, 10.70235079, 10.768636725, 10.836581067, 10.903746581, 10.970209039, 11.037421775, 11.104492363, 11.172054393, 11.241668452, 11.310623275, 11.378398264, 11.447298295, 11.51502099, 11.583459333, 11.65151267, 11.721558044, 11.788357028, 11.858195058, 11.924759195, 11.991748578, 12.060952797, 12.128016782, 12.194058001, 12.262664411, 12.331017188, 12.397395914, 12.465093856, 12.531072755, 12.600539333, 12.670092596, 12.736760097, 12.806629644, 12.875612877, 12.945231048, 13.01354459, 13.083829804, 13.150895046, 13.220510865, 13.288610695, 13.356329568, 13.423226214, 13.490285124, 13.557006975, 13.625140748, 13.694474333, 13.761689643, 13.828259605, 13.898311101, 13.96730172, 14.036310145, 14.104531385, 14.17328702, 14.24107332, 14.308522482, 14.379287396, 14.448930503, 14.517920324, 14.589418245, 14.656637284, 14.726516174, 14.794494003, 14.867794386, 14.937949316, 15.003259227, 15.070367795, 15.140610681, 15.210197895, 15.280703395, 15.352264383, 15.42048158, 15.48557498, 15.553982272, 15.624040115, 15.692995695, 15.761569883, 15.828928457, 15.895412908, 15.963421284, 16.030127014, 16.09794871, 16.166761478, 16.23574672, 16.302489728, 16.371388848, 16.43920874, 16.506885795, 16.571802757, 16.641142252, 16.710976928, 16.773499442, 16.844490026, 16.912585993, 16.981824909, 17.047460797, 17.112821282, 17.183118188, 17.252431046, 17.321239867, 17.38882739, 17.454342306, 17.525471777, 17.594155485, 17.660962706, 17.727756707, 17.791791923, 17.859368109, 17.924085092, 17.993737077, 18.059661551, 18.132479624, 18.201876384, 18.267116918, 18.333460235, 18.399926778, 18.465507401, 18.530466193, 18.597133064, 18.664659499, 18.73179639, 18.799320295, 18.868071384, 18.932517619, 18.998371711, 19.065325207, 19.135129722, 19.206402988, 19.273691046, 19.338139461, 19.406885167, 19.473083959, 19.537232301, 19.600145071, 19.66527158, 19.730233936, 19.79649186, 19.86045111, 19.926468894, 19.991627385, 20.055538038, 20.122037249, 20.185238368, 20.254847929, 20.31891861, 20.383928954, 20.44605776, 20.509409947, 20.572326647, 20.636874581, 20.701076558, 20.76658926, 20.825436459, 20.885143814, 20.949206335, 20.962417927, 21.014726219, 21.083604803, 21.147895218, 21.209535019, 21.267175645, 21.327704991, 21.385146147, 21.449076884, 21.50912981, 21.569890435, 21.633202692, 21.695265393, 21.755257195, 21.81610816, 21.878624764, 21.936959835, 22.000728697, 22.063649412, 22.125047488, 22.18977412, 22.24906804, 22.31225956, 22.367835787, 22.431846367, 22.489339194, 22.553204195, 22.618200938, 22.676226876, 22.734591116, 22.789937721, 22.847062773, 22.902150618, 22.965413707, 23.025198118, 23.084596008, 23.144268223, 23.20253327, 23.257846604, 23.319188133, 23.381403038, 23.438407848, 23.496097368, 23.559236142, 23.620251799, 23.682980362, 23.744993458, 23.804088598, 23.866095512, 23.922195545, 23.974418771, 24.032865524, 24.092052, 24.151864718, 24.208914274, 24.267641369, 24.327264961, 24.385181251, 24.442156575, 24.500127886, 24.557686834, 24.617290747, 24.671487695, 24.720860807, 24.775017544, 24.8324025, 24.886709398, 24.948032991, 25.009915907, 25.067002347, 25.118275757, 25.180902675, 25.239077029, 25.291556739, 25.349628348, 25.411259274, 25.469475073, 25.520758624, 25.574220653, 25.630552011, 25.689092621, 25.740724463, 25.795843692, 25.851973018, 25.905060695, 25.958654424, 26.008683845, 26.060838256, 26.114622002, 26.170929575, 26.226689164, 26.289224591, 26.34624303, 26.410656822, 26.465429206, 26.507433885, 26.559557384, 26.613107253, 26.669341682, 26.720453179, 26.77141133, 26.820491444, 26.870662671, 26.921196347, 26.97265077, 27.025075312, 27.076331415, 27.121942032, 27.171932724, 27.224284236, 27.275128795, 27.327362184, 27.378765522, 27.433210341, 27.486106715, 27.543201087, 27.590367409, 27.634553204, 27.684303908, 27.736025971, 27.788413301, 27.839616051, 27.890957015, 27.932478563, 27.987948787, 28.042338752, 28.087505677, 28.129032734, 28.177206892, 28.226775461, 28.274067764, 28.314901184, 28.363808336, 28.412769043, 28.4545, 28.504096197, 28.555906619, 28.596464665, 28.639751441, 28.693877851, 28.743565978, 28.785181062, 28.831409017, 28.873414696, 28.91752309, 28.963197293, 29.002324815, 29.04401841, 29.084036446, 29.129048255, 29.181361993, 29.228023606, 29.278092756, 29.328469966, 29.372420692, 29.412157326, 29.457102565, 29.499377902, 29.541727767, 29.578436879, 29.626563114, 29.678999513, 29.72022254, 29.760800146, 29.807763449, 29.85405887, 29.898907902, 29.948357346, 29.991517819, 30.032594708, 30.07463922, 30.124267378, 30.169081817, 30.209401093, 30.263639074, 30.308129909, 30.349351446, 30.403123431, 30.44888233, 30.495653538, 30.533500176, 30.566351881, 30.603677184, 30.651663398, 30.687620049, 30.732858335, 30.773318824, 30.811477931, 30.855031664, 30.903544112, 30.941117103, 30.975834588, 31.025712688, 31.067618283, 31.105898375, 31.145599777, 31.191265386, 31.227959395, 31.269915935, 31.310954887, 31.346646846, 31.352889927, 31.384324365, 31.428011124, 31.462954165, 31.504016524, 31.544844485, 31.58228507, 31.616305622, 31.64511888, 31.686394358, 31.726061907, 31.762005653, 31.806589278, 31.84998479, 31.887536925, 31.920902854, 31.955484534, 31.991722316, 32.030320873, 32.0745303, 32.106707037, 32.14247583, 32.191623521, 32.230764362, 32.265823792, 32.305011645, 32.338277477, 32.383669424, 32.430272816, 32.464246531, 32.508333962, 32.540497326, 32.585564407, 32.6183372, 32.648289415, 32.682194896, 32.72600897, 32.761464835, 32.79707999, 32.82678069, 32.867237252, 32.894701497, 32.935087907, 32.972836279, 33.00989734, 33.040617123, 33.075018113, 33.1130372, 33.153237725, 33.191355711, 33.234950756, 33.272237264, 33.299359961, 33.332173059, 33.368440899, 33.403786236, 33.43071725, 33.465359922, 33.504884616, 33.536527922, 33.572121561, 33.604600746, 33.644338797, 33.677148676, 33.723968369, 33.756777797, 33.786668005, 33.819663178, 33.845586285, 33.879792585, 33.917578751, 33.944733922, 33.977593552, 34.002491484, 34.032089128, 34.069687894, 34.100362078, 34.140252698, 34.169052531, 34.205086532, 34.242681427, 34.269904339, 34.286632252, 34.310873656, 34.336359937, 34.379330206, 34.417838005, 34.457667528, 34.48409544, 34.511662962, 34.556383326, 34.574373909, 34.59384773, 34.622776, 34.652918626, 34.671570908, 34.708763946, 34.742606917, 34.769327799, 34.796802843, 34.826760045, 34.857112897, 34.895166557, 34.932199949, 34.964148201, 34.993475794, 35.021601387, 35.060246574, 35.087442295, 35.116270704, 35.152080084, 35.18088866, 35.20392769, 35.239068458, 35.271617551, 35.303735924, 35.332733065, 35.365539575, 35.393998892, 35.413928106, 35.443482437, 35.47522191, 35.510203403, 35.555475209, 35.587438915, 35.616194642, 35.658813147, 35.685381991, 35.712500303, 35.732735208, 35.758990832, 35.794229028, 35.810323208, 35.840381538, 35.867725386, 35.897505779, 35.933119976, 35.955180105, 35.999102802, 36.037615012, 36.063284567, 36.092122847, 36.122018451, 36.133950333, 36.157990686, 36.191808184, 36.216811063, 36.244362433, 36.277293322, 36.292689995, 36.321439371, 36.351071211, 36.387053331, 36.420344893, 36.449569316, 36.475470372, 36.514657208, 36.549298926, 36.571840132, 36.596118682, 36.644681511, 36.672752095, 36.689927475, 36.703018157, 36.717730805, 36.731528636, 36.745371885, 36.767665426, 36.792505734, 36.812777102, 36.839060205, 36.866293985, 36.879110689, 36.919389097, 36.946112477, 36.975157608, 37.002638522, 37.048216862, 37.080182372, 37.12279247, 37.153786128, 37.164048184, 37.187479627, 37.203939046, 37.218494913, 37.237432421, 37.252627558, 37.271083611, 37.304928312, 37.320654104, 37.342707804, 37.367600859, 37.383665516, 37.41472861, 37.446731742, 37.458603008, 37.480648562, 37.494227721, 37.512388941, 37.525307312, 37.535783883, 37.572828989, 37.583118525, 37.593607992, 37.616633117, 37.642772183, 37.65226606, 37.66691065, 37.691888256, 37.700971356, 37.728365689, 37.76209639, 37.772605378, 37.791146591, 37.805691763, 37.818136785, 37.830278349, 37.843017707, 37.863756211, 37.878294213, 37.898404007, 37.912241994, 37.931888, 37.941723422, 37.951200749, 37.966186422, 37.982501157, 37.998681477, 38.01165574, 38.036296398, 38.068904148, 38.102479573, 38.116920667, 38.133608833, 38.154024262, 38.167964004, 38.192100592, 38.20938018, 38.217830319, 38.224011912, 38.234635981, 38.237552573, 38.25874712, 38.307815364, 38.331216763, 38.34196245, 38.354161121, 38.366450641, 38.37848219, 38.392107386, 38.404094261, 38.428170144, 38.453483275, 38.462261535, 38.481224212, 38.50442632, 38.515853613, 38.523028509, 38.539638532, 38.557009872, 38.587524189, 38.592305647, 38.610881872, 38.614367215, 38.6412593, 38.65745459, 38.68111097, 38.68795225, 38.691723163, 38.710037827, 38.719339733, 38.734874149, 38.742343104, 38.755714403, 38.778926544, 38.79971555, 38.808756531, 38.818340744, 38.827939833, 38.833521371, 38.840039093, 38.866540678, 38.880866062, 38.89557291, 38.901913442, 38.932555063, 38.94987501, 38.956322946, 39.002291834, 39.017333788, 39.028902337, 39.047773407, 39.057115663, 39.074730601, 39.082181529, 39.123272644, 39.132706021, 39.151654415, 39.16797747, 39.17753063, 39.186276642, 39.194824504, 39.228426236, 39.253941796, 39.259275338, 39.259417918, 39.279249545, 39.292181105, 39.297594537, 39.313091314, 39.320881108, 39.326795865, 39.338921447, 39.363385661, 39.365346295, 39.39426879, 39.398860142, 39.408102377, 39.421508791, 39.441496828, 39.458994494, 39.477998562, 39.485653631, 39.497097285, 39.509535633, 39.512546714, 39.530129569, 39.584164293, 39.586750201, 39.595527935, 39.634997157, 39.642019657, 39.644831225, 39.674707589, 39.689556372, 39.690841669, 39.701910067, 39.704323197, 39.739142813, 39.791900368, 39.806888728), "10" = c(2.4225e-05, 2.5001e-05, 2.5028e-05, 2.5168e-05, 2.5448e-05, 2.5592e-05, 2.5627e-05, 2.6466e-05, 2.6858e-05, 2.713e-05, 2.7503e-05, 2.791e-05, 2.7932e-05, 2.8384e-05, 2.8694e-05, 3.0007e-05, 3.0263e-05, 3.057e-05, 3.0724e-05, 3.1177e-05, 3.1587e-05, 3.1657e-05, 3.2154e-05, 3.2912e-05, 3.2968e-05, 3.3135e-05, 3.3257e-05, 3.3287e-05, 3.3494e-05, 3.3742e-05, 3.4116e-05, 3.5154e-05, 3.5939e-05, 3.6206e-05, 3.7256e-05, 3.7527e-05, 3.7763e-05, 3.781e-05, 3.8096e-05, 3.8664e-05, 3.8922e-05, 3.9349e-05, 3.9633e-05, 3.9985e-05, 4.0043e-05, 4.0148e-05, 4.0584e-05, 4.1557e-05, 4.1666e-05, 4.2075e-05, 4.2743e-05, 4.329e-05, 4.3696e-05, 4.3975e-05, 4.4737e-05, 4.5208e-05, 4.6093e-05, 4.6409e-05, 4.6688e-05, 4.7879e-05, 4.883e-05, 4.8879e-05, 4.9253e-05, 4.9833e-05, 5.1118e-05, 5.1219e-05, 5.1646e-05, 5.1814e-05, 5.2684e-05, 5.2701e-05, 5.3173e-05, 5.3436e-05, 5.3747e-05, 5.4653e-05, 5.6917e-05, 5.7128e-05, 5.8211e-05, 6.03e-05, 6.0963e-05, 6.1596e-05, 6.228e-05, 6.2504e-05, 6.3548e-05, 6.434e-05, 6.5712e-05, 6.6272e-05, 6.7376e-05, 6.813e-05, 6.8498e-05, 6.9095e-05, 6.9365e-05, 6.9811e-05, 7.0443e-05, 7.1881e-05, 7.2499e-05, 7.4594e-05, 7.5771e-05, 7.6547e-05, 7.6809e-05, 7.7907e-05, 7.8027e-05, 7.8581e-05, 7.9825e-05, 8.026e-05, 8.0927e-05, 8.1532e-05, 8.3105e-05, 8.4205e-05, 8.5499e-05, 8.7041e-05, 8.85e-05, 8.9813e-05, 9.1247e-05, 9.2216e-05, 9.3093e-05, 9.3974e-05, 9.5219e-05, 9.6165e-05, 9.7563e-05, 9.9645e-05, 0.000100551, 0.000101753, 0.000102921, 0.000104656, 0.000105939, 0.00010837, 0.000110445, 0.000111965, 0.000113912, 0.000115373, 0.000117454, 0.00011861, 0.000119411, 0.00012151, 0.000123028, 0.000123645, 0.000125413, 0.00012645, 0.000128183, 0.000129511, 0.00013143, 0.000132959, 0.000134459, 0.000136049, 0.000137792, 0.000139172, 0.000139788, 0.000141666, 0.000146505, 0.000148158, 0.000149205, 0.000150666, 0.000152529, 0.000154093, 0.000156246, 0.000157431, 0.000160167, 0.00016141, 0.000163207, 0.000164867, 0.000167001, 0.000167755, 0.000169191, 0.000172171, 0.00017379, 0.000175926, 0.000178467, 0.000180997, 0.000182945, 0.000185385, 0.000187643, 0.000189891, 0.000191571, 0.00019314, 0.000194793, 0.000197328, 0.000200341, 0.000201933, 0.000205221, 0.000206551, 0.00020783, 0.000210918, 0.000213375, 0.00021479, 0.000218125, 0.000220707, 0.00022311, 0.000225637, 0.000228361, 0.000231289, 0.000233744, 0.000236812, 0.000238756, 0.000240193, 0.000242877, 0.000246115, 0.000250456, 0.000253099, 0.000255775, 0.000261203, 0.000263945, 0.000267291, 0.000269194, 0.000270673, 0.000275675, 0.000278654, 0.000282103, 0.000284338, 0.000287037, 0.000289324, 0.000291168, 0.000293758, 0.000296576, 0.000300255, 0.000302861, 0.000306341, 0.000309799, 0.000314755, 0.00031778, 0.000321978, 0.000324472, 0.000328014, 0.000331378, 0.000335875, 0.000340354, 0.00034511, 0.000348074, 0.00035293, 0.00035831, 0.000363352, 0.000367647, 0.000370564, 0.000375274, 0.00037745, 0.00038115, 0.000385837, 0.000390884, 0.000395712, 0.000401569, 0.000407084, 0.000411823, 0.000417536, 0.000423198, 0.000427264, 0.000430404, 0.00043562, 0.000440752, 0.000445552, 0.000450792, 0.000456385, 0.000461838, 0.000467224, 0.000472282, 0.00047698, 0.000483492, 0.000488339, 0.000494931, 0.000502316, 0.00050852, 0.000516247, 0.000523579, 0.000527881, 0.000532479, 0.000539272, 0.000545489, 0.000550228, 0.000555487, 0.00056118, 0.000564777, 0.000571611, 0.000576607, 0.000583164, 0.000589741, 0.000598126, 0.000605435, 0.00061425, 0.000619276, 0.000626028, 0.000632102, 0.000640251, 0.000646643, 0.000654033, 0.000660557, 0.000667417, 0.000677758, 0.000685735, 0.000691887, 0.000699168, 0.000706745, 0.000714015, 0.000723926, 0.000729667, 0.000738865, 0.000746752, 0.000755425, 0.00076178, 0.000772133, 0.000779358, 0.00078779, 0.000795878, 0.000804403, 0.000812571, 0.000820073, 0.000829976, 0.000840124, 0.00085037, 0.000860979, 0.000869934, 0.000879113, 0.000891395, 0.000902612, 0.000912396, 0.000924129, 0.000932283, 0.000942624, 0.000951714, 0.000963946, 0.000972047, 0.000983117, 0.000993911, 0.00100722, 0.001016032, 0.001025059, 0.001037614, 0.00104898, 0.001061672, 0.001073096, 0.001084438, 0.001095447, 0.00110601, 0.001121114, 0.001132071, 0.001148787, 0.001158801, 0.001170939, 0.001185031, 0.00119737, 0.00121165, 0.00122594, 0.001243202, 0.001255405, 0.001258353, 0.001270821, 0.001286463, 0.001297719, 0.001315369, 0.001329078, 0.001341271, 0.001355607, 0.001371064, 0.001389898, 0.001401572, 0.00141618, 0.00143417, 0.001447981, 0.00146886, 0.00148523, 0.001502641, 0.001513301, 0.001531849, 0.001550612, 0.001569798, 0.001586407, 0.001607299, 0.001626509, 0.001646151, 0.001672829, 0.001693661, 0.001711699, 0.00173128, 0.001747788, 0.001765872, 0.001786737, 0.001802837, 0.001825232, 0.001842997, 0.001861864, 0.001884546, 0.001904873, 0.001926697, 0.001950839, 0.00197212, 0.001997991, 0.002019689, 0.002041605, 0.002063452, 0.002088863, 0.00211438, 0.00213958, 0.002162528, 0.00218851, 0.00221211, 0.002236291, 0.002268575, 0.002296608, 0.002322994, 0.002347513, 0.002374302, 0.002399944, 0.002430773, 0.002461524, 0.002490656, 0.002520554, 0.002548478, 0.00257372, 0.002598957, 0.002627531, 0.002656409, 0.002688046, 0.002715356, 0.002741661, 0.002773379, 0.002807606, 0.00283777, 0.002871217, 0.002903921, 0.00293988, 0.002967046, 0.00299868, 0.003033499, 0.003067124, 0.003108249, 0.003140737, 0.00317534, 0.003211613, 0.00325228, 0.003291963, 0.003327411, 0.003366988, 0.00340476, 0.003442823, 0.003489329, 0.003535798, 0.003573566, 0.003611861, 0.003656422, 0.003701289, 0.003739984, 0.003786672, 0.003827065, 0.00386885, 0.00391425, 0.003963245, 0.00401057, 0.004060403, 0.004106682, 0.004154989, 0.004194183, 0.00424595, 0.004291038, 0.004344861, 0.004394767, 0.004442752, 0.00449446, 0.004547394, 0.004600669, 0.004654978, 0.004706169, 0.004763747, 0.004818222, 0.004877675, 0.004932547, 0.00498662, 0.005045479, 0.005097891, 0.005151508, 0.005207862, 0.005266877, 0.005326688, 0.005384631, 0.005450511, 0.005507664, 0.005566323, 0.005631864, 0.005697411, 0.005765158, 0.005829613, 0.005899966, 0.005964903, 0.006031942, 0.006104284, 0.006174204, 0.00624336, 0.006314383, 0.006390861, 0.00646342, 0.006538994, 0.006615526, 0.006687375, 0.006770475, 0.006843772, 0.006919184, 0.006994462, 0.007070465, 0.007150353, 0.007226725, 0.00731064, 0.007391891, 0.007473752, 0.007556024, 0.00764626, 0.007734012, 0.007825967, 0.007919076, 0.00802116, 0.008111853, 0.008209204, 0.008303233, 0.008386756, 0.008483248, 0.008583645, 0.008683822, 0.008780641, 0.008883886, 0.008985742, 0.009092455, 0.009202802, 0.009310849, 0.009413854, 0.009527583, 0.009639835, 0.009747664, 0.009863143, 0.009975387, 0.01009423, 0.010204864, 0.010314531, 0.010430487, 0.010551237, 0.010673856, 0.010801442, 0.010921029, 0.011050686, 0.011181306, 0.01131156, 0.011439291, 0.011566681, 0.011705759, 0.011840097, 0.011977962, 0.012111255, 0.012211676, 0.012240932, 0.012365781, 0.012509429, 0.012642603, 0.012796205, 0.01294554, 0.013103294, 0.013264738, 0.013418084, 0.013579123, 0.013731395, 0.013893012, 0.01406172, 0.014211308, 0.014362421, 0.014510325, 0.014674199, 0.014851031, 0.015007389, 0.015176658, 0.015339182, 0.015510773, 0.015684383, 0.015864992, 0.016047122, 0.016227529, 0.016409899, 0.01659475, 0.016792587, 0.016981102, 0.017175539, 0.017371671, 0.017589851, 0.017803843, 0.018000676, 0.01819554, 0.018401578, 0.018612415, 0.01883125, 0.019043891, 0.019268324, 0.019503517, 0.019734829, 0.019961821, 0.020203782, 0.020433521, 0.020681929, 0.020922725, 0.021165153, 0.021407154, 0.021656389, 0.021905725, 0.022148888, 0.022405178, 0.022652755, 0.022908908, 0.023165239, 0.023433598, 0.023713281, 0.02397992, 0.024246172, 0.024532125, 0.024828038, 0.025108874, 0.025398733, 0.025683416, 0.025985819, 0.02626826, 0.026575902, 0.026875354, 0.027172917, 0.027474139, 0.027777756, 0.028087127, 0.028412294, 0.028729832, 0.029059364, 0.029401145, 0.029751104, 0.030084594, 0.030428127, 0.030769593, 0.031127862, 0.031469682, 0.0318204, 0.03217575, 0.032555648, 0.0329261, 0.033284671, 0.033656153, 0.034030418, 0.034431946, 0.034826781, 0.035225375, 0.03562973, 0.036052803, 0.036455516, 0.036864118, 0.037299802, 0.037708244, 0.038127955, 0.03854331, 0.038993573, 0.039438694, 0.039890855, 0.04036718, 0.040841554, 0.041320985, 0.041792569, 0.042277243, 0.042747995, 0.043240666, 0.04372332, 0.044226294, 0.044738225, 0.045245368, 0.045751954, 0.046264771, 0.046802853, 0.047330321, 0.047897432, 0.048472645, 0.049004561, 0.049559829, 0.050119604, 0.050688731, 0.051275263, 0.05186103, 0.052469743, 0.053056195, 0.05367326, 0.054296909, 0.054903195, 0.055519053, 0.056138938, 0.056785834, 0.057441479, 0.058102759, 0.058767484, 0.059428062, 0.060104002, 0.060784574, 0.061483474, 0.062178368, 0.062867735, 0.063606118, 0.064320759, 0.065059898, 0.065783975, 0.066526607, 0.067281231, 0.068043841, 0.068835335, 0.06961338, 0.070443216, 0.071238919, 0.072021939, 0.072847498, 0.073674398, 0.07449862, 0.075337892, 0.076195744, 0.077041267, 0.077929923, 0.078799218, 0.079692372, 0.080599076, 0.081524143, 0.082424014, 0.083358824, 0.084286916, 0.085250258, 0.086211018, 0.087183763, 0.088195821, 0.089201002, 0.090220677, 0.091239645, 0.092276235, 0.093285009, 0.094322618, 0.095407386, 0.096510119, 0.097585801, 0.098674986, 0.09979195, 0.100909263, 0.102064621, 0.103202874, 0.104376911, 0.105544313, 0.106711377, 0.107912459, 0.109102112, 0.11033684, 0.111582164, 0.112809591, 0.114108812, 0.115382327, 0.116627213, 0.117661543, 0.117941316, 0.119258751, 0.120593614, 0.121943931, 0.123280664, 0.12463858, 0.126025071, 0.12742727, 0.128841154, 0.130289047, 0.131754693, 0.133238281, 0.134710507, 0.136247629, 0.137743134, 0.139286699, 0.140821824, 0.142389314, 0.143980915, 0.145598921, 0.147191358, 0.148845291, 0.150505023, 0.152151739, 0.153819486, 0.15553998, 0.157271245, 0.158994918, 0.160738099, 0.162509672, 0.164356976, 0.166200634, 0.168027245, 0.169922355, 0.171794779, 0.173692627, 0.175612145, 0.177569154, 0.179512621, 0.181488549, 0.183495105, 0.185527007, 0.187543467, 0.189611425, 0.191691371, 0.193834519, 0.195992813, 0.198129879, 0.200301744, 0.202534656, 0.204746773, 0.207016903, 0.20932865, 0.211615588, 0.213945678, 0.216297269, 0.218672856, 0.221067501, 0.223462934, 0.225917706, 0.228395745, 0.230869142, 0.23343882, 0.236003036, 0.238597798, 0.241215807, 0.243876504, 0.246492833, 0.24920965, 0.251917199, 0.254627452, 0.257406511, 0.260227522, 0.263075256, 0.265938266, 0.268878288, 0.271780925, 0.274765767, 0.277713294, 0.2807101, 0.283740404, 0.286846509, 0.289945262, 0.293094907, 0.296274194, 0.299512585, 0.302770719, 0.306025966, 0.309321141, 0.312710867, 0.316102311, 0.319497247, 0.322942551, 0.326454484, 0.330055414, 0.333625284, 0.33441212, 0.337291852, 0.340963874, 0.344613546, 0.348359439, 0.352118614, 0.355917169, 0.359798028, 0.363652416, 0.367598431, 0.371530428, 0.375544639, 0.379615498, 0.383731286, 0.387914581, 0.39212411, 0.396389047, 0.400692473, 0.405011417, 0.409387284, 0.413818027, 0.418334421, 0.422848463, 0.427402861, 0.432005008, 0.436673604, 0.437614073, 0.441379857, 0.446179507, 0.451018204, 0.455892085, 0.460799699, 0.465786174, 0.470806677, 0.47596626, 0.48111333, 0.486329052, 0.491591803, 0.496882341, 0.5022939, 0.507737092, 0.513256105, 0.51881399, 0.524445256, 0.530151221, 0.535989549, 0.541810364, 0.547730745, 0.55362518, 0.559607153, 0.565703949, 0.571898344, 0.578107016, 0.584383065, 0.590722802, 0.597208127, 0.603694907, 0.610310738, 0.617009347, 0.623830077, 0.630641047, 0.637629264, 0.640601183, 0.644618556, 0.651688965, 0.658845271, 0.666173557, 0.673572342, 0.681025569, 0.688607362, 0.696211957, 0.703928007, 0.711784083, 0.719714277, 0.727739015, 0.73588594, 0.744122154, 0.752417292, 0.760874124, 0.769399108, 0.778178356, 0.786996826, 0.795991102, 0.80504834, 0.814172897, 0.823426799, 0.832830868, 0.842377757, 0.846363531, 0.85215248, 0.86198027, 0.871876115, 0.882002275, 0.892334688, 0.902815419, 0.913514317, 0.924325045, 0.935251615, 0.94631074, 0.95765088, 0.969150702, 0.980839232, 0.992651603, 1.004721483, 1.017029927, 1.029595927, 1.042383609, 1.055364582, 1.065822831, 1.089588749, 1.102887554, 1.115986841, 1.129013687, 1.142088081, 1.155122014, 1.168054628, 1.181013934, 1.193877236, 1.206866758, 1.219719384, 1.232613427, 1.245473904, 1.258265334, 1.271020749, 1.283808707, 1.296448498, 1.309156196, 1.316561623, 1.32184399, 1.334520662, 1.347277053, 1.359978324, 1.372564267, 1.385278944, 1.397938229, 1.410680688, 1.423389322, 1.435983966, 1.448805886, 1.461529731, 1.474352483, 1.487222226, 1.49996462, 1.512727784, 1.525730902, 1.538592609, 1.551536368, 1.56452481, 1.577426507, 1.590558497, 1.603630681, 1.616648313, 1.630059443, 1.63762561, 1.643219284, 1.656585498, 1.669975882, 1.683516733, 1.697056188, 1.710677915, 1.72442837, 1.738094876, 1.751870337, 1.765810092, 1.779771781, 1.794100116, 1.808594942, 1.822962682, 1.837538442, 1.852253172, 1.867078269, 1.882192989, 1.8972627, 1.912673916, 1.928163454, 1.943743882, 1.959581958, 1.97559315, 1.991824462, 2.008213669, 2.024915481, 2.042074733, 2.059229514, 2.076704614, 2.094395294, 2.112314412, 2.130608955, 2.149022346, 2.167853861, 2.183035475, 2.187058742, 2.20694757, 2.226933355, 2.247341366, 2.268099014, 2.289155829, 2.310692129, 2.33283739, 2.35532754, 2.378378329, 2.402117893, 2.42590095, 2.450302445, 2.474988016, 2.500529939, 2.526537017, 2.55311487, 2.580165332, 2.607978334, 2.636139097, 2.665115585, 2.694506568, 2.724417178, 2.754895226, 2.785916947, 2.811025773, 2.81794638, 2.850065236, 2.882475117, 2.915930248, 2.950171571, 2.98427354, 3.01874264, 3.053849141, 3.089619855, 3.126150857, 3.162287838, 3.19857915, 3.23567223, 3.273021333, 3.310720697, 3.348990311, 3.387073692, 3.425804784, 3.465283425, 3.504396867, 3.54411344, 3.584366072, 3.625220431, 3.66632396, 3.707150494, 3.749009833, 3.790599445, 3.832533905, 3.874461323, 3.916141677, 3.958686522, 4.002039039, 4.045415005, 4.089267101, 4.133307119, 4.176915717, 4.221469346, 4.266776978, 4.312767451, 4.358835903, 4.404149778, 4.451132412, 4.497563508, 4.544109084, 4.590352067, 4.637949165, 4.686424056, 4.734352493, 4.783296213, 4.832393764, 4.88083519, 4.929887698, 4.979114905, 5.02769901, 5.079203274, 5.129565274, 5.179824512, 5.230974345, 5.282660006, 5.335120354, 5.38797424, 5.439726374, 5.492744368, 5.545662683, 5.598356701, 5.652399163, 5.705643885, 5.759993548, 5.814601616, 5.869126237, 5.924807709, 5.981040947, 6.037170741, 6.0925258, 6.148510761, 6.205538697, 6.262134187, 6.319122418, 6.377794959, 6.434954897, 6.491948609, 6.55065277, 6.609803727, 6.669719311, 6.730233674, 6.790059987, 6.850920024, 6.91159371, 6.97252503, 7.03269138, 7.093380511, 7.155343324, 7.218723021, 7.279546791, 7.340690408, 7.402439405, 7.416140464, 7.466322026, 7.528769847, 7.593571651, 7.658158366, 7.722466665, 7.788005272, 7.852762642, 7.919092889, 7.982961848, 8.048833383, 8.116539781, 8.183029681, 8.248632132, 8.314296064, 8.382035997, 8.449978963, 8.519449784, 8.58766761, 8.65568746, 8.724060282, 8.792044427, 8.859634513, 8.927911423, 8.996863783, 9.066125008, 9.135577064, 9.205572621, 9.274980703, 9.343339664, 9.413705917, 9.482928965, 9.552422342, 9.623659339, 9.695814087, 9.768783059, 9.841234752, 9.914416605, 9.98603228, 10.058713536, 10.132304508, 10.207202424, 10.279852175, 10.35339341, 10.425831216, 10.499989981, 10.574172038, 10.649454969, 10.725496837, 10.800189152, 10.876976604, 10.954301966, 11.02927477, 11.106128166, 11.182912384, 11.257644432, 11.335120748, 11.413649293, 11.490729804, 11.567351513, 11.6452045, 11.723702495, 11.801481253, 11.880060744, 11.962064231, 12.043005338, 12.121033514, 12.200140107, 12.279820416, 12.356806427, 12.433675544, 12.51372372, 12.594044637, 12.674762824, 12.753141544, 12.831627844, 12.913671056, 12.996475156, 13.078140277, 13.160497221, 13.242276658, 13.325624906, 13.407825816, 13.487160289, 13.568621774, 13.65004158, 13.730160433, 13.812298419, 13.895810898, 13.977013606, 14.060177248, 14.143415488, 14.229095, 14.313360071, 14.394766308, 14.477348132, 14.563107851, 14.645385083, 14.72770328, 14.81250938, 14.89479052, 14.981834834, 15.065301683, 15.150269881, 15.234286843, 15.316810409, 15.39912423, 15.484360159, 15.570739393, 15.65555925, 15.744572468, 15.832204763, 15.91483977, 16.006199891, 16.093526097, 16.177641972, 16.265066797, 16.3550137, 16.442000775, 16.528872659, 16.617325738, 16.705218095, 16.789364649, 16.877776953, 16.965008888, 17.047281211, 17.134189714, 17.227722461, 17.314699292, 17.398636082, 17.482850467, 17.571783862, 17.662838904, 17.747654044, 17.836963457, 17.923092004, 18.013895744, 18.106396985, 18.190017405, 18.279145087, 18.373596427, 18.465420023, 18.552518839, 18.644502974, 18.734212739, 18.826806068, 18.916325367, 19.008805871, 19.091387793, 19.181713594, 19.272957001, 19.363485941, 19.453801499, 19.538872831, 19.63301025, 19.732070148, 19.824719245, 19.910131738, 20.000346004, 20.090735134, 20.17931822, 20.271099604, 20.359345003, 20.449545386, 20.537318639, 20.630440942, 20.72471213, 20.8136158, 20.905402486, 21.006535023, 21.099003867, 21.190641204, 21.277209857, 21.365261401, 21.459067117, 21.54865688, 21.64268309, 21.735833261, 21.827008999, 21.921778544, 22.01167303, 22.096777103, 22.182372289, 22.273804355, 22.364793273, 22.456331699, 22.544747174, 22.63886179, 22.724791592, 22.81491718, 22.899415271, 22.99496967, 23.091840971, 23.18273801, 23.273321936, 23.361577772, 23.451518322, 23.543485669, 23.631391289, 23.721284846, 23.813494388, 23.830958786, 23.904237714, 23.99740631, 24.087594336, 24.172943911, 24.274161415, 24.362139995, 24.453532753, 24.540695793, 24.632500279, 24.723593001, 24.817718992, 24.907582427, 24.996702273, 25.085523164, 25.170573307, 25.261339745, 25.353369823, 25.448395648, 25.543219674, 25.63779333, 25.727406626, 25.819785142, 25.911685111, 25.999908648, 26.090735734, 26.185427567, 26.283638713, 26.376351374, 26.468050184, 26.560393839, 26.653506704, 26.744986408, 26.84148007, 26.935424712, 27.031613859, 27.12990126, 27.213413474, 27.297949511, 27.391606073, 27.481023046, 27.577244196, 27.660078273, 27.752969371, 27.847640785, 27.935775729, 28.03001622, 28.112326411, 28.202678142, 28.305711886, 28.41408588, 28.507798726, 28.601222202, 28.691577655, 28.778426427, 28.865139442, 28.952047073, 29.04189022, 29.13290208, 29.222468629, 29.310252568, 29.403966566, 29.496545685, 29.588955658, 29.670282655, 29.765237946, 29.853860713, 29.939157623, 30.031831597, 30.132635284, 30.223626553, 30.314716077, 30.404698773, 30.49653321, 30.598354005, 30.706591079, 30.794758086, 30.88567056, 30.983904059, 31.079917086, 31.170311984, 31.254085628, 31.349366271, 31.434231574, 31.522216021, 31.62488187, 31.714113276, 31.807101124, 31.898765083, 31.989075454, 32.077621503, 32.163954464, 32.246301303, 32.342922885, 32.42317931, 32.514293109, 32.599385166, 32.696940056, 32.797336076, 32.881616052, 32.963128604, 33.055534389, 33.144613213, 33.240354973, 33.333530041, 33.419772089, 33.511015226, 33.596997478, 33.690154576, 33.770456693, 33.854346738, 33.93568232, 34.026461214, 34.133964357, 34.224368934, 34.31696213, 34.395991053, 34.488531354, 34.573282935, 34.657860394, 34.748500015, 34.83593968, 34.921200877, 35.016495421, 35.103500147, 35.189098757, 35.278248657, 35.380007822, 35.453440189, 35.536598475, 35.628900353, 35.70795709, 35.805519717, 35.884035947, 35.974236628, 36.073947199, 36.166191944, 36.262461722, 36.348830108, 36.447486376, 36.537945741, 36.621765276, 36.72019365, 36.806406163, 36.884595414, 36.961244033, 37.034270501, 37.114565364, 37.209007141, 37.286227619, 37.371118267, 37.439248702, 37.523874232, 37.626546182, 37.714768819, 37.785740396, 37.872095337, 37.959705484, 38.031587597, 38.11013961, 38.193842456, 38.279066005, 38.356655473, 38.426962569, 38.497766592, 38.580200096, 38.665833922, 38.732337607, 38.823390354, 38.912840108, 39.005549346, 39.079872157, 39.167914141, 39.262178359, 39.344000365, 39.42523678, 39.49998407, 39.579711118, 39.658374457, 39.744554639, 39.824637137, 39.909778531, 39.976503627, 40.07086873, 40.146192319, 40.232737117, 40.33047521, 40.411234975, 40.511735513, 40.584150733, 40.678903543, 40.748665601, 40.821384285, 40.896221213, 40.979874976, 41.083133078, 41.172353606, 41.246389695, 41.313545639, 41.396839905, 41.479670109, 41.501513806, 41.585966498, 41.668554998, 41.752348114, 41.831414071, 41.912412532, 42.004031538, 42.084409904, 42.177761254, 42.253139879, 42.328232597, 42.406243606, 42.473229902, 42.548504366, 42.630339647, 42.692319198, 42.74748047, 42.804862445, 42.878076503, 42.963458529, 43.039196054, 43.10863784, 43.194069051, 43.277205491, 43.361188831, 43.436277396, 43.487676246, 43.544669136, 43.634713019, 43.728844753, 43.791675735, 43.859926068, 43.933711086, 44.005127785, 44.086927783, 44.157265008, 44.21662749, 44.292348231, 44.370159707, 44.45510652, 44.534029169, 44.626322887, 44.701067778, 44.803583406, 44.864293009, 44.95201579, 45.043863222, 45.123050925, 45.182140354, 45.25662336, 45.319886322, 45.391665942, 45.459489666, 45.545710844, 45.618135789, 45.66728339, 45.72744204, 45.799838467, 45.898369185, 45.994963194, 46.090238567, 46.146203488, 46.26281139, 46.346893944, 46.45014075, 46.529511793, 46.597497684, 46.658877955, 46.729144287, 46.800422843, 46.861403455, 46.92327215, 46.969716677, 47.023688664, 47.099679441, 47.184733527, 47.248407438, 47.32401346, 47.396937895, 47.452863472, 47.514186447, 47.576990958, 47.648578084, 47.705497443, 47.762521688, 47.831638098, 47.903169177, 47.951731454, 48.020834076, 48.095559152, 48.167585912, 48.220456741, 48.326118955, 48.418029654, 48.484154252, 48.555548343, 48.609736278, 48.677514557, 48.75564225, 48.835717134, 48.912387575, 48.960681064, 49.054169503, 49.128789242, 49.194258607, 49.253431104, 49.37758376, 49.448551612, 49.502782365, 49.539253929, 49.582457332, 49.66630225, 49.713330225, 49.757793563, 49.812926089, 49.886663198, 49.950486551, 50.026712999, 50.088839497, 50.127248006, 50.174739004, 50.240564471, 50.332476336, 50.400841704, 50.480282298, 50.532097998, 50.583808449, 50.662323506, 50.742654396, 50.780844233, 50.891342609, 50.957442039, 51.042725986, 51.093942464, 51.156948895, 51.195729006, 51.291043093, 51.381803663, 51.458790073, 51.531678716, 51.599976131, 51.65626566, 51.709147107, 51.76203002, 51.824975017, 51.878645675, 51.934547869, 52.001951575, 52.067250431, 52.1194897, 52.162675836, 52.235741806, 52.32566646, 52.389523072, 52.443109134, 52.49138602, 52.54272621, 52.595193784, 52.663805809, 52.788684196, 52.833450301, 52.875193543, 52.9159869, 52.975875823, 53.031362979, 53.068981885, 53.116212445, 53.14547418, 53.2727605, 53.338198482, 53.393187604, 53.417470109, 53.505323214, 53.546378814, 53.578433904, 53.615060914, 53.669437374, 53.780209647, 53.808896345, 53.854121481, 53.906261433, 53.961012623, 54.009645471, 54.049179711, 54.104410343, 54.169819551, 54.203007186, 54.288961166, 54.351679756, 54.396473216, 54.439717446, 54.469957439, 54.546661941, 54.642504156, 54.676294861, 54.762218371, 54.808256939, 54.882289295, 54.928723673, 55.048099579, 55.128384739, 55.17783498, 55.235278344, 55.304976843, 55.374097326, 55.467879464, 55.513557679, 55.543457793, 55.570730734, 55.686372953, 55.770528997, 55.87696501, 55.905337912, 55.947162423, 56.0312052, 56.176790596, 56.219229001, 56.245140746, 56.27486856, 56.330070588, 56.399630729, 56.450215642, 56.488855048, 56.546142414, 56.587661981, 56.648618888, 56.741137626, 56.802316218, 56.933502363, 56.990857005, 57.040105216, 57.097273315, 57.119688441, 57.235078939, 57.327216296, 57.406750052, 57.417746121, 57.474042919, 57.533842229, 57.599588486, 57.620970505, 57.6515351, 57.679454109, 57.740176231, 57.746021517, 57.753052499, 57.795981006, 57.822460492, 57.867960392, 57.879056695, 57.909533392, 58.01337581, 58.077555295, 58.117737276, 58.156706159, 58.205200391, 58.248586396, 58.268805623, 58.321966227, 58.405923894, 58.443694331, 58.520466117, 58.586773008, 58.59859899, 58.722980332, 58.768044116, 58.785127157, 58.807314622, 58.852421729, 58.886936484, 58.89957316, 58.91820026, 58.946018727, 59.008331298, 59.04888349, 59.148655135, 59.183619318, 59.18393932, 59.234868721, 59.286425847, 59.364700758, 59.537521765, 59.548197367, 59.598490284, 59.672819646, 59.727335913, 59.78205831, 59.818075066, 59.861644715, 59.901500831, 59.964907418, 59.97134798, 60.049307518, 60.102000229, 60.150915601, 60.191144727, 60.236815256, 60.244739861, 60.326130152, 60.368676594, 60.458258591, 60.461048872, 60.485896663, 60.519909409, 60.563425111, 60.595992007, 60.620363457, 60.67239429, 60.682697059, 60.770795465, 60.816598289, 60.84351731, 60.919060583, 60.931892622, 60.962964442, 60.965851849, 60.981282393, 61.008663477, 61.034751528, 61.062704721, 61.156373572, 61.198838093, 61.243416455, 61.262388603, 61.358863648, 61.379551606, 61.57937367, 61.579655353, 61.585538279, 61.587656687, 61.658794017, 61.667865819, 61.722849948, 61.829180575, 61.88010347, 61.881584817, 61.946075566, 61.982596065, 62.043244688, 62.120505964, 62.209069428), "20" = c(2.1738e-05, 2.2164e-05, 2.2221e-05, 2.2704e-05, 2.2864e-05, 2.3015e-05, 2.3582e-05, 2.3592e-05, 2.372e-05, 2.3884e-05, 2.3969e-05, 2.4259e-05, 2.4576e-05, 2.481e-05, 2.4906e-05, 2.5291e-05, 2.5399e-05, 2.5596e-05, 2.5674e-05, 2.574e-05, 2.6771e-05, 2.7183e-05, 2.7636e-05, 2.783e-05, 2.8432e-05, 2.8451e-05, 2.8745e-05, 2.8937e-05, 2.9495e-05, 2.9803e-05, 2.9873e-05, 3.0239e-05, 3.0634e-05, 3.1161e-05, 3.2279e-05, 3.2841e-05, 3.3132e-05, 3.408e-05, 3.4187e-05, 3.4496e-05, 3.4732e-05, 3.4892e-05, 3.513e-05, 3.6065e-05, 3.6173e-05, 3.6425e-05, 3.6823e-05, 3.7422e-05, 3.8441e-05, 3.8984e-05, 3.939e-05, 3.9863e-05, 4.0046e-05, 4.0391e-05, 4.0753e-05, 4.1457e-05, 4.1758e-05, 4.2048e-05, 4.2295e-05, 4.2706e-05, 4.3357e-05, 4.3567e-05, 4.4124e-05, 4.4534e-05, 4.4838e-05, 4.4991e-05, 4.5728e-05, 4.6237e-05, 4.7076e-05, 4.7239e-05, 4.7709e-05, 4.7879e-05, 4.8164e-05, 4.8893e-05, 4.9274e-05, 5.0724e-05, 5.1959e-05, 5.2958e-05, 5.3087e-05, 5.3999e-05, 5.4986e-05, 5.5417e-05, 5.592e-05, 5.6276e-05, 5.7091e-05, 5.7659e-05, 5.8588e-05, 5.8911e-05, 5.9347e-05, 6.0369e-05, 6.0784e-05, 6.1513e-05, 6.1974e-05, 6.3907e-05, 6.4217e-05, 6.53e-05, 6.6645e-05, 6.7606e-05, 6.7791e-05, 6.8862e-05, 6.9435e-05, 6.9947e-05, 7.1e-05, 7.1214e-05, 7.2755e-05, 7.3795e-05, 7.4935e-05, 7.6325e-05, 7.6983e-05, 7.8369e-05, 7.9595e-05, 8.008e-05, 8.0405e-05, 8.1462e-05, 8.4584e-05, 8.5489e-05, 8.811e-05, 8.8859e-05, 8.9357e-05, 9.077e-05, 9.2593e-05, 9.5605e-05, 9.6161e-05, 9.7325e-05, 9.7938e-05, 9.9273e-05, 0.000100154, 0.000100714, 0.000103258, 0.000104261, 0.000104848, 0.000105045, 0.000106708, 0.00010781, 0.000108898, 0.000109399, 0.000111046, 0.000112114, 0.000113095, 0.000114353, 0.000115575, 0.000116267, 0.000118189, 0.000118745, 0.000119753, 0.000120482, 0.000121507, 0.000122095, 0.00012346, 0.000125392, 0.000126507, 0.000129093, 0.000130551, 0.000132507, 0.000133447, 0.000134879, 0.000137351, 0.000139148, 0.00014054, 0.000142284, 0.0001439, 0.00014488, 0.000146531, 0.000147152, 0.000148488, 0.000149579, 0.000150744, 0.000152047, 0.000153371, 0.000154106, 0.00015606, 0.00015708, 0.000158669, 0.000160688, 0.000163011, 0.00016419, 0.000166789, 0.000168079, 0.000170232, 0.000172431, 0.000174337, 0.000175728, 0.000177814, 0.000179076, 0.000181937, 0.000184129, 0.000186687, 0.000189155, 0.000191258, 0.000192473, 0.000194548, 0.000196885, 0.000198096, 0.0002003, 0.000203664, 0.000206278, 0.00020807, 0.000209829, 0.000211699, 0.000213095, 0.000215329, 0.000217316, 0.000219443, 0.000221027, 0.000222918, 0.000225052, 0.000227004, 0.000228799, 0.000230623, 0.000233094, 0.00023592, 0.000237484, 0.000240574, 0.000243835, 0.000246973, 0.000251189, 0.00025431, 0.000257105, 0.000259253, 0.000263075, 0.000265521, 0.0002684, 0.000271877, 0.000274366, 0.000276811, 0.000281744, 0.000284244, 0.000286038, 0.00028939, 0.000295676, 0.000299303, 0.000303533, 0.000307541, 0.000312855, 0.000315645, 0.000319724, 0.000324628, 0.000329116, 0.000333104, 0.000336953, 0.000340689, 0.000343192, 0.00034782, 0.000351803, 0.000356268, 0.000360921, 0.00036406, 0.000368748, 0.000372736, 0.00037745, 0.000382522, 0.000387406, 0.000391622, 0.000394855, 0.000401068, 0.000405696, 0.000411255, 0.000417248, 0.000421599, 0.000425071, 0.000429984, 0.000435364, 0.000441678, 0.000447928, 0.000452185, 0.000456249, 0.000461861, 0.00046784, 0.00047247, 0.000478592, 0.00048337, 0.000488966, 0.00049625, 0.000501319, 0.000507632, 0.000513116, 0.000518072, 0.000523313, 0.000530276, 0.000535429, 0.000541265, 0.000547466, 0.000553451, 0.000562153, 0.000569329, 0.000575598, 0.000582245, 0.000589352, 0.000595505, 0.000602347, 0.000609259, 0.000615674, 0.000622014, 0.000628936, 0.000637991, 0.000643839, 0.000651651, 0.000659401, 0.000670168, 0.000681384, 0.000689048, 0.000697732, 0.000705547, 0.000712816, 0.000720061, 0.000727273, 0.000735817, 0.000742163, 0.000749501, 0.000758206, 0.000767112, 0.000775057, 0.000782356, 0.000788241, 0.000794981, 0.000804576, 0.000814258, 0.000822131, 0.000832088, 0.000843104, 0.000850698, 0.000857672, 0.000867094, 0.000876794, 0.000886068, 0.000897049, 0.000906755, 0.000917242, 0.000928563, 0.000938324, 0.00094862, 0.000959582, 0.000969364, 0.000979292, 0.000991039, 0.001002089, 0.001013865, 0.001027939, 0.00103962, 0.001050135, 0.001059193, 0.001062461, 0.00107824, 0.001090818, 0.001101962, 0.001115178, 0.001127784, 0.001137825, 0.001149981, 0.001160579, 0.001173463, 0.001187747, 0.00120098, 0.001213668, 0.001232128, 0.001246793, 0.001262567, 0.001276638, 0.001291745, 0.001305286, 0.00132156, 0.001335842, 0.001354054, 0.001370372, 0.001387485, 0.001404099, 0.001422324, 0.001438359, 0.001452987, 0.001471639, 0.001491647, 0.001507602, 0.001526961, 0.001545932, 0.001564062, 0.001582893, 0.001599386, 0.001619272, 0.001637045, 0.001655626, 0.001672941, 0.001692533, 0.00171318, 0.001733724, 0.001754772, 0.001775471, 0.001797629, 0.001817998, 0.001840528, 0.001860266, 0.001879788, 0.001900636, 0.001921016, 0.001941105, 0.00196539, 0.001992672, 0.002011813, 0.002032412, 0.002055079, 0.002075867, 0.002103918, 0.002124837, 0.002151084, 0.00218006, 0.002204168, 0.002233454, 0.002256756, 0.002281981, 0.002311798, 0.002336818, 0.002363182, 0.002388778, 0.002420165, 0.002445716, 0.002476578, 0.002505192, 0.002535139, 0.002559801, 0.002594495, 0.002619292, 0.002655543, 0.002685624, 0.002712511, 0.002744206, 0.002778383, 0.002816116, 0.002850697, 0.002882313, 0.002913297, 0.002949434, 0.002979888, 0.003014668, 0.003049562, 0.003088279, 0.003121772, 0.003158025, 0.003196779, 0.00323089, 0.003271365, 0.003307848, 0.003349713, 0.00338827, 0.003425124, 0.003471762, 0.003509171, 0.003553734, 0.003595781, 0.003643731, 0.003684672, 0.003730534, 0.00377162, 0.003815931, 0.003861329, 0.003906293, 0.00394849, 0.003994191, 0.004039181, 0.004084892, 0.00413336, 0.004175296, 0.004222356, 0.004268406, 0.004316003, 0.004368866, 0.004424117, 0.004472958, 0.004523195, 0.004571199, 0.004627289, 0.004683818, 0.004743053, 0.004794654, 0.004853115, 0.004907556, 0.004962485, 0.005012138, 0.005063829, 0.005122648, 0.005177126, 0.005235906, 0.005300626, 0.005361236, 0.005422632, 0.00549376, 0.005554307, 0.005617404, 0.005683021, 0.005752425, 0.005821914, 0.005888533, 0.005961669, 0.006024391, 0.006089921, 0.006158429, 0.006227853, 0.006295536, 0.006372634, 0.006448759, 0.006518778, 0.006598477, 0.006676279, 0.006750067, 0.006830177, 0.006906, 0.006980973, 0.007058179, 0.007145763, 0.007224822, 0.007307814, 0.007387226, 0.007466012, 0.007551021, 0.00763989, 0.007730255, 0.007813552, 0.007904621, 0.00799612, 0.008094422, 0.008190973, 0.008287425, 0.008383547, 0.008470813, 0.008567856, 0.008663977, 0.008760746, 0.00886911, 0.008969825, 0.009078002, 0.009171032, 0.009277574, 0.009386748, 0.009490449, 0.009603885, 0.009711037, 0.009822521, 0.009948059, 0.010058413, 0.010169728, 0.010288038, 0.010413405, 0.010524267, 0.010619268, 0.010644417, 0.010765856, 0.010898346, 0.011027812, 0.011155879, 0.011283296, 0.011416768, 0.011548391, 0.011686219, 0.01181406, 0.011950967, 0.012088283, 0.012231189, 0.01237423, 0.012527451, 0.01267378, 0.012819938, 0.012962279, 0.013116772, 0.013267997, 0.013422675, 0.013576091, 0.013731761, 0.013897283, 0.01407281, 0.014227037, 0.014387631, 0.014558172, 0.014718529, 0.014880458, 0.015053452, 0.015228204, 0.015401633, 0.015584076, 0.01577357, 0.015960091, 0.016145884, 0.016338155, 0.016526725, 0.016718581, 0.016907605, 0.017102862, 0.017292104, 0.017498125, 0.017693058, 0.017894404, 0.01810058, 0.018313131, 0.018525688, 0.018748961, 0.018952532, 0.019180808, 0.019408553, 0.019635838, 0.01986561, 0.020090225, 0.020334446, 0.020565416, 0.020802533, 0.021039759, 0.021277174, 0.02152185, 0.021780839, 0.022036802, 0.022288444, 0.02252659, 0.022776259, 0.023031832, 0.023295002, 0.023556568, 0.02381309, 0.024085019, 0.024356025, 0.02462488, 0.024920869, 0.025214909, 0.025510377, 0.025801832, 0.026098792, 0.026400144, 0.026708872, 0.027022399, 0.027337502, 0.027654443, 0.027970077, 0.028293166, 0.028619996, 0.028952127, 0.029285014, 0.029614978, 0.029961808, 0.03030048, 0.030640518, 0.030986692, 0.031341669, 0.031693112, 0.032071062, 0.032443039, 0.032819107, 0.033205587, 0.03359287, 0.033985402, 0.034368088, 0.034775676, 0.03518514, 0.0355713, 0.035977969, 0.036381636, 0.036807348, 0.03722512, 0.037646165, 0.038088373, 0.038519738, 0.038958947, 0.039412355, 0.039872338, 0.040335748, 0.040806541, 0.04126531, 0.041740714, 0.042201966, 0.042667851, 0.043148961, 0.043640955, 0.044146186, 0.044648078, 0.045140655, 0.045656294, 0.046192771, 0.046725155, 0.047279468, 0.047841521, 0.048378238, 0.048931074, 0.049485475, 0.050036681, 0.050613349, 0.051210901, 0.051783706, 0.052371462, 0.052971063, 0.053591109, 0.054194754, 0.054824948, 0.055433284, 0.056068564, 0.056709205, 0.057327402, 0.057993993, 0.058660753, 0.059335311, 0.060016228, 0.060701055, 0.06140114, 0.062111953, 0.062804692, 0.063521759, 0.064266362, 0.065019126, 0.065758322, 0.066487141, 0.067245564, 0.068024153, 0.068806415, 0.069613844, 0.070428008, 0.071224237, 0.072042407, 0.072844003, 0.073660222, 0.074508963, 0.075362091, 0.076211346, 0.077052226, 0.07791137, 0.078800091, 0.079698564, 0.080590185, 0.08150072, 0.082441213, 0.083388798, 0.084311804, 0.085255847, 0.086238772, 0.087237018, 0.088222273, 0.089220544, 0.090222164, 0.09126791, 0.092322419, 0.093381202, 0.094465764, 0.095557228, 0.096663489, 0.097775587, 0.098893855, 0.100043326, 0.101164997, 0.102328219, 0.103464346, 0.104395852, 0.104648447, 0.105851244, 0.107051945, 0.108265081, 0.109486873, 0.110705413, 0.111969023, 0.11326186, 0.11452615, 0.115818733, 0.117138356, 0.118460365, 0.119798257, 0.12118723, 0.122570138, 0.123976191, 0.125404718, 0.126843682, 0.128306592, 0.129767224, 0.131247854, 0.132734943, 0.13424515, 0.13575281, 0.137284489, 0.138834957, 0.140410238, 0.142034214, 0.143671018, 0.14529447, 0.14692176, 0.148593437, 0.150298132, 0.152012395, 0.15372701, 0.155462416, 0.157195034, 0.158984705, 0.160794716, 0.16261291, 0.16445612, 0.166310233, 0.168183763, 0.170097821, 0.17201673, 0.173996873, 0.175982709, 0.17798229, 0.179985419, 0.182059109, 0.184121459, 0.186188341, 0.188297482, 0.190406754, 0.192579061, 0.194730342, 0.196926631, 0.199154601, 0.201432716, 0.203682554, 0.20599302, 0.20831785, 0.210701685, 0.213060161, 0.215443731, 0.217885245, 0.220313972, 0.222806449, 0.225339306, 0.227899585, 0.230485911, 0.23310306, 0.235741064, 0.238372325, 0.241071267, 0.243783335, 0.246572057, 0.249342078, 0.252144108, 0.254930084, 0.257816901, 0.260763213, 0.263730565, 0.266779329, 0.269765166, 0.272834018, 0.27591923, 0.279026211, 0.2821618, 0.285381285, 0.288598803, 0.291796123, 0.295104229, 0.298464186, 0.301851634, 0.305304813, 0.306052404, 0.308783657, 0.312280535, 0.315809044, 0.319387442, 0.322970255, 0.326634551, 0.330314176, 0.334081149, 0.337856923, 0.341654674, 0.345495742, 0.349383073, 0.353314049, 0.357344901, 0.361391437, 0.365471267, 0.369596363, 0.373792564, 0.378036632, 0.382364809, 0.386706614, 0.39111015, 0.39554839, 0.400076763, 0.404629074, 0.4055502, 0.40922258, 0.413872244, 0.418650814, 0.423442293, 0.428253505, 0.433130218, 0.438011388, 0.443027854, 0.448041277, 0.453134624, 0.458405887, 0.463619489, 0.468840604, 0.474205853, 0.479642096, 0.485136876, 0.490676124, 0.496355682, 0.502053204, 0.507860021, 0.513722913, 0.519644769, 0.525658872, 0.531665227, 0.53774407, 0.544012912, 0.550270408, 0.556611739, 0.562993785, 0.569525648, 0.576165666, 0.582916898, 0.589688691, 0.596582753, 0.603608225, 0.606546515, 0.610657662, 0.617785675, 0.625014259, 0.632309719, 0.639748927, 0.647279766, 0.654883982, 0.662592452, 0.67046725, 0.678431805, 0.686533283, 0.694695606, 0.702986634, 0.711407735, 0.719992418, 0.728653949, 0.737455154, 0.746401519, 0.755453363, 0.764564917, 0.77379886, 0.783210999, 0.792738527, 0.802492791, 0.812368384, 0.816501157, 0.822412298, 0.83262617, 0.842993439, 0.853471297, 0.864248162, 0.87509903, 0.886146568, 0.897442748, 0.908838744, 0.920451765, 0.932286407, 0.944321314, 0.956539342, 0.969052686, 0.981751396, 0.994664249, 1.007762529, 1.021150752, 1.034903764, 1.045971156, 1.071147008, 1.08504851, 1.09894747, 1.112934178, 1.12678466, 1.14063567, 1.15442433, 1.168255229, 1.181962236, 1.195704255, 1.209387112, 1.223109377, 1.236793461, 1.250488417, 1.264155409, 1.277786606, 1.291357271, 1.304973665, 1.312958486, 1.318556824, 1.33214701, 1.345776225, 1.359515843, 1.373133829, 1.386759332, 1.400464537, 1.414080075, 1.427662151, 1.441278436, 1.454784708, 1.468475646, 1.482188694, 1.495796401, 1.509549761, 1.523354229, 1.537147022, 1.550975022, 1.564848446, 1.578661837, 1.592557944, 1.60650114, 1.62058513, 1.634622868, 1.648669883, 1.656926778, 1.662904237, 1.67715719, 1.691467323, 1.705861735, 1.720313521, 1.734779826, 1.749320517, 1.763857006, 1.778560208, 1.793317132, 1.808128119, 1.82313953, 1.838260911, 1.853316344, 1.868607652, 1.883931063, 1.899400637, 1.914908088, 1.930463792, 1.946190188, 1.962209563, 1.978289188, 1.994603034, 2.011028416, 2.027640967, 2.044069188, 2.0609797, 2.077829215, 2.094827272, 2.1121563, 2.129561953, 2.147269268, 2.165055853, 2.183271538, 2.201652034, 2.216383304, 2.220296146, 2.239072547, 2.258094496, 2.277097833, 2.296695778, 2.316442028, 2.336703773, 2.357021251, 2.377422945, 2.398320606, 2.419532696, 2.441185314, 2.463177549, 2.485412981, 2.507973035, 2.530856348, 2.554232711, 2.577635212, 2.601566362, 2.625679517, 2.650228605, 2.675290556, 2.700785776, 2.726713563, 2.753080571, 2.773604781, 2.779474412, 2.806890452, 2.834516935, 2.862565446, 2.890434042, 2.919462559, 2.948578755, 2.978466804, 3.008281381, 3.039189148, 3.070741253, 3.101981835, 3.133375521, 3.1656192, 3.19817405, 3.231395108, 3.264653605, 3.298528191, 3.332020173, 3.366773328, 3.401610069, 3.437096945, 3.472554345, 3.508468108, 3.544868085, 3.582038271, 3.619584691, 3.656439276, 3.693699426, 3.731434023, 3.76951363, 3.807693778, 3.846552162, 3.88609297, 3.925807265, 3.965728379, 4.005852726, 4.046162153, 4.086919106, 4.128644042, 4.170203881, 4.211527332, 4.25390359, 4.295896816, 4.338314449, 4.380751581, 4.424580169, 4.467944547, 4.512146529, 4.556031186, 4.600118197, 4.643789146, 4.688494866, 4.734390072, 4.779867065, 4.825232272, 4.871172697, 4.917329812, 4.964267632, 5.011349415, 5.058884445, 5.106295502, 5.154171531, 5.202431355, 5.250347925, 5.299443052, 5.348028736, 5.398153912, 5.448685118, 5.499437573, 5.549394869, 5.600478971, 5.651350172, 5.703244347, 5.754749218, 5.80714069, 5.859322785, 5.912968738, 5.9663709, 6.01985651, 6.075727556, 6.129659458, 6.184167214, 6.240156729, 6.295798237, 6.352257791, 6.407955272, 6.464258346, 6.520293649, 6.5766751, 6.632766125, 6.68950642, 6.74557258, 6.803399922, 6.861731797, 6.919786869, 6.931742664, 6.978862994, 7.038565284, 7.098122627, 7.157883189, 7.217716068, 7.27881002, 7.340433075, 7.401899123, 7.463081661, 7.52372135, 7.584670174, 7.647523403, 7.710991158, 7.776059666, 7.838460073, 7.903275306, 7.966897788, 8.030443345, 8.095294939, 8.160895804, 8.225326736, 8.290595616, 8.355701281, 8.421979912, 8.490540418, 8.557967813, 8.627737032, 8.69796975, 8.76464612, 8.834787584, 8.902892239, 8.974864462, 9.04455907, 9.114996327, 9.185543471, 9.256143616, 9.326276535, 9.3989204, 9.471711212, 9.545436676, 9.615871352, 9.690642189, 9.766056572, 9.840187402, 9.914450653, 9.989702416, 10.065507183, 10.140756498, 10.216127682, 10.291476283, 10.366652221, 10.445692542, 10.523656777, 10.598963145, 10.67793459, 10.754626484, 10.829988691, 10.909180264, 10.986958286, 11.069281166, 11.146798424, 11.224868599, 11.306601372, 11.38568575, 11.467293832, 11.547918622, 11.630175013, 11.710875847, 11.795179386, 11.877810374, 11.96222071, 12.043774485, 12.126337636, 12.210454876, 12.298304804, 12.381032687, 12.466099066, 12.552640516, 12.639025457, 12.725792235, 12.815096219, 12.902151487, 12.98779967, 13.076105984, 13.166304779, 13.258415076, 13.346521898, 13.432944986, 13.521615304, 13.608930936, 13.705297782, 13.795582379, 13.886958852, 13.978430244, 14.07076749, 14.164611537, 14.259113718, 14.352678787, 14.448788719, 14.540331847, 14.63807769, 14.734102132, 14.828524837, 14.924013658, 15.021167262, 15.120611159, 15.218521165, 15.313756291, 15.410973957, 15.508367981, 15.605626876, 15.707885728, 15.807728083, 15.906838076, 16.007656926, 16.100352435, 16.205647267, 16.302054699, 16.401711819, 16.505327933, 16.613051764, 16.71366502, 16.81635126, 16.916363929, 17.018989708, 17.119397414, 17.229002831, 17.335612537, 17.44635848, 17.549655892, 17.660274829, 17.767366268, 17.87427101, 17.987675728, 18.096612567, 18.204907084, 18.311662714, 18.421255605, 18.531193361, 18.643237008, 18.754681152, 18.863520003, 18.972502378, 19.087232682, 19.195876097, 19.309703701, 19.420056906, 19.538538214, 19.656585412, 19.77473586, 19.893604109, 20.013732996, 20.127669764, 20.236686879, 20.352602784, 20.479815258, 20.598888453, 20.712349413, 20.828058452, 20.947896707, 21.065203894, 21.189808576, 21.31192235, 21.427569818, 21.542641122, 21.661085589, 21.779559872, 21.89767617, 22.022703769, 22.144771994, 22.267941913, 22.393259725, 22.514636978, 22.640689832, 22.768612123, 22.89202267, 23.009280672, 23.132089256, 23.257321551, 23.375603093, 23.505029116, 23.625992109, 23.758502333, 23.87764876, 24.003120792, 24.131434875, 24.257996217, 24.393276955, 24.520260152, 24.649282554, 24.785768185, 24.917504049, 25.046816256, 25.168129888, 25.297801936, 25.425661178, 25.539681339, 25.675334564, 25.797834392, 25.934010143, 25.963193763, 26.072087573, 26.200788783, 26.33663465, 26.473642388, 26.606596223, 26.741222345, 26.875779379, 27.014474957, 27.145581151, 27.280969075, 27.417822508, 27.567778134, 27.700520273, 27.830713001, 27.967409715, 28.107566306, 28.247241366, 28.374605205, 28.506864319, 28.658122721, 28.797672392, 28.945087212, 29.0963734, 29.244544481, 29.386500841, 29.535451316, 29.664603134, 29.815664425, 29.961424418, 30.119823331, 30.262308468, 30.414748161, 30.55925268, 30.714182421, 30.875735476, 31.029672324, 31.175896196, 31.336718269, 31.486421033, 31.641463077, 31.779540592, 31.940514013, 32.085490789, 32.248118381, 32.392568625, 32.532276738, 32.689258095, 32.839487408, 33.000902334, 33.150571111, 33.308315508, 33.439345615, 33.585716656, 33.751230005, 33.901257413, 34.065056949, 34.228034292, 34.375555843, 34.542010007, 34.704826135, 34.862088038, 35.01425944, 35.166678289, 35.330063835, 35.481703564, 35.642863069, 35.798178597, 35.96058598, 36.111960441, 36.272718875, 36.427278001, 36.588014112, 36.770423835, 36.929400181, 37.096456206, 37.265701951, 37.423116433, 37.58269047, 37.763650849, 37.943815824, 38.117667292, 38.285359836, 38.427050374, 38.595170735, 38.738333047, 38.907994611, 39.063459541, 39.222057064, 39.378576673, 39.533715364, 39.716737424, 39.903944908, 40.086115317, 40.250411055, 40.425622557, 40.597422525, 40.776667221, 40.943420697, 41.114709879, 41.287887407, 41.468926079, 41.627576992, 41.798171396, 41.995100364, 42.169895945, 42.347677803, 42.512319717, 42.703643273, 42.879700228, 43.063387538, 43.237098813, 43.403134376, 43.59578143, 43.776332257, 43.959857809, 44.136891746, 44.304729692, 44.460772298, 44.633950166, 44.795123191, 44.962310099, 45.134201681, 45.328150206, 45.503915376, 45.71401254, 45.89800616, 46.095529998, 46.264885497, 46.436543957, 46.62608965, 46.830275263, 46.978328375, 47.138486294, 47.318158002, 47.498291573, 47.693259633, 47.878818937, 48.042940633, 48.191315382, 48.39859832, 48.595405679, 48.806128206, 48.959659331, 49.139823241, 49.339930039, 49.531630484, 49.703912614, 49.912108449, 50.085530654, 50.285660792, 50.488027259, 50.663953309, 50.889504002, 51.092554149, 51.298347426, 51.522537319, 51.737282679, 51.880856993, 52.116775455, 52.309843379, 52.514434064, 52.71728739, 52.930969139, 53.096184296, 53.308425189, 53.521320004, 53.679089813, 53.880569228, 54.048479958, 54.228672477, 54.418935054, 54.586751305, 54.786446117, 54.995215828, 55.198728011, 55.386684118, 55.581963841, 55.784685536, 55.986042817, 56.166438825, 56.339692303, 56.563076058, 56.758486576, 56.988142544, 57.18912896, 57.412195993, 57.611511132, 57.833726537, 58.050529422, 58.301941015, 58.510327181, 58.743947349, 58.932528945, 59.137855565, 59.358861778, 59.583992102, 59.881304219, 60.066231782, 60.263685594, 60.483380108, 60.507761042, 60.676082048, 60.873485363, 61.11840179, 61.333260855, 61.533419952, 61.751462725, 61.974838907, 62.165950149, 62.363935329, 62.557703775, 62.751444906, 62.909723147, 63.06619517, 63.288758637, 63.468265451, 63.77130707, 63.971473607, 64.159788759, 64.345321276, 64.558086425, 64.78873441, 64.948761622, 65.153255361, 65.412461461, 65.599534021, 65.825130455, 66.015147527, 66.221104826, 66.416652523, 66.627797515, 66.793122639, 67.026231073, 67.20800774, 67.419823391, 67.732410001, 67.957899541, 68.208295959, 68.392500607, 68.581187935, 68.840555801, 69.095078074, 69.332950467, 69.557699415, 69.712236524, 69.904037101, 70.141175621, 70.330683347, 70.607401872, 70.873608654, 71.073030149, 71.315751464, 71.505718916, 71.728399981, 71.985437846, 72.247074408, 72.422839636, 72.650518382, 72.891087341, 73.079714751, 73.282104991, 73.52734859, 73.773397567, 73.992250657, 74.234750453, 74.413445794, 74.660350445, 74.885235054, 75.071426379, 75.258767098, 75.46388081, 75.656448592, 75.833900543, 76.075094452, 76.355793546, 76.623073833, 76.858508105, 77.063715437, 77.219277916, 77.459726857, 77.63564141, 77.947559656, 78.14167472, 78.396445706, 78.590257005, 78.72264449, 79.016511421, 79.252393848, 79.433239825, 79.628187206, 79.859067895, 80.023439022, 80.187434007, 80.403162674, 80.605471905, 80.913954595, 81.124182368, 81.248044432, 81.472293182, 81.681197292, 81.890631713, 82.120379431, 82.257732935, 82.470034678, 82.670571112, 82.893470083, 83.08308427, 83.344835477, 83.698114933, 83.938086208, 84.128091741, 84.343981087, 84.541232082, 84.804394298, 85.021720136, 85.206610623, 85.550338201, 85.771973071, 85.979450507, 86.184537636, 86.430283294, 86.740601741, 87.129004258, 87.339532774, 87.550032691, 87.812460277, 88.005290895, 88.336000046, 88.498674087, 88.707318031, 89.030638588, 89.278743205, 89.521253438, 89.769914309, 90.036975461, 90.226632836, 90.41902623, 90.604884124, 90.813244166, 90.983387726, 91.216755744, 91.431628889, 91.666896964, 91.832806752, 92.011340533, 92.133715011, 92.277519741, 92.52732875, 92.799224004, 92.904251721, 93.22229394, 93.410129829, 93.650758786, 93.948652661, 94.351479254, 94.671381961, 94.847490597, 95.122994779, 95.335072102, 95.614094358, 96.074507714, 96.294110008, 96.648127084, 96.882460741, 97.106404772, 97.261329399, 97.644870762, 97.850639225, 97.945543327, 98.177419216, 98.480910386, 98.575623014, 98.774477041, 98.956630791, 99.144696059, 99.340220679, 99.536674742, 99.99320855, 100.177893879, 100.329155381, 100.44993558, 100.597918378, 100.763109498, 100.94371307, 101.153678727, 101.311839367, 101.430438257, 101.578860762, 101.823881729, 102.17179555, 102.461684737, 102.664374686, 102.964709876, 103.141442528, 103.291312518, 103.601921191, 103.871847861, 104.360261695, 104.728748251, 104.980757231, 105.253278959, 105.483450195, 105.56157741, 105.820836947, 106.238943297, 106.460567071, 106.571389735, 106.856502809, 107.021957387, 107.177718715, 107.652789409, 107.763471628, 107.980247986, 108.233260173, 108.450163059, 108.605297355, 108.846439465, 109.120053441, 109.324711923, 109.53211782, 109.851434801, 110.169604442, 110.313106726, 110.614933851, 110.955088274, 111.081738318, 111.408807437, 111.670948009, 111.853081469, 111.989439218, 112.101574801, 112.394644261, 112.483526604, 112.687516624, 112.766089398, 113.377482442, 113.484959196, 113.606811802, 113.716551507, 114.006853693, 114.192406057, 114.293383234, 114.644706396, 115.163970778, 115.698509077, 116.320815797, 116.821105423, 116.89808776, 117.607328149, 117.795788977, 118.081088046, 118.265115771, 118.678073383, 118.85750606, 118.958238405, 119.035764296, 119.121625508, 119.867184876, 120.139387451, 120.241000398, 120.491235983, 120.574248738, 120.881499423, 121.004672116, 121.342956851, 121.529488733, 121.660584521, 121.722714089, 122.060594137, 122.237059595, 122.350677802, 122.752070097, 122.897544387, 123.151597004, 123.221073949, 123.599122174, 123.774131605, 123.890683992, 124.358382896, 124.423141801, 124.466363107, 124.617381418, 124.776292159, 125.125186208, 125.367623599, 125.6085467, 125.647068425, 125.730697292, 125.916103177, 126.156308619, 126.479797574, 126.795154463, 127.005448825, 127.01680762, 127.306572899, 127.600265345, 127.695888804, 127.951327568, 128.641858837, 128.830184667, 129.253056492, 129.585925047, 129.894576922, 130.149186998, 130.599068079, 130.807754452, 130.939593639, 131.097325005, 131.131648253, 131.500492701, 131.689181219, 131.734235591, 131.944280865, 132.469694218, 132.730447788, 133.200888014, 133.424867868, 133.505314196, 133.624568779, 133.784010538, 133.824489228, 133.956346669, 134.079522074, 134.143642238, 134.485427343, 134.485827464, 134.654472668, 134.712571757, 134.720142325, 135.061623134, 135.537580798, 135.615527016, 135.857949492, 135.917030005, 136.149270873, 136.192068238, 136.298114, 136.489901117, 136.869211454, 136.948927687, 137.089489716 ), "35" = c(1.5838e-05, 1.5993e-05, 1.6104e-05, 1.6612e-05, 1.6615e-05, 1.6621e-05, 1.6731e-05, 1.6991e-05, 1.7132e-05, 1.7212e-05, 1.7214e-05, 1.7315e-05, 1.7511e-05, 1.7607e-05, 1.7814e-05, 1.7877e-05, 1.8108e-05, 1.8454e-05, 1.9067e-05, 1.9129e-05, 1.9339e-05, 1.9512e-05, 1.9847e-05, 1.9883e-05, 2.011e-05, 2.0195e-05, 2.0252e-05, 2.0303e-05, 2.0576e-05, 2.1588e-05, 2.2032e-05, 2.2124e-05, 2.2326e-05, 2.2402e-05, 2.3037e-05, 2.3401e-05, 2.3432e-05, 2.365e-05, 2.3798e-05, 2.4518e-05, 2.4632e-05, 2.4817e-05, 2.5628e-05, 2.5791e-05, 2.6087e-05, 2.6285e-05, 2.695e-05, 2.7386e-05, 2.7995e-05, 2.8023e-05, 2.8454e-05, 2.8796e-05, 2.8909e-05, 2.9285e-05, 2.9779e-05, 3.0787e-05, 3.1447e-05, 3.1813e-05, 3.2358e-05, 3.2988e-05, 3.3341e-05, 3.3541e-05, 3.3681e-05, 3.5001e-05, 3.5246e-05, 3.5968e-05, 3.6426e-05, 3.6574e-05, 3.6929e-05, 3.7553e-05, 3.8091e-05, 3.8572e-05, 3.881e-05, 3.9102e-05, 3.9217e-05, 3.956e-05, 4.033e-05, 4.1878e-05, 4.2489e-05, 4.3064e-05, 4.3512e-05, 4.3855e-05, 4.4424e-05, 4.4929e-05, 4.5719e-05, 4.598e-05, 4.6461e-05, 4.6737e-05, 4.7406e-05, 4.8231e-05, 4.8628e-05, 4.8926e-05, 4.9624e-05, 5.0693e-05, 5.1576e-05, 5.1922e-05, 5.2416e-05, 5.3038e-05, 5.4095e-05, 5.4351e-05, 5.5548e-05, 5.6717e-05, 5.7708e-05, 5.8348e-05, 5.8917e-05, 6.0067e-05, 6.1404e-05, 6.2087e-05, 6.2662e-05, 6.3314e-05, 6.4057e-05, 6.4759e-05, 6.6117e-05, 6.7003e-05, 6.753e-05, 6.7898e-05, 6.9269e-05, 6.9954e-05, 7.1506e-05, 7.2117e-05, 7.2902e-05, 7.4234e-05, 7.4675e-05, 7.6382e-05, 7.7076e-05, 7.7595e-05, 7.8754e-05, 7.9869e-05, 8.1066e-05, 8.2687e-05, 8.4621e-05, 8.5339e-05, 8.5784e-05, 8.763e-05, 8.8125e-05, 8.8593e-05, 8.9589e-05, 9.0587e-05, 9.1324e-05, 9.2401e-05, 9.306e-05, 9.4567e-05, 9.5483e-05, 9.6193e-05, 9.7225e-05, 9.8182e-05, 9.9619e-05, 0.000100356, 0.000101525, 0.000103625, 0.000104584, 0.000105976, 0.000106918, 0.00010798, 0.000109622, 0.000111681, 0.000113557, 0.000115071, 0.000116623, 0.000118584, 0.000120122, 0.00012176, 0.000123429, 0.000124168, 0.000126009, 0.00012748, 0.00012874, 0.000129845, 0.00013276, 0.000135902, 0.000137063, 0.000139689, 0.000140897, 0.000142107, 0.000143982, 0.00014646, 0.000147254, 0.000149847, 0.000151374, 0.000152506, 0.000153432, 0.00015562, 0.000156779, 0.000158122, 0.000159756, 0.000160951, 0.000161816, 0.000164077, 0.000165887, 0.000167622, 0.000168438, 0.000170624, 0.000172999, 0.000175341, 0.000178304, 0.00017987, 0.000181772, 0.000183899, 0.000186577, 0.000189493, 0.000191105, 0.000193132, 0.000195439, 0.000198325, 0.000202338, 0.000206887, 0.000210397, 0.000212948, 0.000215017, 0.000216461, 0.000218075, 0.000220853, 0.000225595, 0.000227706, 0.000231228, 0.000234218, 0.000237073, 0.000239564, 0.000241176, 0.00024358, 0.000247207, 0.000250286, 0.000252956, 0.000256189, 0.000259091, 0.000263383, 0.000267118, 0.000269729, 0.00027394, 0.000278443, 0.000280649, 0.000282786, 0.000286287, 0.000288249, 0.000290536, 0.000292653, 0.000295826, 0.000301563, 0.000304813, 0.000308416, 0.00031279, 0.00031527, 0.000318879, 0.000323046, 0.00032662, 0.000329854, 0.000334565, 0.00033941, 0.000343289, 0.000346941, 0.000351556, 0.000356877, 0.000360327, 0.000364661, 0.00036991, 0.000374878, 0.000379473, 0.000383823, 0.000388846, 0.000392232, 0.000396403, 0.000400083, 0.000403981, 0.000409081, 0.000413603, 0.000418264, 0.000421555, 0.000425575, 0.00042981, 0.00043551, 0.000439811, 0.000444945, 0.000450706, 0.000453261, 0.000457886, 0.000463454, 0.00046705, 0.000475035, 0.000479659, 0.00048459, 0.000489614, 0.000496136, 0.000500632, 0.00050692, 0.000510856, 0.000517255, 0.00052203, 0.000527236, 0.000533631, 0.000538229, 0.000545991, 0.000551747, 0.00055631, 0.000565621, 0.000572764, 0.000577865, 0.000581712, 0.000587792, 0.00059303, 0.000601038, 0.000608666, 0.000614069, 0.000620664, 0.000627864, 0.000638384, 0.000644394, 0.000653675, 0.000664289, 0.000668917, 0.000676001, 0.00068269, 0.000691245, 0.000700188, 0.000708146, 0.000716491, 0.000725612, 0.000734373, 0.000741224, 0.000749843, 0.000759047, 0.000765883, 0.000776118, 0.000786667, 0.000795656, 0.000806572, 0.000817679, 0.000828352, 0.000839936, 0.000850519, 0.000861373, 0.000871637, 0.000882553, 0.000892962, 0.000903389, 0.000912493, 0.000921067, 0.000930819, 0.000940572, 0.000950951, 0.000960871, 0.000969695, 0.000971939, 0.000982773, 0.000996131, 0.001005247, 0.001015629, 0.001029532, 0.001042934, 0.001054315, 0.001066518, 0.001081945, 0.001094998, 0.00110756, 0.001118304, 0.001133894, 0.001148263, 0.001163945, 0.001179029, 0.001192059, 0.001205464, 0.001219202, 0.001234111, 0.001247365, 0.00126044, 0.00127697, 0.001293318, 0.001308622, 0.001323705, 0.001340462, 0.001354962, 0.001372486, 0.001384869, 0.00140073, 0.001415475, 0.001432907, 0.001449223, 0.001467179, 0.001487703, 0.001501946, 0.001516135, 0.001534297, 0.001552229, 0.001568826, 0.001588694, 0.001610315, 0.001631819, 0.001651673, 0.001671373, 0.001688917, 0.001702917, 0.001723256, 0.001743486, 0.001765982, 0.001789164, 0.00180835, 0.001830026, 0.001847676, 0.001868095, 0.00188701, 0.001909544, 0.001930472, 0.001952028, 0.001976809, 0.002000305, 0.002026502, 0.002050552, 0.002076755, 0.002100624, 0.002125069, 0.002149496, 0.002173566, 0.002197898, 0.002227051, 0.002252861, 0.002276812, 0.002306146, 0.002332473, 0.002362706, 0.0023871, 0.002416739, 0.00244292, 0.002472085, 0.002500707, 0.002530453, 0.002559565, 0.002585932, 0.002618624, 0.002648693, 0.00267914, 0.002715982, 0.00274909, 0.002777172, 0.002810995, 0.002845879, 0.00287797, 0.002913569, 0.002947819, 0.002980834, 0.003015768, 0.003051896, 0.003087067, 0.003128145, 0.003164832, 0.003198976, 0.003235145, 0.003267768, 0.003310994, 0.003347518, 0.003385268, 0.003426784, 0.0034725, 0.00351621, 0.00355555, 0.003597687, 0.003639912, 0.00368469, 0.003729842, 0.003773617, 0.003818895, 0.003859491, 0.003904334, 0.003944737, 0.00399032, 0.004039528, 0.004083856, 0.004131587, 0.004180103, 0.004231245, 0.004285071, 0.004333214, 0.004383039, 0.004433153, 0.004490229, 0.004541426, 0.004595148, 0.004645446, 0.004702012, 0.004756862, 0.004813816, 0.004874489, 0.004932172, 0.004984575, 0.005038498, 0.005095237, 0.005150921, 0.005214476, 0.005276814, 0.005338038, 0.005397096, 0.0054628, 0.005528096, 0.005592859, 0.005656579, 0.005728494, 0.005797678, 0.005865291, 0.005928406, 0.005997769, 0.006066799, 0.00613641, 0.006202617, 0.006279935, 0.006342081, 0.00641674, 0.006490055, 0.006563769, 0.00663595, 0.006714596, 0.006793708, 0.006884802, 0.006966275, 0.007049833, 0.007136003, 0.007214468, 0.007296821, 0.007375637, 0.007457329, 0.00754643, 0.007630677, 0.007727789, 0.007826501, 0.007915764, 0.008009827, 0.008108028, 0.008201704, 0.008301936, 0.008394186, 0.008498097, 0.008594066, 0.008687508, 0.008781382, 0.008886101, 0.008996425, 0.009106262, 0.009208665, 0.009312218, 0.009421165, 0.009546241, 0.009654455, 0.009765016, 0.009876264, 0.009973045, 0.009995391, 0.010111036, 0.010229762, 0.010346381, 0.010465167, 0.010582833, 0.010699074, 0.010833237, 0.010954832, 0.011084718, 0.011219761, 0.011350383, 0.01147113, 0.011608352, 0.011743531, 0.011883754, 0.012028317, 0.012167037, 0.012303834, 0.012446116, 0.012602307, 0.012741323, 0.012881523, 0.013026005, 0.013176168, 0.013333037, 0.013496065, 0.013652963, 0.0138178, 0.013971475, 0.014132179, 0.014296884, 0.014456723, 0.014617244, 0.014782907, 0.014954774, 0.015121069, 0.015292675, 0.01546569, 0.015642292, 0.015810248, 0.015996285, 0.016180602, 0.01637586, 0.016565833, 0.016757518, 0.016945396, 0.017141766, 0.017340004, 0.017537652, 0.017745562, 0.017949955, 0.018154414, 0.018359387, 0.018569604, 0.018783775, 0.018993221, 0.019217639, 0.019439444, 0.019667108, 0.019892088, 0.020123683, 0.020350773, 0.020575746, 0.020821431, 0.021073084, 0.021308832, 0.021547237, 0.021807076, 0.022066695, 0.022337239, 0.022597693, 0.022859676, 0.023135482, 0.023412527, 0.023702195, 0.023966669, 0.024256458, 0.024516734, 0.024794881, 0.025088435, 0.025395626, 0.025699252, 0.025993374, 0.026280394, 0.026587314, 0.026876081, 0.027190134, 0.027497275, 0.02780642, 0.028130569, 0.028466136, 0.028792656, 0.029135966, 0.029463954, 0.029803439, 0.030161794, 0.030502054, 0.030863475, 0.031225622, 0.03160424, 0.031975081, 0.032346037, 0.0327156, 0.033097032, 0.033477069, 0.033849079, 0.034246577, 0.03464701, 0.03505482, 0.035466933, 0.03588037, 0.036294581, 0.036701528, 0.037137808, 0.037575655, 0.03803493, 0.03848246, 0.038921593, 0.039352995, 0.039806329, 0.040263854, 0.040729023, 0.041199384, 0.041674853, 0.042155139, 0.042639445, 0.043139299, 0.043638372, 0.044160686, 0.04465973, 0.045176478, 0.045698965, 0.046255845, 0.046788018, 0.047348346, 0.047893499, 0.048456487, 0.049007845, 0.049561763, 0.050147681, 0.050723664, 0.051287229, 0.051879981, 0.052477479, 0.05305997, 0.053663422, 0.054288488, 0.054915319, 0.05554912, 0.056188568, 0.056843716, 0.057496682, 0.058161503, 0.05883591, 0.059497208, 0.060196317, 0.060898196, 0.061615731, 0.062333393, 0.063046273, 0.063772043, 0.064510662, 0.065263105, 0.06600264, 0.066770578, 0.067537014, 0.06832739, 0.069110714, 0.069916738, 0.070732124, 0.071546706, 0.072388907, 0.073224227, 0.074066768, 0.074901993, 0.07576499, 0.076655611, 0.077541992, 0.078455859, 0.079362795, 0.080282584, 0.081222109, 0.082136937, 0.083065114, 0.084014125, 0.084956492, 0.085939487, 0.086953917, 0.087955593, 0.088983699, 0.090048418, 0.091090137, 0.092129155, 0.093174026, 0.094219542, 0.095310199, 0.096418313, 0.097530333, 0.098646529, 0.099561669, 0.09979984, 0.100949651, 0.102123799, 0.10330525, 0.104506439, 0.105721404, 0.106977921, 0.108233695, 0.10946597, 0.110728912, 0.111993519, 0.113298479, 0.114640525, 0.11596575, 0.117282786, 0.118631128, 0.120026842, 0.121405224, 0.122831099, 0.124253392, 0.125685091, 0.127171228, 0.128662822, 0.130137362, 0.131661735, 0.133173379, 0.134759056, 0.136292765, 0.137887268, 0.139494372, 0.141109251, 0.14272606, 0.144387145, 0.146044188, 0.147725324, 0.149436942, 0.151160846, 0.152892434, 0.154637879, 0.156465248, 0.158297081, 0.160120828, 0.161956769, 0.163838249, 0.165718186, 0.167656211, 0.169605733, 0.171559338, 0.17354117, 0.175586077, 0.177603296, 0.179617572, 0.181724489, 0.183818171, 0.185924391, 0.188079157, 0.190242679, 0.192441604, 0.194641923, 0.196911684, 0.199159417, 0.201476044, 0.203800988, 0.206156464, 0.20854777, 0.210973084, 0.213428671, 0.215919498, 0.218426615, 0.220936999, 0.223510209, 0.226099777, 0.228776657, 0.231456224, 0.234138056, 0.236863087, 0.239607702, 0.242397409, 0.245190447, 0.24806333, 0.250957678, 0.25390331, 0.256855424, 0.25986237, 0.262917132, 0.265974269, 0.269052096, 0.272217653, 0.275413681, 0.278624276, 0.281874216, 0.285141307, 0.288486016, 0.291793022, 0.2951733, 0.298594224, 0.299378474, 0.302095267, 0.305623741, 0.309190504, 0.312798601, 0.316449755, 0.320163157, 0.323901091, 0.327688411, 0.331450561, 0.335345548, 0.33925286, 0.343215385, 0.347258545, 0.351317632, 0.355439833, 0.359614627, 0.36381065, 0.368106651, 0.372431291, 0.37679976, 0.381248876, 0.385761905, 0.390302784, 0.394856706, 0.399554803, 0.400529669, 0.404271275, 0.40906564, 0.413898937, 0.418846551, 0.423773953, 0.428794001, 0.433798472, 0.43893682, 0.444199867, 0.449480036, 0.454936108, 0.460353788, 0.465850012, 0.471448835, 0.477090068, 0.482793386, 0.488596682, 0.494410155, 0.500311342, 0.506341468, 0.512438161, 0.518588613, 0.524899265, 0.531276961, 0.537635087, 0.544159955, 0.550676521, 0.55739939, 0.564124492, 0.571003389, 0.577974208, 0.585004209, 0.592177608, 0.599437472, 0.606813524, 0.60998688, 0.614305501, 0.621966379, 0.62962423, 0.63738482, 0.645268463, 0.653210424, 0.661365196, 0.669569121, 0.677915474, 0.686397767, 0.695019308, 0.70366082, 0.712488022, 0.721493179, 0.730644838, 0.73998176, 0.749388438, 0.758945007, 0.768569438, 0.778395795, 0.788328174, 0.798469123, 0.808786066, 0.819275339, 0.829963452, 0.83436653, 0.840656699, 0.851777992, 0.862823102, 0.874187436, 0.88576081, 0.897667213, 0.909616193, 0.921813993, 0.934229221, 0.946892807, 0.95981637, 0.97292846, 0.986241445, 0.999882492, 1.013825632, 1.027954128, 1.042381226, 1.057089332, 1.072166194, 1.08435368, 1.112023707, 1.12740465, 1.142682019, 1.157984999, 1.173229156, 1.18844436, 1.203620769, 1.218823243, 1.233991629, 1.249218146, 1.264266682, 1.279348304, 1.294439814, 1.309474741, 1.324549802, 1.339463906, 1.354565194, 1.369529713, 1.378538685, 1.384754025, 1.399783859, 1.414845888, 1.429909492, 1.445131703, 1.460355225, 1.475388729, 1.490551648, 1.505601611, 1.520781451, 1.53583874, 1.550979098, 1.566182127, 1.581292676, 1.596435025, 1.611661666, 1.626907987, 1.642109555, 1.657390231, 1.672726101, 1.688039217, 1.703356304, 1.718781367, 1.734274855, 1.749635192, 1.75850715, 1.765161575, 1.780800186, 1.796552552, 1.81228478, 1.827976144, 1.843777098, 1.859725833, 1.875522506, 1.891504176, 1.907635738, 1.923646464, 1.939917857, 1.956276865, 1.972634626, 1.989100042, 2.005754381, 2.022408616, 2.039100163, 2.05589931, 2.072676231, 2.089646706, 2.106953554, 2.124083581, 2.141357346, 2.158594864, 2.176183056, 2.193753039, 2.211486601, 2.229489009, 2.247552575, 2.265840693, 2.28417654, 2.302642702, 2.320979666, 2.339792615, 2.354729264, 2.35853965, 2.377483097, 2.396792926, 2.416238803, 2.435644968, 2.45538105, 2.475273569, 2.495141048, 2.515400723, 2.535795037, 2.556518107, 2.577348767, 2.598479038, 2.619691357, 2.641461757, 2.663137368, 2.685225159, 2.707641229, 2.730129154, 2.75284215, 2.775804087, 2.798971505, 2.822380972, 2.846175351, 2.870395686, 2.889510135, 2.894845221, 2.919293296, 2.94448953, 2.969685762, 2.995473099, 3.021549062, 3.047692419, 3.074403477, 3.101699623, 3.129195253, 3.156615785, 3.184207799, 3.212705928, 3.241445392, 3.271059169, 3.300389128, 3.330277823, 3.360471858, 3.390996353, 3.421345723, 3.452670792, 3.484069033, 3.516211966, 3.548416342, 3.580471301, 3.613645842, 3.646969718, 3.680571607, 3.714724234, 3.748920418, 3.783291433, 3.817913573, 3.853088661, 3.888719296, 3.925072502, 3.961180358, 3.997600786, 4.034054362, 4.071468759, 4.108531794, 4.146260071, 4.18454227, 4.223535409, 4.26226376, 4.300595402, 4.340251187, 4.380218584, 4.419269321, 4.459291682, 4.500094692, 4.541120668, 4.582490729, 4.623873092, 4.665837469, 4.707791924, 4.749687923, 4.791834333, 4.83516217, 4.878101199, 4.921849009, 4.965457028, 5.0091109, 5.052462396, 5.096175685, 5.140556524, 5.184494286, 5.230344281, 5.276502524, 5.322360378, 5.368520862, 5.414613808, 5.460792713, 5.507248069, 5.553868839, 5.60202146, 5.650187795, 5.698260781, 5.747322635, 5.794906298, 5.843385116, 5.892413265, 5.941922685, 5.991102994, 6.042071054, 6.092520992, 6.143674549, 6.194755758, 6.245617252, 6.297311825, 6.348475101, 6.400920595, 6.453360111, 6.506283452, 6.560073434, 6.613785181, 6.667298269, 6.678777942, 6.722690663, 6.777692627, 6.832183551, 6.886478452, 6.941498993, 6.996606339, 7.052261316, 7.1085803, 7.164219432, 7.221463113, 7.277563678, 7.334695663, 7.39337572, 7.45125532, 7.509518914, 7.569355011, 7.626759506, 7.68503655, 7.744358157, 7.803460783, 7.86370427, 7.922737936, 7.985028939, 8.046502359, 8.106381184, 8.166275579, 8.226264372, 8.287874356, 8.35189338, 8.416082585, 8.481562371, 8.54421396, 8.608067523, 8.673613961, 8.737891572, 8.803511467, 8.869739133, 8.93729254, 9.004805306, 9.071543529, 9.137721189, 9.204160274, 9.272079183, 9.339530472, 9.407823579, 9.475968919, 9.544115017, 9.613499267, 9.681319684, 9.752622704, 9.822679086, 9.890778986, 9.963857479, 10.037350878, 10.107996217, 10.181040892, 10.25244534, 10.325537406, 10.398665784, 10.470260273, 10.542801165, 10.61684543, 10.691749849, 10.766845592, 10.841857426, 10.916229761, 10.991119406, 11.066293612, 11.142887686, 11.216226674, 11.292785416, 11.369860473, 11.446567251, 11.525729061, 11.603587584, 11.681288743, 11.760966713, 11.840379078, 11.919415783, 12.001328095, 12.083951378, 12.165095654, 12.248082849, 12.330684112, 12.412700066, 12.498345169, 12.580566496, 12.663942643, 12.748783656, 12.831586449, 12.91746963, 13.000097933, 13.087712716, 13.17443694, 13.26448119, 13.350396938, 13.437850859, 13.525234879, 13.610702002, 13.695615069, 13.784924776, 13.876389001, 13.966005982, 14.052650246, 14.139922823, 14.230512111, 14.317314069, 14.409773527, 14.503222841, 14.596060431, 14.687754719, 14.783808551, 14.874856058, 14.967336895, 15.059619825, 15.152345242, 15.246605223, 15.341199192, 15.438985803, 15.536176764, 15.631009404, 15.725277632, 15.81786761, 15.916997936, 16.014643322, 16.113313501, 16.211896456, 16.311966528, 16.407028309, 16.506039841, 16.604528025, 16.705394303, 16.803420332, 16.914975468, 17.014462716, 17.115460095, 17.217349842, 17.327123526, 17.430126988, 17.539572057, 17.644639158, 17.752439553, 17.853756444, 17.962947719, 18.065623365, 18.173488729, 18.277540062, 18.381227556, 18.490780511, 18.598536767, 18.712919864, 18.824786377, 18.936692715, 19.048688072, 19.160051409, 19.267718952, 19.383010495, 19.492393059, 19.602069881, 19.713872141, 19.827009743, 19.939404629, 20.055595157, 20.164909143, 20.278838284, 20.387661527, 20.506314018, 20.617256255, 20.735886258, 20.849596977, 20.967068468, 21.083157749, 21.201771303, 21.319861165, 21.433437512, 21.552389587, 21.669828196, 21.784998104, 21.907313216, 22.040682528, 22.158572666, 22.277741687, 22.40071919, 22.532338219, 22.657238411, 22.771417728, 22.890192732, 23.004341897, 23.12978721, 23.257794698, 23.384918228, 23.526752517, 23.654048159, 23.783959281, 23.89964595, 24.03384206, 24.155280571, 24.274852724, 24.401007015, 24.539515305, 24.568722045, 24.679865656, 24.806764428, 24.931938862, 25.066777847, 25.200914222, 25.340775173, 25.469630758, 25.601685871, 25.733822665, 25.86818825, 25.99732227, 26.134097034, 26.264598198, 26.409330788, 26.535822646, 26.670748749, 26.810898086, 26.952081671, 27.08861727, 27.233434629, 27.372947841, 27.524834136, 27.666763846, 27.80789388, 27.956681424, 28.099272809, 28.244556299, 28.387500862, 28.536928532, 28.681687778, 28.816108413, 28.954518996, 29.101342317, 29.253091315, 29.403627579, 29.547428635, 29.702648086, 29.848956361, 29.998165506, 30.150376405, 30.306134198, 30.456305278, 30.614718095, 30.75127775, 30.903908537, 31.047487376, 31.195520756, 31.354874686, 31.501976786, 31.644042532, 31.786019673, 31.948021173, 32.108306067, 32.268099436, 32.434228397, 32.580996241, 32.757302377, 32.922347932, 33.079652231, 33.239028059, 33.412426684, 33.574141262, 33.738584503, 33.889037928, 34.051848734, 34.231857035, 34.394311959, 34.581545838, 34.745610613, 34.905256852, 35.056858567, 35.219084883, 35.375877881, 35.541147403, 35.718704434, 35.89192333, 36.057879813, 36.230734075, 36.408231393, 36.583569456, 36.748469998, 36.915701895, 37.109143471, 37.253925994, 37.433222953, 37.627563675, 37.808669953, 37.973648167, 38.131947768, 38.319830737, 38.47177366, 38.646681082, 38.834831535, 39.008224259, 39.17462922, 39.364969968, 39.555618698, 39.716545413, 39.892491401, 40.070119748, 40.26232604, 40.444344336, 40.612473131, 40.779646754, 40.946133674, 41.135695427, 41.313783432, 41.52814243, 41.718436998, 41.912596271, 42.116072577, 42.309037975, 42.494516972, 42.68893015, 42.896715554, 43.071921396, 43.283009468, 43.50379794, 43.698157397, 43.897209707, 44.07791851, 44.294801576, 44.47819044, 44.669443078, 44.849038899, 45.041089975, 45.220775135, 45.423108661, 45.614548807, 45.793480878, 45.997146201, 46.209456977, 46.450568191, 46.632466165, 46.818945263, 47.007977263, 47.207082389, 47.392855276, 47.601083315, 47.779690884, 48.004955408, 48.199285998, 48.391672982, 48.602776913, 48.809876175, 49.004841654, 49.207657138, 49.447914654, 49.659904797, 49.870728279, 50.053017336, 50.268475305, 50.475861011, 50.698422973, 50.871062239, 51.076574119, 51.309283633, 51.508062313, 51.699919756, 51.904426338, 52.111923624, 52.362103174, 52.578417905, 52.779816919, 53.015904857, 53.228490166, 53.432060987, 53.634954186, 53.895803467, 54.160794402, 54.353551948, 54.540858606, 54.754143937, 54.987450942, 55.230772147, 55.442366844, 55.643630256, 55.859420741, 56.12489402, 56.375967898, 56.572110461, 56.759611369, 56.947011755, 57.159984529, 57.394343981, 57.646973117, 57.88114977, 58.094140997, 58.367073354, 58.582079745, 58.81990894, 59.048727047, 59.291640153, 59.512334001, 59.77520663, 59.986948454, 60.206481976, 60.444911386, 60.671173212, 60.875001568, 60.927112341, 61.081514695, 61.319250383, 61.571121928, 61.834253742, 62.080050068, 62.327148058, 62.539233344, 62.800192515, 63.064143965, 63.356242274, 63.588539175, 63.845301848, 64.030986938, 64.261239485, 64.535939951, 64.838442091, 65.056549729, 65.282718551, 65.543010344, 65.769599854, 66.02017046, 66.294417819, 66.549481803, 66.762635857, 67.153062311, 67.421544663, 67.636057351, 67.93459442, 68.277325697, 68.602135349, 68.790781477, 69.036326556, 69.343612254, 69.632916097, 69.915178879, 70.179567555, 70.477583157, 70.774053219, 71.050802421, 71.338423035, 71.649795779, 71.941766516, 72.126564485, 72.427574041, 72.694171387, 72.88436945, 73.114706342, 73.309914714, 73.521134768, 73.79956, 74.09813125, 74.32259345, 74.490376295, 74.730090786, 74.984631294, 75.22277406, 75.45426605, 75.767494445, 76.066941118, 76.331780505, 76.654049819, 76.955417797, 77.168800479, 77.467260607, 77.799639682, 78.059187753, 78.28290166, 78.467967999, 78.738299369, 78.934485836, 79.270323939, 79.528054768, 79.795558684, 80.115735813, 80.425413327, 80.679470831, 80.936585555, 81.27065012, 81.564398624, 81.778298193, 82.005878933, 82.279863921, 82.495373285, 82.8645289, 83.081219005, 83.403850885, 83.745760575, 84.074856356, 84.306339388, 84.540797173, 84.94941201, 85.195813147, 85.463832328, 85.857998684, 86.112027646, 86.423545776, 86.662214289, 86.94137535, 87.141268334, 87.409977131, 87.718416808, 88.05817132, 88.244517593, 88.573995381, 88.954991297, 89.186646405, 89.475760276, 89.781208791, 90.007003639, 90.265456954, 90.530469544, 90.913877617, 91.230719865, 91.557317451, 91.790999753, 92.049149527, 92.25340017, 92.467484859, 92.984058093, 93.206895261, 93.520893856, 93.819364766, 94.122124781, 94.659638941, 94.846973038, 95.128667955, 95.557566043, 95.715451337, 95.894378361, 96.24669127, 96.673559607, 96.902153342, 97.284312815, 97.521462192, 97.99382407, 98.322270422, 98.781956103, 99.089357134, 99.314349111, 99.882687003, 100.241854079, 100.514913428, 100.9176625, 101.134542486, 101.617530376, 101.802566475, 102.025938021, 102.27991377, 102.650488258, 102.943192268, 103.325619902, 103.805507101, 104.157014871, 104.531824428, 104.810052251, 105.109733346, 105.356049617, 105.652355979, 105.842524499, 106.292069678, 106.648033186, 106.905305573, 107.223635627, 107.618579572, 107.861943448, 108.135011176, 108.656808836, 108.831594814, 109.123835698, 109.545925708, 110.078682586, 110.594090879, 110.70289684, 111.106721969, 111.384652871, 111.631411606, 112.034810306, 112.394695675, 112.602290002, 112.907894543, 113.321193556, 113.527685474, 113.897368593, 114.502589489, 114.697635467, 115.247709702, 115.557911125, 115.852670754, 116.15782419, 116.340205967, 116.736946863, 117.064764662, 117.296290215, 117.731589281, 117.99572534, 118.590837052, 119.121000714, 119.674882126, 119.94283508, 120.206253868, 120.568903625, 121.152046212, 121.669182987, 122.041524631, 122.282689094, 122.930683165, 123.305373781, 123.633290883, 123.75835489, 124.020775424, 124.395167247, 124.660960054, 124.954198327, 125.394235156, 125.772752987, 126.557434518, 126.984130884, 127.691528655, 128.026087561, 128.215818381, 128.54131364, 128.77258964, 129.001192447, 129.341240553, 129.622599533, 129.813971222, 130.293562725, 130.384702495, 130.574321962, 130.843467083, 131.033702075, 131.258052909, 131.68693313, 131.883285782, 132.292775992, 133.058643708, 133.249261848, 133.481971694, 134.193959495, 134.713817623, 135.037614873, 135.539057531, 135.994479965, 136.489024963, 136.950885039, 137.359361168, 137.484532801, 137.934388228, 138.496425601, 139.175542225, 139.63351102, 139.741619977, 140.29157909, 140.900792247, 141.245560429, 141.336477477, 142.182582636, 142.743799713, 143.058631215, 143.336977981, 144.311671215, 144.523720381, 144.90157109, 145.104665052, 145.50385202, 146.162794373, 146.178586891, 146.378669443, 146.709680321, 147.05274606, 147.258097714, 147.89210362, 148.102902697, 148.789898309, 149.232782915, 149.881623253, 150.341254166, 150.573994454, 151.019686154, 151.822099327, 152.121611228, 152.260143944, 152.471919011, 152.966004801, 154.264182449, 154.632740822, 155.092632628, 155.522999128, 156.004061191, 156.638640877, 156.870600578, 157.633998329, 157.690945989, 157.800795006, 158.064984162, 158.160621873, 158.912623113, 159.343952879, 159.399939226, 160.244531766, 161.184128851, 161.942322924, 162.074446975, 162.452858883, 162.553329021, 163.052809407, 163.409906359, 163.532849309, 164.246944821, 165.035772344, 165.180417762, 165.653246239, 165.830398044, 165.891048339, 167.250532549, 167.38016672, 167.451886351, 167.510308486, 167.690623347, 168.036271544, 168.214724565, 168.820509427, 168.848688997, 169.824385267, 169.932498326, 170.369996402, 170.41262208, 170.953906206, 170.955586427, 171.55448653, 172.484466894, 173.338413642, 174.974229003, 175.110590676, 175.785117943, 175.874917918, 175.949020007, 176.234487621, 176.591346789, 176.785312131), "50" = c(2.019e-05, 2.0205e-05, 2.0416e-05, 2.0967e-05, 2.1027e-05, 2.1275e-05, 2.1334e-05, 2.1351e-05, 2.2074e-05, 2.2167e-05, 2.2597e-05, 2.278e-05, 2.3539e-05, 2.379e-05, 2.3848e-05, 2.4345e-05, 2.4669e-05, 2.5067e-05, 2.5254e-05, 2.5264e-05, 2.5556e-05, 2.5792e-05, 2.6088e-05, 2.6366e-05, 2.6483e-05, 2.6563e-05, 2.6965e-05, 2.7711e-05, 2.795e-05, 2.8933e-05, 2.9083e-05, 2.9389e-05, 2.9848e-05, 2.9859e-05, 3.0384e-05, 3.049e-05, 3.1071e-05, 3.1636e-05, 3.184e-05, 3.2211e-05, 3.2741e-05, 3.3051e-05, 3.33e-05, 3.3631e-05, 3.4768e-05, 3.5032e-05, 3.5603e-05, 3.5629e-05, 3.5952e-05, 3.6325e-05, 3.6705e-05, 3.7131e-05, 3.7446e-05, 3.7661e-05, 3.8345e-05, 3.8518e-05, 3.9274e-05, 3.9418e-05, 3.9694e-05, 3.9998e-05, 4.0665e-05, 4.0963e-05, 4.0995e-05, 4.1343e-05, 4.1639e-05, 4.198e-05, 4.2451e-05, 4.2566e-05, 4.2852e-05, 4.3271e-05, 4.4095e-05, 4.4522e-05, 4.545e-05, 4.5824e-05, 4.5858e-05, 4.6929e-05, 4.7618e-05, 4.8022e-05, 4.8134e-05, 4.8258e-05, 4.9184e-05, 5.0293e-05, 5.1012e-05, 5.1428e-05, 5.2679e-05, 5.3656e-05, 5.3943e-05, 5.48e-05, 5.5891e-05, 5.6133e-05, 5.6547e-05, 5.6787e-05, 5.7184e-05, 5.8349e-05, 5.9087e-05, 6.0303e-05, 6.143e-05, 6.1937e-05, 6.3259e-05, 6.38e-05, 6.4019e-05, 6.4622e-05, 6.596e-05, 6.6071e-05, 6.6573e-05, 6.7978e-05, 6.8583e-05, 6.9176e-05, 7.0741e-05, 7.2067e-05, 7.2774e-05, 7.3173e-05, 7.3848e-05, 7.4923e-05, 7.583e-05, 7.6872e-05, 7.694e-05, 7.7282e-05, 7.8358e-05, 8.0051e-05, 8.0958e-05, 8.2354e-05, 8.3093e-05, 8.3639e-05, 8.4391e-05, 8.5927e-05, 8.6997e-05, 8.8251e-05, 8.8738e-05, 8.9565e-05, 9.0689e-05, 9.1601e-05, 9.2106e-05, 9.3566e-05, 9.4525e-05, 9.5215e-05, 9.7199e-05, 9.84e-05, 9.9213e-05, 0.000100121, 0.000100739, 0.000102205, 0.000103723, 0.000104641, 0.000105743, 0.000107377, 0.000108245, 0.000109208, 0.000110706, 0.000111803, 0.000112875, 0.000113909, 0.000114563, 0.000115546, 0.000116294, 0.000118463, 0.000119355, 0.000121276, 0.000122472, 0.000124048, 0.000125229, 0.000125731, 0.000127716, 0.000130099, 0.000131506, 0.000132309, 0.000134032, 0.000135349, 0.00013712, 0.000139149, 0.000140299, 0.000142244, 0.000143997, 0.000145688, 0.000147833, 0.000149779, 0.000150872, 0.000153099, 0.000154144, 0.00015662, 0.000159186, 0.000160758, 0.000162182, 0.000164046, 0.000166308, 0.000168828, 0.000170254, 0.000172291, 0.00017385, 0.000175542, 0.000178345, 0.000180074, 0.000182621, 0.000185223, 0.000187768, 0.000189628, 0.000191391, 0.000192906, 0.000194547, 0.000196016, 0.00019728, 0.000199487, 0.000200744, 0.000201849, 0.00020362, 0.000206168, 0.000209615, 0.000212143, 0.000213832, 0.000215601, 0.000218118, 0.000221152, 0.000224171, 0.000229082, 0.00023196, 0.000235318, 0.000237483, 0.000240301, 0.000242489, 0.000246302, 0.000252736, 0.00025492, 0.000257647, 0.000260336, 0.000263194, 0.000265527, 0.000268476, 0.000273399, 0.000276454, 0.000278715, 0.00028274, 0.000285945, 0.000289186, 0.000291918, 0.000294555, 0.000297525, 0.00030007, 0.000303989, 0.00030838, 0.000312336, 0.000315495, 0.000317184, 0.00032051, 0.000324187, 0.000328083, 0.00033244, 0.00033489, 0.00033813, 0.000342433, 0.000345902, 0.000349911, 0.000354133, 0.000357791, 0.000362759, 0.00036559, 0.000370389, 0.000377629, 0.000381676, 0.000386494, 0.000390176, 0.000393593, 0.00039731, 0.000402234, 0.000406789, 0.000410469, 0.000414679, 0.000417982, 0.000421552, 0.000426087, 0.00043005, 0.000436443, 0.000440932, 0.000446794, 0.000450159, 0.000454889, 0.000459879, 0.000464413, 0.000469047, 0.000474044, 0.000478912, 0.000483837, 0.000491975, 0.000499812, 0.000505271, 0.000509994, 0.000514565, 0.000521893, 0.000527558, 0.000533706, 0.000539215, 0.000547162, 0.000553043, 0.000560445, 0.000567965, 0.000577584, 0.000583139, 0.000591322, 0.000599636, 0.000606256, 0.000611444, 0.000617304, 0.000625326, 0.00063197, 0.000640625, 0.00064919, 0.000654672, 0.000661542, 0.000668733, 0.000675739, 0.000683625, 0.000692334, 0.000701286, 0.000711183, 0.00071944, 0.000729635, 0.000736791, 0.00074419, 0.000750555, 0.000761188, 0.00076953, 0.000777571, 0.00078845, 0.000797485, 0.000804767, 0.000811944, 0.00082077, 0.000830016, 0.000840515, 0.000850539, 0.000861607, 0.0008704, 0.000880649, 0.00089128, 0.000904131, 0.000916312, 0.000928041, 0.000936455, 0.000945878, 0.00095837, 0.000973362, 0.000983831, 0.000986457, 0.000997865, 0.001010027, 0.001021199, 0.001033114, 0.001043783, 0.001054089, 0.001065257, 0.001076954, 0.001088244, 0.001102624, 0.001114654, 0.001127719, 0.001142337, 0.001154759, 0.00117152, 0.001186376, 0.001200129, 0.001215598, 0.001229731, 0.001242811, 0.001257455, 0.001270463, 0.001284917, 0.001303007, 0.001318175, 0.001333988, 0.001351157, 0.001365691, 0.001383647, 0.001398886, 0.001413365, 0.001428922, 0.001447756, 0.001468414, 0.001485601, 0.001502279, 0.001521855, 0.00153792, 0.001556678, 0.001575165, 0.001593123, 0.001612234, 0.001631421, 0.001648469, 0.001667297, 0.001686437, 0.001704749, 0.001727203, 0.001747751, 0.001764788, 0.001786623, 0.001804504, 0.001824461, 0.001847478, 0.001867076, 0.001888228, 0.001906468, 0.001925635, 0.001948575, 0.001970081, 0.001994098, 0.002017878, 0.002041074, 0.002065082, 0.002088412, 0.002114554, 0.002135873, 0.00216032, 0.002188545, 0.002216817, 0.002240926, 0.002267331, 0.002292851, 0.002316881, 0.002342883, 0.002371198, 0.002395838, 0.002427362, 0.002457652, 0.002486512, 0.002515326, 0.002543462, 0.002575498, 0.002601825, 0.002630253, 0.002660622, 0.002691821, 0.002721928, 0.002753853, 0.002785027, 0.002817186, 0.002847036, 0.002876844, 0.00290863, 0.00294403, 0.002981901, 0.003018732, 0.003051169, 0.003083025, 0.003126739, 0.003166002, 0.003204325, 0.003240019, 0.003275286, 0.003310562, 0.00334948, 0.003389144, 0.003431512, 0.003471749, 0.003513312, 0.003553074, 0.003595635, 0.003637422, 0.003678817, 0.003718264, 0.003761746, 0.003802768, 0.00384361, 0.003884008, 0.003927128, 0.003973577, 0.004027514, 0.004073117, 0.004123935, 0.004173584, 0.004222091, 0.004273434, 0.004323656, 0.004372338, 0.004422993, 0.004472049, 0.004522206, 0.004577358, 0.004626582, 0.00467467, 0.004734686, 0.004787722, 0.004839646, 0.00489532, 0.004952117, 0.005008494, 0.005067644, 0.005122521, 0.005177938, 0.005234363, 0.005298586, 0.005360208, 0.005424168, 0.005480237, 0.005541287, 0.005601648, 0.005663107, 0.005729266, 0.005795892, 0.005858724, 0.005921718, 0.005989611, 0.006062575, 0.006133056, 0.006209556, 0.006276743, 0.006345358, 0.00642221, 0.006501667, 0.006580791, 0.006647121, 0.006718227, 0.006793842, 0.006876317, 0.006958449, 0.007040752, 0.007119127, 0.007200652, 0.007287408, 0.007377221, 0.007462955, 0.007554616, 0.007645002, 0.007727608, 0.007812044, 0.007904918, 0.007990284, 0.008083001, 0.008182769, 0.008278197, 0.008374989, 0.008475591, 0.008569257, 0.0086686, 0.00877213, 0.008880439, 0.008981845, 0.009081389, 0.009190709, 0.009298055, 0.009407666, 0.009520156, 0.009630344, 0.009735829, 0.009829074, 0.009854459, 0.009971109, 0.010082016, 0.010192336, 0.010311958, 0.010436564, 0.010559461, 0.01068318, 0.010804546, 0.010923772, 0.011049966, 0.011174198, 0.011305745, 0.011427668, 0.011560674, 0.011698991, 0.011845247, 0.011979833, 0.01211508, 0.012262094, 0.012403306, 0.012546504, 0.012687185, 0.012833786, 0.012976501, 0.013121119, 0.013279543, 0.013446275, 0.013610222, 0.013774658, 0.013940335, 0.014106974, 0.014279082, 0.01445019, 0.014613915, 0.014789451, 0.014954726, 0.015112349, 0.015299877, 0.015491741, 0.015676348, 0.015850882, 0.016035657, 0.01621702, 0.01640175, 0.016593356, 0.016788842, 0.016975379, 0.017179957, 0.017371198, 0.017575981, 0.017777139, 0.017975951, 0.018177396, 0.018385431, 0.018611967, 0.018828409, 0.019044306, 0.019268147, 0.01948952, 0.019718585, 0.019940762, 0.020182237, 0.02040204, 0.020625111, 0.020854586, 0.021096072, 0.02133607, 0.021587116, 0.021842935, 0.022101658, 0.022346041, 0.022592346, 0.02285937, 0.023127305, 0.023396694, 0.023670296, 0.023943095, 0.024226516, 0.024502629, 0.024786481, 0.025080325, 0.025372198, 0.025662521, 0.025955196, 0.026260947, 0.02656299, 0.026870854, 0.027196179, 0.027504632, 0.027824485, 0.028154031, 0.028465083, 0.028787331, 0.029114063, 0.02946049, 0.029805179, 0.030147747, 0.030506497, 0.03085849, 0.031224698, 0.031580482, 0.031946636, 0.032312024, 0.032688964, 0.033080968, 0.033474751, 0.033858837, 0.034256236, 0.03465799, 0.035056252, 0.035460665, 0.035879336, 0.036291442, 0.036713613, 0.037143392, 0.037568506, 0.037997038, 0.038452816, 0.038889142, 0.039336507, 0.039797575, 0.040270269, 0.040738851, 0.041201527, 0.041671824, 0.042168853, 0.042642444, 0.043130634, 0.043633223, 0.044142788, 0.04466566, 0.045188869, 0.045713938, 0.046243019, 0.046779246, 0.0473012, 0.047843657, 0.048393645, 0.048939967, 0.049518326, 0.05008889, 0.050657872, 0.051242017, 0.051833437, 0.05243651, 0.053038194, 0.053636275, 0.054250441, 0.05485575, 0.055505535, 0.056125001, 0.056782215, 0.057434922, 0.058109072, 0.058781715, 0.059462804, 0.060154942, 0.060856807, 0.061558963, 0.06226504, 0.062980929, 0.063692469, 0.064436331, 0.065184959, 0.065949201, 0.066723026, 0.067478962, 0.068250581, 0.069057533, 0.069856517, 0.070651543, 0.071464038, 0.072307868, 0.073163538, 0.074019444, 0.074886019, 0.075753024, 0.076602328, 0.077475498, 0.0783897, 0.079281085, 0.080200506, 0.081151792, 0.082099971, 0.083035468, 0.084008478, 0.085004586, 0.0859882, 0.086964651, 0.087980512, 0.089020068, 0.090048608, 0.091125148, 0.092172902, 0.093257448, 0.094325228, 0.095426289, 0.096550719, 0.097694725, 0.098588335, 0.098825885, 0.099976394, 0.101151923, 0.102320207, 0.103494321, 0.104718159, 0.105953669, 0.107185903, 0.108436853, 0.109715266, 0.111028126, 0.112334616, 0.113642614, 0.114965663, 0.116282802, 0.117625703, 0.119017119, 0.120380169, 0.121773836, 0.123181211, 0.124613975, 0.126057113, 0.127503255, 0.128979355, 0.13048784, 0.132041852, 0.133574549, 0.135118359, 0.136649158, 0.138213466, 0.139834582, 0.141472027, 0.143118906, 0.144781297, 0.146485308, 0.148161617, 0.149901371, 0.151629511, 0.153397236, 0.155201614, 0.156999459, 0.1588623, 0.16073841, 0.162630655, 0.164511766, 0.166464898, 0.168401847, 0.170386021, 0.172381462, 0.174415983, 0.176432392, 0.178478142, 0.180567198, 0.182676788, 0.184813853, 0.186982449, 0.189135122, 0.191341016, 0.19362012, 0.195912056, 0.198191857, 0.200491915, 0.202835625, 0.20523448, 0.207653147, 0.210035343, 0.212510834, 0.214980491, 0.217519911, 0.220094051, 0.22262155, 0.225278365, 0.227923194, 0.230612742, 0.233306794, 0.236061468, 0.238822682, 0.241609939, 0.244439204, 0.247310784, 0.250240186, 0.253224473, 0.256232882, 0.259226277, 0.262313694, 0.265369846, 0.268491052, 0.27161151, 0.274777471, 0.278005432, 0.281229269, 0.284548546, 0.287954334, 0.291368837, 0.294836603, 0.298366343, 0.299137766, 0.3018811, 0.305441595, 0.309037614, 0.312674294, 0.316419235, 0.320228187, 0.324070106, 0.327953675, 0.331801264, 0.335769089, 0.339718216, 0.343733789, 0.347865557, 0.352021201, 0.356248815, 0.360474324, 0.364790642, 0.369096523, 0.373532645, 0.378022593, 0.382550627, 0.387094336, 0.391750874, 0.396495955, 0.40124321, 0.402220565, 0.406020387, 0.410945347, 0.415892796, 0.420977009, 0.426048472, 0.431204123, 0.436455595, 0.44177867, 0.447145143, 0.452541706, 0.458067543, 0.463648593, 0.469306223, 0.47505397, 0.480828718, 0.486655393, 0.492566206, 0.498676605, 0.50480208, 0.510982564, 0.517300879, 0.523653378, 0.530090956, 0.536649173, 0.543320049, 0.550056611, 0.556870628, 0.563769291, 0.57082874, 0.57800615, 0.585238626, 0.592581448, 0.599961126, 0.607418736, 0.615033014, 0.618261558, 0.622806081, 0.630665596, 0.638593621, 0.646691172, 0.654835212, 0.663181553, 0.671703182, 0.680239255, 0.688960083, 0.697723261, 0.706688472, 0.715905465, 0.725236579, 0.73463827, 0.744197905, 0.75378801, 0.7636659, 0.773750397, 0.783896406, 0.794162292, 0.804699414, 0.815454584, 0.82633625, 0.837416987, 0.84859961, 0.853247157, 0.860099833, 0.871628583, 0.883427729, 0.895495442, 0.90776317, 0.920179879, 0.932941919, 0.945949612, 0.959147493, 0.97259477, 0.986210538, 1.00004985, 1.014185334, 1.028615517, 1.043322803, 1.058332147, 1.073696355, 1.089373553, 1.105356484, 1.118276445, 1.147661032, 1.164020459, 1.180450911, 1.196750836, 1.212878991, 1.229225917, 1.245395746, 1.261723465, 1.277908044, 1.294037943, 1.310161329, 1.326241806, 1.342205676, 1.358231206, 1.374397167, 1.390360146, 1.40641944, 1.422523054, 1.432032614, 1.438685042, 1.454787126, 1.470909388, 1.487076006, 1.503287203, 1.519514218, 1.535792104, 1.551922922, 1.568079577, 1.584173962, 1.600396208, 1.616577693, 1.632857498, 1.649201794, 1.665351141, 1.681636891, 1.698012009, 1.714318771, 1.730680527, 1.747022947, 1.763442521, 1.779778216, 1.796316106, 1.812868601, 1.829309044, 1.838785356, 1.845827026, 1.86230921, 1.878802198, 1.895452371, 1.912101853, 1.928733429, 1.945538507, 1.962420539, 1.979421551, 1.996462631, 2.013498816, 2.030613433, 2.047837191, 2.065122056, 2.082434233, 2.099795685, 2.117267175, 2.13456954, 2.152320156, 2.170074342, 2.187894106, 2.205518802, 2.223308709, 2.241534133, 2.25968779, 2.277858724, 2.296261799, 2.314498788, 2.333132557, 2.351575097, 2.370333891, 2.389286255, 2.408172581, 2.427147705, 2.446253369, 2.461560209, 2.465594036, 2.484901583, 2.50443451, 2.524351281, 2.544281476, 2.564251508, 2.584523308, 2.604606747, 2.624904791, 2.645436775, 2.666381482, 2.687229888, 2.708409421, 2.729584016, 2.750969357, 2.772609136, 2.794635949, 2.816627952, 2.838299731, 2.860782748, 2.883215686, 2.905730454, 2.92846844, 2.951630185, 2.974981098, 2.993455636, 2.998475671, 3.022387748, 3.046310016, 3.070665678, 3.095533475, 3.120807054, 3.14592327, 3.171031788, 3.196903039, 3.222361075, 3.248646058, 3.274782573, 3.30174249, 3.328530719, 3.355661884, 3.38346905, 3.411378792, 3.439314228, 3.467542328, 3.496344735, 3.52500378, 3.554479529, 3.584258485, 3.613726717, 3.643616307, 3.674388692, 3.704998475, 3.735709567, 3.76778341, 3.799745033, 3.832309362, 3.864371779, 3.896775593, 3.930001549, 3.963691344, 3.997732562, 4.031512831, 4.066013035, 4.100700047, 4.136295332, 4.171473658, 4.207118296, 4.242645009, 4.278634318, 4.31462059, 4.351472655, 4.388591004, 4.42651482, 4.464009973, 4.501888051, 4.540169681, 4.578993857, 4.617579826, 4.656698414, 4.696797048, 4.736354943, 4.776514658, 4.816890641, 4.857257165, 4.898134709, 4.938700998, 4.979694834, 5.02117416, 5.062909223, 5.105412232, 5.147127262, 5.18915082, 5.231975932, 5.275387341, 5.318538881, 5.361979784, 5.406105308, 5.450499386, 5.494745512, 5.540110393, 5.585506041, 5.631138216, 5.677105657, 5.722760031, 5.768741417, 5.815144868, 5.861634109, 5.908812855, 5.955524657, 6.002580338, 6.050448109, 6.098968838, 6.147338268, 6.195223898, 6.243734375, 6.292424748, 6.342672299, 6.39283463, 6.442564422, 6.492266927, 6.542678589, 6.553304998, 6.594018526, 6.644116408, 6.69636615, 6.74820814, 6.800969876, 6.853544109, 6.905761693, 6.958642131, 7.011736455, 7.063905479, 7.117918696, 7.172376666, 7.226015415, 7.281270474, 7.33736543, 7.391992489, 7.447535096, 7.50304389, 7.55831746, 7.614919777, 7.671352282, 7.727474495, 7.782610126, 7.839447888, 7.895729449, 7.952197578, 8.010463926, 8.068968663, 8.127615098, 8.186073522, 8.245363699, 8.305348147, 8.365383973, 8.424933473, 8.485564831, 8.54635179, 8.607510295, 8.668127431, 8.729654648, 8.790350442, 8.852899381, 8.917082577, 8.979831834, 9.043268675, 9.10715488, 9.172802047, 9.237049387, 9.300585061, 9.366996556, 9.433758709, 9.499058873, 9.562536943, 9.627843964, 9.69394471, 9.762830448, 9.827178709, 9.89571097, 9.963212904, 10.030188592, 10.099325481, 10.167546435, 10.235508082, 10.303641906, 10.375561796, 10.446002456, 10.514730578, 10.586345163, 10.656783188, 10.727836073, 10.797960329, 10.869306185, 10.941246923, 11.012923088, 11.085177434, 11.160327386, 11.230405514, 11.3060048, 11.381839478, 11.456490363, 11.528921819, 11.602004267, 11.677406485, 11.754288798, 11.834019485, 11.910024292, 11.987309649, 12.064980787, 12.140495923, 12.21959513, 12.298104837, 12.377282373, 12.458576379, 12.539113037, 12.617735047, 12.701535036, 12.781975083, 12.865860406, 12.946361785, 13.025266016, 13.107410095, 13.187905517, 13.265938039, 13.34784859, 13.427544901, 13.509089895, 13.59253879, 13.675030565, 13.758292714, 13.841978144, 13.926452526, 14.011530072, 14.096842369, 14.183310064, 14.271493005, 14.356937586, 14.44307979, 14.531169948, 14.618772395, 14.7076259, 14.798789238, 14.887280907, 14.9756141, 15.062954441, 15.150753042, 15.240733694, 15.332175828, 15.425775414, 15.520496355, 15.616938465, 15.710324273, 15.802542921, 15.896022834, 15.982838266, 16.07650801, 16.172319582, 16.267809031, 16.364248492, 16.460968264, 16.562365533, 16.659085246, 16.752179578, 16.850410344, 16.947500887, 17.049795686, 17.146470837, 17.249576864, 17.34751568, 17.447677838, 17.545330976, 17.651865113, 17.758939625, 17.863534392, 17.967390846, 18.073659062, 18.173249608, 18.272244134, 18.376164353, 18.480662749, 18.586501152, 18.69270695, 18.797222908, 18.909760403, 19.020031076, 19.123905294, 19.224268228, 19.331424337, 19.436870004, 19.541426705, 19.652450475, 19.761889913, 19.867168517, 19.972835494, 20.086160797, 20.196255773, 20.307269148, 20.416191989, 20.529828013, 20.642827783, 20.753954204, 20.871722199, 20.995331078, 21.104263827, 21.21489194, 21.335694554, 21.450918373, 21.55686499, 21.666760447, 21.779970668, 21.902382162, 22.00810243, 22.124779975, 22.245804573, 22.359751981, 22.483956045, 22.605617556, 22.730061178, 22.853890368, 22.962607397, 23.081863519, 23.200390161, 23.229185027, 23.328817491, 23.454272604, 23.586029129, 23.707075311, 23.82574447, 23.941869964, 24.066879821, 24.197226639, 24.321630377, 24.451009061, 24.570565379, 24.69266521, 24.819263413, 24.948734671, 25.077438309, 25.198194297, 25.338747439, 25.46825159, 25.595711176, 25.717365041, 25.847123961, 25.979722219, 26.107325375, 26.23858713, 26.378887971, 26.510138391, 26.639420733, 26.77631126, 26.907696558, 27.030038178, 27.160051988, 27.299079452, 27.449337052, 27.579224008, 27.722399625, 27.863710572, 27.995880172, 28.133811239, 28.271983745, 28.410577147, 28.571545575, 28.703561428, 28.844019399, 28.999889402, 29.142198269, 29.277164318, 29.42532668, 29.560029115, 29.701749769, 29.845412722, 29.990949578, 30.138327286, 30.275913704, 30.432826493, 30.582521188, 30.732761896, 30.888842588, 31.05472399, 31.206805322, 31.346518717, 31.494540266, 31.629411846, 31.79190212, 31.928149452, 32.086781699, 32.230850768, 32.38588119, 32.542979379, 32.687314462, 32.850935859, 33.004353791, 33.160483977, 33.323579807, 33.475604099, 33.620996621, 33.757968703, 33.915771195, 34.079734014, 34.242759592, 34.386900748, 34.539219174, 34.703639332, 34.85366148, 35.019146, 35.197395684, 35.383732377, 35.553833786, 35.736180127, 35.898790285, 36.092078468, 36.250287438, 36.412574055, 36.584176835, 36.772568106, 36.95145678, 37.134599853, 37.287700903, 37.464970491, 37.626723877, 37.801322621, 37.987248894, 38.159280184, 38.32892814, 38.501615971, 38.686873975, 38.878723867, 39.079412905, 39.257991858, 39.44861108, 39.640068121, 39.814088007, 40.012238217, 40.203860139, 40.38900056, 40.553432292, 40.775508864, 40.949962235, 41.141954456, 41.348395416, 41.546161159, 41.728761042, 41.898837561, 42.099791834, 42.289896716, 42.466387406, 42.659980268, 42.841283443, 43.016813558, 43.197873545, 43.414196983, 43.58423683, 43.757160407, 43.963492429, 44.114584298, 44.333136265, 44.530474856, 44.706820228, 44.906459152, 45.107554433, 45.318101853, 45.481907782, 45.686493016, 45.874588191, 46.064131703, 46.250397328, 46.439016275, 46.633904658, 46.833072302, 47.038167215, 47.203696919, 47.386224783, 47.590636278, 47.780030431, 47.973333609, 48.196272239, 48.383078288, 48.616068148, 48.810610859, 48.99600004, 49.206858779, 49.407206006, 49.611263094, 49.784958123, 49.990156573, 50.185537115, 50.404981107, 50.595744363, 50.859935184, 51.055635924, 51.247828906, 51.423927373, 51.625806476, 51.8375713, 52.040927093, 52.258940981, 52.457244294, 52.686069887, 52.937674746, 53.140272777, 53.393206688, 53.632899563, 53.850245706, 54.089652035, 54.266376605, 54.488288344, 54.71245731, 54.983553496, 55.222554648, 55.450285422, 55.671789559, 55.89384767, 56.079198477, 56.306620894, 56.549688893, 56.799028376, 57.002619111, 57.217730462, 57.446654763, 57.661903139, 57.955889695, 58.013263956, 58.195091998, 58.411827253, 58.675586124, 58.882383256, 59.139542133, 59.362357623, 59.609137833, 59.841876322, 60.031931999, 60.31225422, 60.521416794, 60.747505979, 60.930806652, 61.166597325, 61.395747592, 61.654372888, 61.842287464, 62.108628071, 62.322630855, 62.533100003, 62.791021019, 63.069856924, 63.332797237, 63.612707849, 63.796829863, 64.039997027, 64.324044978, 64.593574802, 64.815242108, 65.086088464, 65.345814855, 65.601629547, 65.823073156, 66.027994955, 66.225033197, 66.540324238, 66.764013702, 67.088103348, 67.382161242, 67.64717566, 67.899594655, 68.113741756, 68.39869876, 68.643600351, 68.93447417, 69.126502545, 69.382181323, 69.63964634, 69.884535833, 70.171274294, 70.419199646, 70.775601506, 70.996800336, 71.173534234, 71.375764377, 71.727002274, 71.997415142, 72.283115015, 72.613503028, 72.911513096, 73.154816727, 73.398500871, 73.639752857, 73.880191077, 74.169666333, 74.43986113, 74.681434294, 74.961173364, 75.274468172, 75.546948457, 75.816196087, 76.012611693, 76.216579817, 76.458326874, 76.626314544, 76.883480262, 77.140592211, 77.426883939, 77.689840637, 77.96771686, 78.233420334, 78.574019966, 78.872274749, 79.126786287, 79.246641878, 79.607247888, 79.847961934, 80.212418598, 80.45224006, 80.731541045, 81.030353276, 81.222252945, 81.508484105, 81.955770046, 82.328901321, 82.652340989, 83.107576065, 83.432473123, 83.617854292, 83.866061774, 84.122204508, 84.278244423, 84.659538859, 84.950686193, 85.251073327, 85.52690369, 85.731738836, 86.106358457, 86.326792226, 86.660267866, 87.078308367, 87.242853687, 87.617322011, 87.849641858, 88.217792146, 88.522702039, 88.788377199, 89.076601867, 89.299948105, 89.722055847, 90.029259956, 90.384101246, 90.635831804, 90.925042732, 91.240603358, 91.471691018, 91.802060329, 92.195688522, 92.508420522, 92.834117224, 93.102390816, 93.359753425, 93.590067441, 93.862030077, 94.393626341, 94.775853636, 94.964898062, 95.340244136, 95.740770569, 96.158286342, 96.293194222, 96.838133001, 97.058510034, 97.382584382, 97.698626546, 97.963019908, 98.158797115, 98.496854009, 98.695505819, 98.938196698, 99.448068893, 99.775985099, 100.137129989, 100.506655626, 100.76165646, 101.009123937, 101.337222539, 101.71602578, 101.966468987, 102.342175987, 102.738282759, 103.278812345, 103.71625785, 104.016329515, 104.328515389, 104.74418731, 105.558513651, 106.032649865, 106.169687827, 106.585181231, 107.07669284, 107.516654738, 107.719881969, 107.995710718, 108.374618611, 108.686222925, 109.011611195, 109.246349146, 109.557211276, 109.955095259, 110.436555104, 111.140469686, 111.251522072, 111.557258393, 111.821977607, 112.377533242, 112.563918941, 113.078999246, 113.266967639, 113.493153052, 113.79451872, 114.016494654, 114.516271962, 114.849115425, 115.228905996, 115.478174546, 115.715688907, 115.861175954, 116.165624709, 116.606972913, 116.928202812, 117.100782759, 117.668705637, 118.165544465, 118.672325476, 118.908869496, 119.409560174, 119.998277567, 120.40854695, 120.663832815, 120.913449786, 121.152295821, 121.539890948, 121.82716221, 122.674972882, 122.995344101, 123.138182321, 123.303640388, 123.508839627, 124.063932583, 124.239657114, 124.584833095, 125.074496234, 125.352673047, 125.528865859, 125.85949649, 126.083210263, 126.214190065, 126.466184688, 126.710877595, 127.314327173, 128.063691959, 128.669197263, 129.030548426, 129.355996268, 129.896928566, 130.321890716, 130.498929634, 131.379276914, 131.70962744, 131.899100531, 132.116289728, 132.204170119, 132.337403009, 132.650638441, 133.581317785, 133.84849024, 134.306377149, 134.630435996, 134.90528433, 135.269906734, 135.75058761, 135.891452841, 136.065011972, 136.809221, 137.366318542, 137.825687805, 138.019182248, 138.303150816, 138.904173617, 139.210909351, 139.431835499, 139.811327395, 140.406700273, 140.846375091, 141.557698364, 141.943003869, 142.634193374, 142.897554909, 143.161553852, 143.497879344, 143.992127334, 144.434422288, 144.719460382, 145.158311782, 145.537956758, 145.715784909, 146.137565229, 147.177112331, 147.620457417, 148.170679611, 148.273362105, 149.453550032, 150.786979716, 151.761124986, 151.975193258, 152.111637244, 152.338572269, 152.52566726, 152.9126127, 153.279203738, 153.882093625, 154.018566471, 154.1564456, 154.237081026, 155.28415731, 155.560639406, 155.640571972, 156.060846946, 156.360826452, 156.538788176, 157.066712895, 157.806475258, 158.407153976, 159.003007, 159.785329768, 160.039781621, 161.039888476, 161.142944264, 161.468406361, 161.66252347, 162.14094407, 162.364007521, 162.490318729, 162.619644464, 163.08779663, 163.410916439, 163.623779739, 164.098744512, 164.196449462, 165.906565417, 165.918403527, 166.126431718, 166.359293923, 166.698406416, 167.133046834, 167.529927369, 168.321726778, 168.805410097, 169.419541702, 169.528177179, 169.603115977, 170.034649233, 170.041649743, 170.135530717, 171.166731181, 171.576821338, 172.736813929, 173.114361229, 173.367993743), "75" = c(1.8209e-05, 1.8358e-05, 1.8595e-05, 1.8845e-05, 1.8975e-05, 1.8984e-05, 1.9016e-05, 1.9259e-05, 1.9486e-05, 1.9643e-05, 1.9892e-05, 2.0345e-05, 2.0628e-05, 2.0633e-05, 2.1077e-05, 2.1952e-05, 2.2248e-05, 2.2447e-05, 2.2561e-05, 2.2641e-05, 2.282e-05, 2.2961e-05, 2.299e-05, 2.34e-05, 2.3692e-05, 2.3727e-05, 2.3851e-05, 2.4299e-05, 2.4405e-05, 2.4899e-05, 2.507e-05, 2.6398e-05, 2.6825e-05, 2.7007e-05, 2.7588e-05, 2.7889e-05, 2.825e-05, 2.8534e-05, 2.8895e-05, 2.9347e-05, 2.9366e-05, 2.9713e-05, 3.0176e-05, 3.0329e-05, 3.1059e-05, 3.154e-05, 3.1955e-05, 3.2221e-05, 3.2644e-05, 3.3042e-05, 3.3167e-05, 3.3424e-05, 3.4031e-05, 3.4534e-05, 3.6139e-05, 3.707e-05, 3.779e-05, 3.8827e-05, 3.9541e-05, 4.0614e-05, 4.119e-05, 4.1238e-05, 4.1263e-05, 4.1697e-05, 4.2633e-05, 4.2807e-05, 4.3634e-05, 4.4122e-05, 4.5485e-05, 4.5822e-05, 4.6302e-05, 4.6463e-05, 4.7353e-05, 4.8224e-05, 4.8441e-05, 4.9122e-05, 4.9863e-05, 5.0651e-05, 5.0882e-05, 5.2099e-05, 5.2871e-05, 5.3077e-05, 5.3194e-05, 5.3979e-05, 5.44e-05, 5.4774e-05, 5.5434e-05, 5.6488e-05, 5.6894e-05, 5.7206e-05, 5.8385e-05, 5.8711e-05, 5.9576e-05, 6.0386e-05, 6.1128e-05, 6.1679e-05, 6.2635e-05, 6.3313e-05, 6.4207e-05, 6.4953e-05, 6.5589e-05, 6.6554e-05, 6.788e-05, 6.8734e-05, 6.9736e-05, 7.0604e-05, 7.1055e-05, 7.2407e-05, 7.3112e-05, 7.345e-05, 7.4273e-05, 7.4897e-05, 7.5803e-05, 7.655e-05, 7.7304e-05, 7.8027e-05, 7.8739e-05, 7.9328e-05, 8.0842e-05, 8.1369e-05, 8.2282e-05, 8.2969e-05, 8.3413e-05, 8.4045e-05, 8.4987e-05, 8.5315e-05, 8.5631e-05, 8.642e-05, 8.7994e-05, 8.9127e-05, 8.9782e-05, 9.2127e-05, 9.2905e-05, 9.3674e-05, 9.4246e-05, 9.4891e-05, 9.6312e-05, 9.7111e-05, 9.8182e-05, 9.8757e-05, 0.000100241, 0.000101603, 0.000102887, 0.000103939, 0.00010481, 0.0001062, 0.000107163, 0.0001074, 0.0001083, 0.000108953, 0.000110116, 0.000111488, 0.000112145, 0.000112867, 0.000114772, 0.000115471, 0.00011636, 0.000117553, 0.000120367, 0.000121003, 0.000122141, 0.000122922, 0.000124501, 0.000125819, 0.000128184, 0.000129041, 0.000130143, 0.000131921, 0.00013404, 0.000135609, 0.000137434, 0.000138335, 0.000140331, 0.000141991, 0.000144433, 0.000146497, 0.000147756, 0.000149652, 0.000151815, 0.000153255, 0.000154405, 0.000155756, 0.000157732, 0.000159797, 0.00016085, 0.00016345, 0.00016678, 0.000168849, 0.000171128, 0.000173241, 0.000174616, 0.000176496, 0.000177661, 0.0001794, 0.000180594, 0.00018324, 0.000185568, 0.000187418, 0.00018905, 0.000190426, 0.000192994, 0.000194505, 0.000196091, 0.000199302, 0.000200963, 0.000203452, 0.000206776, 0.000208346, 0.00021183, 0.000214626, 0.000216146, 0.000218594, 0.000223144, 0.000225564, 0.000228351, 0.000231216, 0.000232935, 0.00023609, 0.000238753, 0.000242563, 0.00024576, 0.000249661, 0.000252239, 0.000254357, 0.000257446, 0.000260258, 0.000263194, 0.000266796, 0.000271683, 0.00027558, 0.000280933, 0.0002836, 0.000286864, 0.00029088, 0.000293586, 0.000297092, 0.000302018, 0.000304347, 0.000306476, 0.000309727, 0.000312121, 0.000314905, 0.000319326, 0.000322143, 0.00032537, 0.000329516, 0.000332285, 0.000335477, 0.000338738, 0.000343615, 0.000347261, 0.000350993, 0.00035489, 0.00035796, 0.000361577, 0.000364868, 0.000368124, 0.000372072, 0.000376801, 0.000381117, 0.000385449, 0.000389568, 0.000395624, 0.000400479, 0.000406477, 0.000409348, 0.000414134, 0.000417686, 0.000422739, 0.000428939, 0.00043483, 0.000438978, 0.00044368, 0.000447884, 0.000452944, 0.00045863, 0.000464167, 0.000469564, 0.000475943, 0.000481879, 0.000488077, 0.000493646, 0.000499456, 0.000505542, 0.000510833, 0.000516672, 0.000524122, 0.000530081, 0.000537184, 0.000543616, 0.00054903, 0.000555146, 0.000562827, 0.000568957, 0.000575447, 0.000581738, 0.000590355, 0.000597067, 0.000602745, 0.000609943, 0.000616543, 0.000622768, 0.000629051, 0.000636296, 0.000644788, 0.000651431, 0.00065975, 0.000667505, 0.000676204, 0.000684367, 0.000691226, 0.000700118, 0.000707285, 0.000718799, 0.000730087, 0.000736719, 0.000743694, 0.000754704, 0.000765657, 0.00077262, 0.000781369, 0.000788502, 0.000797208, 0.000806223, 0.000817279, 0.000827593, 0.000837212, 0.000847842, 0.000859441, 0.000870424, 0.000881582, 0.000891865, 0.000900259, 0.000909138, 0.000917939, 0.000928429, 0.000940948, 0.000951801, 0.000962542, 0.00097281, 0.000980746, 0.000983438, 0.000995566, 0.00100667, 0.001018491, 0.001029957, 0.00104087, 0.001051583, 0.001067963, 0.001079373, 0.001092534, 0.001106844, 0.001119831, 0.001131053, 0.001142726, 0.00115765, 0.001173307, 0.00118404, 0.001197976, 0.001213841, 0.001226223, 0.001240792, 0.001258141, 0.001270767, 0.00128509, 0.001298669, 0.001310963, 0.001324475, 0.001338006, 0.001351257, 0.001366754, 0.001382734, 0.001401566, 0.001417831, 0.001436156, 0.001453497, 0.001469923, 0.001487274, 0.00150751, 0.00152247, 0.00153929, 0.001555941, 0.001571556, 0.001589423, 0.001605776, 0.001624971, 0.001643278, 0.001662343, 0.001684805, 0.001702351, 0.001723984, 0.001746558, 0.001766554, 0.00178634, 0.001806953, 0.001825658, 0.001847151, 0.001869745, 0.001893413, 0.001914612, 0.001934095, 0.001953136, 0.001976794, 0.001995929, 0.002019236, 0.002040252, 0.002061997, 0.00208561, 0.002108347, 0.002131309, 0.002158775, 0.002185866, 0.002211248, 0.002237469, 0.002263212, 0.002290097, 0.002314808, 0.002341747, 0.00236629, 0.002393074, 0.002419411, 0.002448152, 0.002477594, 0.002504078, 0.002535949, 0.002567649, 0.002593114, 0.0026226, 0.0026539, 0.002681041, 0.002712663, 0.002744175, 0.002772973, 0.002804142, 0.002834663, 0.002868875, 0.002905541, 0.002941829, 0.002972421, 0.003004403, 0.003040666, 0.003073111, 0.003109522, 0.003147188, 0.00318628, 0.003223647, 0.003258683, 0.003296016, 0.003329591, 0.003368827, 0.003407368, 0.003442325, 0.003483133, 0.003521489, 0.003561483, 0.003600918, 0.003642232, 0.003685098, 0.003727781, 0.003772552, 0.003813257, 0.003852405, 0.003895134, 0.003944163, 0.003993108, 0.004042176, 0.004087417, 0.004132161, 0.004182091, 0.004229945, 0.004282899, 0.004327777, 0.004381896, 0.004435419, 0.004486858, 0.00453835, 0.004587396, 0.004643133, 0.004697991, 0.004752347, 0.004807964, 0.004860343, 0.004912878, 0.004971717, 0.005027785, 0.005086806, 0.005147312, 0.005205217, 0.005270105, 0.005332397, 0.005396119, 0.005453283, 0.005516801, 0.005583042, 0.005646586, 0.005714503, 0.005778433, 0.005842576, 0.005912496, 0.005976558, 0.006046083, 0.006110896, 0.006180662, 0.006256144, 0.006320255, 0.006394294, 0.006469572, 0.006556447, 0.006631952, 0.006706346, 0.006785633, 0.006867494, 0.006948544, 0.007028668, 0.007111222, 0.007194139, 0.007273466, 0.007365966, 0.007456298, 0.007537812, 0.007625499, 0.007721537, 0.007815314, 0.007902847, 0.007992783, 0.00808695, 0.008182568, 0.008274713, 0.00836983, 0.008466153, 0.008555319, 0.008656258, 0.008759551, 0.008857032, 0.008954869, 0.009069621, 0.009171844, 0.009279351, 0.009388548, 0.009503001, 0.009611676, 0.009705323, 0.009725512, 0.009831866, 0.009943281, 0.010050742, 0.010167536, 0.010287974, 0.010420793, 0.010537934, 0.010654138, 0.010775616, 0.010892855, 0.011015208, 0.011136739, 0.011262669, 0.011398287, 0.011522628, 0.011659548, 0.011793156, 0.011927567, 0.012058741, 0.012193749, 0.012336499, 0.012480777, 0.012624995, 0.012774382, 0.012923971, 0.013080718, 0.013227255, 0.013373483, 0.01352752, 0.013686408, 0.013843372, 0.014005478, 0.014165016, 0.01433344, 0.014501415, 0.014665907, 0.014843232, 0.015022472, 0.015198322, 0.015368289, 0.015547129, 0.015734833, 0.015913916, 0.016096434, 0.016288053, 0.01648043, 0.016657719, 0.016861903, 0.017060612, 0.017257382, 0.017458803, 0.017663088, 0.017875744, 0.018082364, 0.018297807, 0.018516931, 0.018734564, 0.018950813, 0.019165184, 0.019381779, 0.019596919, 0.0198221, 0.020051345, 0.020283417, 0.020526649, 0.020767427, 0.021011533, 0.021259273, 0.021499816, 0.021750506, 0.021997156, 0.022263522, 0.02251955, 0.022771712, 0.023027473, 0.02329574, 0.023572599, 0.0238611, 0.024132474, 0.024423853, 0.024713213, 0.025007192, 0.025285099, 0.025570107, 0.025854399, 0.026139919, 0.026450642, 0.026750809, 0.027056901, 0.027369447, 0.027686566, 0.0280112, 0.028334473, 0.028670597, 0.029020824, 0.029366381, 0.029717523, 0.030053876, 0.030418594, 0.030765126, 0.031129199, 0.0314916, 0.031862319, 0.032228778, 0.032594581, 0.032971976, 0.033364999, 0.03375905, 0.034158006, 0.034560072, 0.034952103, 0.035356497, 0.035772058, 0.036189038, 0.036608262, 0.03703296, 0.037470208, 0.037900245, 0.038338367, 0.038793272, 0.039245729, 0.039690489, 0.04014047, 0.04060804, 0.041069827, 0.041540644, 0.042046353, 0.042537979, 0.043037598, 0.043526439, 0.044021293, 0.044549004, 0.045048404, 0.045587785, 0.046121267, 0.046671876, 0.047208008, 0.04775404, 0.048289526, 0.04886904, 0.049450655, 0.050011345, 0.050593458, 0.051212101, 0.051815751, 0.052420298, 0.053040891, 0.053652957, 0.054296226, 0.054930164, 0.055578928, 0.056233111, 0.056882915, 0.057542318, 0.058221232, 0.05889295, 0.059584029, 0.06029178, 0.060992831, 0.061719016, 0.062446732, 0.063162001, 0.063922656, 0.064676632, 0.065426584, 0.066197884, 0.066974644, 0.067762881, 0.068551557, 0.069350287, 0.070135562, 0.070954051, 0.071776225, 0.072620064, 0.073473578, 0.074342041, 0.075210557, 0.07608673, 0.076973962, 0.077870805, 0.078769338, 0.079697353, 0.08061394, 0.081562918, 0.082509665, 0.083477014, 0.084435753, 0.085400907, 0.086393829, 0.087390137, 0.088409441, 0.089458632, 0.090508247, 0.091579829, 0.092640506, 0.093731129, 0.094852477, 0.095952482, 0.097072379, 0.097964457, 0.098201534, 0.099341076, 0.100509767, 0.101713823, 0.102904584, 0.104105727, 0.105327133, 0.106575237, 0.107832932, 0.109092855, 0.110345798, 0.111637774, 0.112933263, 0.11425739, 0.115595088, 0.116938802, 0.118307762, 0.119709125, 0.121112734, 0.122520632, 0.123929965, 0.125377851, 0.126827128, 0.128300375, 0.129811467, 0.131342677, 0.132869569, 0.134419975, 0.136015991, 0.137602408, 0.139193988, 0.140817598, 0.142491197, 0.144150489, 0.145862943, 0.14755778, 0.149315189, 0.151102712, 0.152856271, 0.154659404, 0.156474048, 0.158285836, 0.160143439, 0.162001354, 0.163929702, 0.165843246, 0.167822765, 0.169804134, 0.171807259, 0.173823377, 0.175905066, 0.177967484, 0.180106201, 0.182215309, 0.184372179, 0.186569749, 0.188806861, 0.190995496, 0.19324511, 0.195577572, 0.197924431, 0.200268507, 0.202641804, 0.205021261, 0.20744692, 0.209928246, 0.212391455, 0.214875364, 0.217461202, 0.220049915, 0.222676123, 0.225290871, 0.227967772, 0.230678246, 0.233415559, 0.236224426, 0.239043453, 0.241870895, 0.244738529, 0.247687795, 0.250689288, 0.253680523, 0.25670441, 0.259744662, 0.262867688, 0.266028492, 0.269220539, 0.27244601, 0.275716591, 0.279031205, 0.282381191, 0.285772514, 0.289207871, 0.292642262, 0.296188788, 0.299757843, 0.300548528, 0.303404921, 0.30704805, 0.310743352, 0.314515441, 0.318301876, 0.322166027, 0.326094918, 0.329992448, 0.333956971, 0.338016755, 0.34216987, 0.346306501, 0.35050006, 0.354729422, 0.359046304, 0.363384846, 0.36774712, 0.3722477, 0.376776538, 0.381332539, 0.386049716, 0.390777495, 0.395548472, 0.400447644, 0.405369419, 0.406402025, 0.410354489, 0.415450448, 0.42060558, 0.425849448, 0.431071201, 0.43640345, 0.441821473, 0.447362758, 0.452925482, 0.45853981, 0.464233822, 0.469984177, 0.475898695, 0.481820761, 0.487806738, 0.493916992, 0.500083429, 0.506348127, 0.512781878, 0.519175607, 0.525691558, 0.532232556, 0.538921631, 0.545727666, 0.552648067, 0.55962564, 0.566769163, 0.574040408, 0.581344226, 0.588778745, 0.596302746, 0.603964616, 0.611760845, 0.619510527, 0.627542045, 0.630937479, 0.635592839, 0.643811069, 0.652090033, 0.660536191, 0.669237722, 0.678002852, 0.686921521, 0.6958268, 0.704905439, 0.714223795, 0.72370052, 0.733276446, 0.742994173, 0.752871948, 0.762897065, 0.773071609, 0.783463282, 0.794061287, 0.804811005, 0.815757311, 0.826785213, 0.838040552, 0.849555766, 0.861259704, 0.87315773, 0.878065251, 0.885186324, 0.897512756, 0.910102704, 0.922768182, 0.935775566, 0.949002143, 0.962515411, 0.976170001, 0.990154511, 1.004441002, 1.018976185, 1.033810491, 1.048958559, 1.064283846, 1.079987859, 1.096060668, 1.112487295, 1.129326882, 1.146574464, 1.160445004, 1.191919324, 1.209372977, 1.226845118, 1.244281568, 1.261659876, 1.279229691, 1.296695401, 1.314097158, 1.331465028, 1.348875436, 1.366139801, 1.383412344, 1.400702726, 1.417937779, 1.435356445, 1.452643622, 1.470012259, 1.487264251, 1.497450564, 1.504509134, 1.521702347, 1.539071316, 1.556339335, 1.573577304, 1.590810444, 1.608094458, 1.625567124, 1.642782158, 1.660030598, 1.67723626, 1.694557683, 1.711923057, 1.729349994, 1.746885701, 1.764407816, 1.781890256, 1.799371332, 1.816880647, 1.834391532, 1.851973254, 1.869567437, 1.887044013, 1.904711718, 1.922385523, 1.932547799, 1.940102804, 1.957846271, 1.975620608, 1.993539463, 2.011264185, 2.029033551, 2.047026763, 2.064880134, 2.082726477, 2.100669735, 2.118726991, 2.136689988, 2.154806695, 2.17315354, 2.191428602, 2.209933002, 2.228328905, 2.246841141, 2.26552183, 2.284213929, 2.302888518, 2.321733987, 2.340537653, 2.359510467, 2.378234426, 2.397211544, 2.416392532, 2.435595798, 2.454965227, 2.474064991, 2.493537387, 2.513288958, 2.532838582, 2.552457238, 2.572379341, 2.588089316, 2.592202859, 2.61243664, 2.63261092, 2.652630575, 2.672868122, 2.693301353, 2.713612861, 2.734274068, 2.755008069, 2.775752077, 2.796729773, 2.817743725, 2.83877383, 2.860096482, 2.881452323, 2.902964544, 2.924669414, 2.946813128, 2.968694573, 2.990861741, 3.012897854, 3.03528377, 3.057663163, 3.080302146, 3.103319593, 3.121543415, 3.126508971, 3.149678316, 3.173329761, 3.196779226, 3.220669257, 3.244684839, 3.269037798, 3.293622245, 3.318190542, 3.343092455, 3.368193024, 3.393675425, 3.418789213, 3.444443201, 3.470080507, 3.496359765, 3.522821579, 3.548891213, 3.575207422, 3.602176054, 3.629367867, 3.65683497, 3.68457476, 3.712845929, 3.740917839, 3.769203326, 3.797510577, 3.826200645, 3.855194991, 3.884484747, 3.914073063, 3.943879219, 3.974408307, 4.004282869, 4.034875954, 4.066354418, 4.097371377, 4.128695993, 4.1600797, 4.19253721, 4.22470417, 4.257484573, 4.290775072, 4.324579452, 4.358018252, 4.391247593, 4.425188169, 4.459351299, 4.493511793, 4.528132167, 4.563168989, 4.598868451, 4.634499869, 4.670373586, 4.705908242, 4.742462814, 4.778792822, 4.815770356, 4.85275991, 4.890100906, 4.927356557, 4.965162751, 5.003401443, 5.041401564, 5.080080519, 5.119401048, 5.158942436, 5.198289711, 5.237685871, 5.277948549, 5.317805083, 5.358410016, 5.398834599, 5.439629729, 5.480951975, 5.522130396, 5.563668472, 5.605920014, 5.648803103, 5.692456682, 5.735564607, 5.779189807, 5.8220187, 5.865351768, 5.908886283, 5.952360706, 5.996611388, 6.041258903, 6.08544067, 6.131433118, 6.176874267, 6.221492379, 6.265415028, 6.311295886, 6.357968626, 6.40465048, 6.414448645, 6.451014598, 6.498563339, 6.546141057, 6.593393883, 6.640314733, 6.687799851, 6.735116619, 6.784281433, 6.832543656, 6.881884679, 6.931261623, 6.980186951, 7.030937217, 7.079258239, 7.129949421, 7.181707482, 7.232551193, 7.283565483, 7.335043097, 7.386912463, 7.43746725, 7.488450509, 7.540758909, 7.593169162, 7.645501103, 7.69703803, 7.750038173, 7.804118575, 7.858346217, 7.911086545, 7.96517272, 8.02042631, 8.076060684, 8.131035978, 8.186655349, 8.240487751, 8.296698718, 8.352038488, 8.410008291, 8.465849742, 8.522965471, 8.578244388, 8.63457062, 8.690840262, 8.749025447, 8.805081189, 8.86252695, 8.921324861, 8.981771027, 9.038123372, 9.095093989, 9.152921685, 9.213846321, 9.273190647, 9.332211436, 9.394243357, 9.454306924, 9.514819665, 9.576033798, 9.639634888, 9.701459228, 9.762013374, 9.824436304, 9.888852969, 9.953750125, 10.016785766, 10.080221859, 10.145598187, 10.212625501, 10.275339238, 10.339237172, 10.405209369, 10.468222157, 10.533534823, 10.598107802, 10.662540413, 10.728495724, 10.794875871, 10.859869366, 10.926429558, 10.994766673, 11.062150743, 11.130684002, 11.20039583, 11.270132011, 11.338996132, 11.407757522, 11.479850258, 11.548726068, 11.616260212, 11.687582845, 11.756759988, 11.827487689, 11.899654102, 11.970475962, 12.045045956, 12.117944479, 12.190759113, 12.265784447, 12.337665908, 12.412453749, 12.487755745, 12.558513236, 12.630304005, 12.703465837, 12.7802537, 12.853333775, 12.926211091, 13.003419358, 13.083700373, 13.159079242, 13.236353333, 13.31268431, 13.391201099, 13.46784636, 13.546357213, 13.623796586, 13.70008304, 13.779906833, 13.857349337, 13.93588803, 14.014943562, 14.096881632, 14.173679669, 14.254448161, 14.33038347, 14.411931829, 14.495159986, 14.578858381, 14.662825102, 14.744792836, 14.82670875, 14.91429547, 14.996403528, 15.07667691, 15.161991714, 15.252356336, 15.338831795, 15.424946902, 15.50632982, 15.59292541, 15.678697721, 15.766528144, 15.85640411, 15.944389489, 16.032153897, 16.121342753, 16.207011689, 16.297181648, 16.38776141, 16.472206898, 16.56185599, 16.651248428, 16.745149389, 16.83843384, 16.932784863, 17.022796321, 17.119759701, 17.219046539, 17.307433287, 17.395548794, 17.487700308, 17.580898771, 17.674084945, 17.772625616, 17.867943499, 17.956172338, 18.057518464, 18.160555814, 18.256335841, 18.347090214, 18.445782853, 18.544262725, 18.63873842, 18.741796974, 18.845503282, 18.938574795, 19.040432312, 19.138586266, 19.233860211, 19.330831603, 19.428621442, 19.534302634, 19.635999178, 19.734399095, 19.839814369, 19.943141348, 20.049125943, 20.148494615, 20.245182057, 20.351349058, 20.456861228, 20.567819726, 20.672598151, 20.779623416, 20.888068427, 20.993195211, 21.096552866, 21.204740573, 21.312256003, 21.333924869, 21.423039034, 21.528863991, 21.631734233, 21.728797768, 21.838600661, 21.946920278, 22.061648426, 22.167613938, 22.273926199, 22.395074726, 22.501123518, 22.609542174, 22.717862372, 22.836833068, 22.948838218, 23.067905723, 23.179842124, 23.293301006, 23.403957458, 23.518336114, 23.631660115, 23.743037947, 23.857283032, 23.979005147, 24.091383601, 24.203636288, 24.320197499, 24.444638741, 24.571321971, 24.684898462, 24.797546338, 24.907696977, 25.034094425, 25.152548681, 25.273103678, 25.395236072, 25.528804541, 25.638819484, 25.769004677, 25.884008235, 25.997167191, 26.115346842, 26.227453484, 26.338522948, 26.468604894, 26.595613021, 26.717997476, 26.848805838, 26.986031708, 27.108755125, 27.244104805, 27.369431021, 27.513268205, 27.653894213, 27.781524731, 27.909038448, 28.040556524, 28.166113302, 28.290329297, 28.419710183, 28.549340373, 28.681572947, 28.818640296, 28.941932245, 29.07204936, 29.200178493, 29.337812515, 29.469524345, 29.601581123, 29.726207553, 29.849300516, 29.979348722, 30.11008238, 30.234714973, 30.376084008, 30.497922793, 30.633158902, 30.778205959, 30.910981776, 31.04842856, 31.179571136, 31.331294238, 31.472103385, 31.599134862, 31.740162775, 31.875439537, 32.013388812, 32.140550281, 32.28425395, 32.434005091, 32.571660875, 32.717762521, 32.867454242, 32.999253951, 33.145492345, 33.311219581, 33.444267939, 33.613546135, 33.778490176, 33.931689709, 34.081554534, 34.230612542, 34.383303307, 34.537522421, 34.705861764, 34.849273263, 35.012521122, 35.170883037, 35.337746999, 35.504600548, 35.661705591, 35.829051995, 35.991783124, 36.148844671, 36.303007401, 36.469257458, 36.622006651, 36.786963241, 36.958462097, 37.139263655, 37.286589283, 37.44795492, 37.602378946, 37.746851777, 37.909340708, 38.056488316, 38.228535231, 38.370671446, 38.526201997, 38.67362326, 38.833034461, 38.982522461, 39.133022676, 39.291371776, 39.433407386, 39.625010528, 39.780401775, 39.943582568, 40.106462974, 40.265451154, 40.441465986, 40.621906039, 40.765672289, 40.928891851, 41.065404182, 41.237857735, 41.402345626, 41.57042902, 41.748819579, 41.954029178, 42.141957786, 42.311822701, 42.488029712, 42.679327567, 42.845754667, 42.996298863, 43.19942955, 43.355474143, 43.542617843, 43.711343125, 43.877996255, 44.013338068, 44.164955521, 44.352878754, 44.570268569, 44.726686011, 44.931862213, 45.137161974, 45.355106755, 45.533617863, 45.743479608, 45.943534577, 46.137783808, 46.327690356, 46.498164823, 46.729438398, 46.94005661, 47.128413935, 47.299936715, 47.491864208, 47.695297751, 47.860920329, 48.05450139, 48.222039178, 48.413566081, 48.632790614, 48.866861504, 49.031384245, 49.248830156, 49.427340509, 49.632737843, 49.866839942, 50.034958677, 50.227452412, 50.420133641, 50.606405855, 50.851737147, 51.033967013, 51.220022225, 51.383812545, 51.412590707, 51.584768363, 51.793253809, 51.981775983, 52.18059352, 52.419303766, 52.680054338, 52.881236143, 53.083332567, 53.287725074, 53.484021235, 53.707952213, 53.902501871, 54.171602671, 54.367330308, 54.577247166, 54.791125607, 55.034589736, 55.199706481, 55.504680329, 55.739737409, 55.881983065, 56.061306789, 56.257981376, 56.469989991, 56.667093756, 56.902999371, 57.120706526, 57.388879106, 57.588072291, 57.774327907, 58.034546492, 58.257361347, 58.499627191, 58.665231733, 58.903875938, 59.068591999, 59.331640232, 59.59891297, 59.852743397, 60.095377277, 60.336085388, 60.616277046, 60.87670842, 61.130402551, 61.344660424, 61.592131808, 61.828741334, 62.014295261, 62.25849466, 62.486908431, 62.666434124, 62.88308536, 63.160095611, 63.30195569, 63.521508568, 63.794651377, 64.046969358, 64.242529395, 64.424866796, 64.680201719, 64.841233258, 65.101885797, 65.430784567, 65.699693818, 65.914932732, 66.10013208, 66.337089003, 66.554217329, 66.737388189, 66.924812082, 67.191845469, 67.373396074, 67.654250349, 67.822270291, 67.988302537, 68.316997837, 68.532218883, 68.731274497, 68.974300134, 69.170073195, 69.427940594, 69.724558577, 70.013121415, 70.221567567, 70.401102032, 70.603774652, 70.8029222, 71.032380609, 71.237046756, 71.556353115, 71.957864437, 72.158432553, 72.390350177, 72.673183779, 72.908713318, 73.118441779, 73.449990639, 73.745602563, 73.962503297, 74.230535031, 74.414504787, 74.675638418, 74.852151796, 75.210934335, 75.527064654, 75.728301186, 76.003644239, 76.199978853, 76.462854301, 76.652718435, 76.860784292, 77.19629523, 77.566595624, 77.866918526, 78.261408882, 78.54316052, 78.841946779, 79.18179811, 79.493847943, 79.791090943, 79.953072464, 80.461991677, 80.75749843, 81.004045254, 81.249533685, 81.411426191, 81.771852894, 82.12384154, 82.323479345, 82.636618117, 82.941961363, 83.363029317, 83.596675405, 83.871213496, 84.157037636, 84.413573179, 84.685586188, 85.115006391, 85.443223563, 85.696174931, 85.825915339, 86.027608243, 86.378842569, 86.68734833, 86.878211831, 87.179844612, 87.481498786, 87.730569121, 88.10327244, 88.346254718, 88.725454093, 88.991925784, 89.373420139, 89.640224596, 90.000401389, 90.428242912, 90.654743899, 90.932248147, 91.143774286, 91.462434799, 91.803206817, 91.998159496, 92.326679894, 92.733522583, 93.046938964, 93.350857294, 93.572884047, 93.836150594, 94.200595473, 94.434116252, 94.895158325, 95.097075978, 95.585855113, 95.952748123, 96.298747757, 96.734245729, 96.959600476, 97.326333153, 97.74323943, 98.059616368, 98.211484432, 98.34865051, 98.677349857, 98.972340143, 99.393307159, 99.859871659, 100.120892154, 100.341315649, 100.542263718, 100.884989985, 101.209652637, 101.494645106, 102.01792074, 102.531202599, 102.852517962, 103.145958904, 103.593121992, 103.739777823, 104.081820536, 104.304192262, 104.679931707, 104.939346016, 105.157818389, 105.574176705, 106.220991213, 106.605145597, 106.868605872, 107.083617821, 107.471452485, 107.877856029, 108.045994456, 108.349528324, 108.56177967, 109.054125635, 109.327054305, 109.502323685, 109.897114907, 110.664880229, 111.000497994, 111.253280957, 111.506870445, 112.220381101, 112.516873859, 112.946147213, 113.163092471, 113.715504408, 114.019605, 114.605068717, 114.775355308, 114.861644549, 115.053893952, 115.24237858, 115.387284944, 115.956221007, 116.046435335, 116.566491796, 116.973471041, 117.280988567, 117.631935704, 117.958298681, 118.182900985, 118.638072007, 118.911506259, 119.04184583, 119.73271414, 120.566878209, 120.968571472, 121.598199692, 121.920499304, 122.497426345, 123.006710012, 123.228803912, 123.729878752, 124.061621816, 124.343555335, 124.456428003, 124.690555015, 125.503325047, 125.740359182, 125.884879381, 126.721358459, 127.102857763, 127.523346739, 127.796053194, 128.099269351, 128.270418922, 128.5038192, 129.105458953, 129.459765672, 129.678612501, 130.394600773, 131.16848018, 131.525039246, 131.6963765, 132.232038619, 132.511170688, 133.771679732, 134.716874656, 135.134554139, 135.530753077, 135.953787819, 136.297396611, 136.987373535, 137.381437802, 138.244585679, 138.382736579, 139.214249305, 140.001275516, 140.941763139, 141.136300375, 141.589193846, 141.870084565, 142.120332494, 142.332948588, 142.742126237, 143.186477971, 144.332316837, 144.518526615, 145.66070562, 147.13773539, 147.322039686, 147.642162434, 147.935372929, 148.694068888, 148.771569971, 148.925469098, 149.034911642, 149.129365377, 149.24072046, 149.560597049, 149.708982929, 150.334315906, 151.090898581, 151.121089253, 152.091815628, 152.104337605, 152.857317674, 153.070094619, 154.039484412, 154.171415905, 154.66542309, 155.669673599, 155.780557184, 156.179207475, 156.740731425, 156.965143864, 157.248451124, 157.278619943, 158.125477862, 158.437160821, 158.476637147, 159.015198749, 159.221400347, 159.780332745, 159.826486461, 159.90542881, 160.844455667, 161.510348581, 161.537187694, 161.716769583), "100" = c(1.9123e-05, 1.9736e-05, 1.9952e-05, 2.0636e-05, 2.0833e-05, 2.1049e-05, 2.1131e-05, 2.1634e-05, 2.2694e-05, 2.2743e-05, 2.3126e-05, 2.362e-05, 2.3687e-05, 2.3859e-05, 2.4541e-05, 2.4736e-05, 2.5204e-05, 2.554e-05, 2.5815e-05, 2.6004e-05, 2.6578e-05, 2.6893e-05, 2.7228e-05, 2.7514e-05, 2.7789e-05, 2.7903e-05, 2.8467e-05, 2.8575e-05, 2.8726e-05, 2.9109e-05, 2.9279e-05, 2.9874e-05, 3.0426e-05, 3.049e-05, 3.1097e-05, 3.1635e-05, 3.234e-05, 3.3326e-05, 3.3606e-05, 3.4237e-05, 3.4386e-05, 3.4627e-05, 3.4792e-05, 3.4833e-05, 3.4958e-05, 3.5527e-05, 3.6286e-05, 3.6837e-05, 3.7093e-05, 3.7321e-05, 3.7355e-05, 3.7483e-05, 3.7763e-05, 3.8108e-05, 3.8205e-05, 3.8293e-05, 3.8877e-05, 3.9397e-05, 3.9723e-05, 3.9914e-05, 4.0052e-05, 4.0103e-05, 4.0897e-05, 4.1775e-05, 4.2192e-05, 4.258e-05, 4.3222e-05, 4.3455e-05, 4.3676e-05, 4.3895e-05, 4.4154e-05, 4.4725e-05, 4.5157e-05, 4.553e-05, 4.5852e-05, 4.6142e-05, 4.6896e-05, 4.7973e-05, 4.8088e-05, 4.9365e-05, 4.9703e-05, 5.0113e-05, 5.0681e-05, 5.224e-05, 5.248e-05, 5.4033e-05, 5.4703e-05, 5.5175e-05, 5.6291e-05, 5.7562e-05, 5.8735e-05, 5.9062e-05, 5.9322e-05, 5.9656e-05, 5.9818e-05, 6.0815e-05, 6.1705e-05, 6.2042e-05, 6.2381e-05, 6.2936e-05, 6.3332e-05, 6.3835e-05, 6.4751e-05, 6.5128e-05, 6.5633e-05, 6.624e-05, 6.6896e-05, 6.7665e-05, 6.8232e-05, 6.9476e-05, 7.0098e-05, 7.0734e-05, 7.1626e-05, 7.2225e-05, 7.3412e-05, 7.4465e-05, 7.6432e-05, 7.7738e-05, 7.8472e-05, 8.0004e-05, 8.0352e-05, 8.1719e-05, 8.2535e-05, 8.3804e-05, 8.4997e-05, 8.6929e-05, 8.7507e-05, 8.8777e-05, 9.0586e-05, 9.1215e-05, 9.1547e-05, 9.2228e-05, 9.2981e-05, 9.4217e-05, 9.4445e-05, 9.5717e-05, 9.6896e-05, 9.7878e-05, 9.9746e-05, 0.000100579, 0.000101858, 0.000102555, 0.000103623, 0.000105202, 0.000106517, 0.000107988, 0.000109884, 0.00011022, 0.000111651, 0.000113622, 0.000114348, 0.000116007, 0.00011761, 0.00011986, 0.000121414, 0.00012394, 0.000125299, 0.00012678, 0.000129606, 0.000130116, 0.000131909, 0.000133311, 0.000134832, 0.000135912, 0.000138205, 0.000138976, 0.000139919, 0.000141929, 0.000142882, 0.000143994, 0.000145668, 0.000146902, 0.000149005, 0.000151125, 0.000152102, 0.000153419, 0.000155524, 0.000157266, 0.000158737, 0.000159652, 0.000161895, 0.000163563, 0.000164985, 0.000166591, 0.000167898, 0.00016985, 0.00017229, 0.00017411, 0.000175558, 0.000177782, 0.000179258, 0.000181096, 0.00018321, 0.000184826, 0.000186249, 0.00018785, 0.000190313, 0.000192498, 0.000194745, 0.000197116, 0.000199871, 0.00020106, 0.000203148, 0.000204865, 0.000208034, 0.000208694, 0.000210388, 0.000212994, 0.00021677, 0.000218258, 0.000219863, 0.000222198, 0.000225352, 0.000227863, 0.00023057, 0.00023452, 0.000237159, 0.000239998, 0.000244228, 0.000246669, 0.000248932, 0.000252597, 0.000255055, 0.000258993, 0.000261771, 0.000264088, 0.000266675, 0.000270702, 0.000275055, 0.0002782, 0.000280691, 0.000283919, 0.00028632, 0.000289595, 0.000293073, 0.000297494, 0.000302661, 0.000307915, 0.000311205, 0.000314912, 0.000318602, 0.000322669, 0.000327312, 0.000331092, 0.000335333, 0.000338742, 0.000341412, 0.000344957, 0.000349583, 0.000352737, 0.000356837, 0.000360053, 0.000363805, 0.000368092, 0.000370919, 0.000374723, 0.000377892, 0.000382669, 0.000387794, 0.00039156, 0.000395127, 0.000399463, 0.000402481, 0.000406971, 0.000412853, 0.000418201, 0.000423111, 0.00042941, 0.000436019, 0.00043888, 0.000442802, 0.000449236, 0.000456701, 0.000462892, 0.000468006, 0.00047141, 0.000476438, 0.000482089, 0.000485858, 0.000490543, 0.000496345, 0.000501564, 0.000505997, 0.000512174, 0.000517906, 0.000523832, 0.000528643, 0.000533687, 0.000540468, 0.000545894, 0.000552255, 0.000556628, 0.000563068, 0.000571389, 0.000577492, 0.000584669, 0.000591133, 0.000598408, 0.000606794, 0.000612552, 0.000619958, 0.000626562, 0.000633478, 0.00063813, 0.000645626, 0.000653479, 0.00065949, 0.000667466, 0.000674238, 0.000684431, 0.000692875, 0.000703054, 0.000709123, 0.00071684, 0.000726268, 0.000734288, 0.000744044, 0.000751393, 0.000759239, 0.000767587, 0.000776897, 0.000785953, 0.000795834, 0.000804611, 0.000815249, 0.000827512, 0.000837703, 0.000847796, 0.000859153, 0.00086853, 0.000879598, 0.000889529, 0.000900081, 0.00090954, 0.000919101, 0.000929832, 0.00094066, 0.000948699, 0.000959802, 0.000973483, 0.000983215, 0.000985892, 0.000993671, 0.001005588, 0.001013978, 0.001022825, 0.00103482, 0.001046951, 0.001061273, 0.001074148, 0.001087183, 0.001098411, 0.001109094, 0.001120692, 0.00113239, 0.00114252, 0.00115819, 0.00117008, 0.001182838, 0.001196416, 0.001209245, 0.001221912, 0.001237803, 0.00125397, 0.001266098, 0.001281255, 0.001295335, 0.001310962, 0.001326587, 0.001348241, 0.001365574, 0.001382849, 0.001398391, 0.001413821, 0.001429027, 0.001445955, 0.001462817, 0.001482272, 0.00149878, 0.00151357, 0.001529473, 0.001546028, 0.001565174, 0.001583239, 0.001601323, 0.001620996, 0.001639951, 0.00165844, 0.001675148, 0.001696394, 0.001715796, 0.001734586, 0.001751732, 0.001769274, 0.00178858, 0.001812623, 0.001833139, 0.001852008, 0.001871982, 0.001894286, 0.001915239, 0.001934137, 0.001955934, 0.001979119, 0.002003646, 0.002024837, 0.002046225, 0.002066941, 0.002093272, 0.002116134, 0.002142677, 0.002171402, 0.002197694, 0.002224777, 0.002249493, 0.002273528, 0.002299737, 0.002319065, 0.002344646, 0.002375195, 0.00240534, 0.002430435, 0.002461458, 0.002490433, 0.002522199, 0.002550691, 0.002580889, 0.002611167, 0.002639702, 0.002669305, 0.002696471, 0.002727623, 0.002761267, 0.002789493, 0.002823371, 0.002851605, 0.002885755, 0.002919118, 0.002952602, 0.002989136, 0.003023418, 0.003059531, 0.003096386, 0.003130381, 0.00316893, 0.003205376, 0.00323832, 0.0032757, 0.003313049, 0.003349296, 0.003392303, 0.003434958, 0.003476086, 0.003520079, 0.003562206, 0.0036053, 0.003642699, 0.003683055, 0.003723767, 0.003765996, 0.003807741, 0.003852537, 0.003894684, 0.003940451, 0.00398654, 0.004035055, 0.004089241, 0.004140856, 0.004186253, 0.004232987, 0.004279517, 0.004330918, 0.00438271, 0.004431728, 0.00448848, 0.004541072, 0.004596412, 0.004649194, 0.00470279, 0.004752375, 0.004809188, 0.004865869, 0.004923529, 0.00497731, 0.005031294, 0.005087978, 0.005146283, 0.005208921, 0.005272617, 0.005333221, 0.005397769, 0.005464588, 0.005529424, 0.005595526, 0.005654626, 0.00572722, 0.005792532, 0.0058563, 0.005919167, 0.005987743, 0.006056266, 0.006131331, 0.006197538, 0.006271319, 0.006346223, 0.006418705, 0.006490712, 0.006565145, 0.006645397, 0.006719306, 0.006795755, 0.006872029, 0.006953585, 0.007034997, 0.00711846, 0.007196521, 0.00728679, 0.007368389, 0.007449817, 0.007538234, 0.007619667, 0.007704934, 0.007793076, 0.007884724, 0.007978876, 0.008072783, 0.0081736, 0.008281882, 0.008380715, 0.00847982, 0.008577965, 0.008675058, 0.008774886, 0.008868612, 0.008969667, 0.009067206, 0.009173741, 0.009284438, 0.009394798, 0.009507099, 0.009619416, 0.009699258, 0.009722345, 0.009831479, 0.009948376, 0.010060003, 0.010179634, 0.010301919, 0.010421608, 0.010546812, 0.010674739, 0.010796063, 0.010919421, 0.011050537, 0.011175416, 0.011298151, 0.011430511, 0.011566219, 0.011698505, 0.011835163, 0.011972124, 0.01210739, 0.012249038, 0.012390303, 0.012526863, 0.01267491, 0.01281721, 0.012961447, 0.013115288, 0.013266601, 0.013424832, 0.013580005, 0.0137387, 0.013902144, 0.014065324, 0.014233493, 0.014401464, 0.014564179, 0.014725362, 0.014890533, 0.015062726, 0.01523923, 0.015417249, 0.015591146, 0.015772141, 0.015963732, 0.016148264, 0.016331476, 0.016521939, 0.016707817, 0.016899835, 0.017094265, 0.017282997, 0.017479894, 0.017693381, 0.017893474, 0.01810576, 0.018310885, 0.018531894, 0.01873805, 0.018953945, 0.01916331, 0.019379277, 0.019602773, 0.019828262, 0.020073568, 0.020304731, 0.020530559, 0.020765301, 0.021000495, 0.021242669, 0.02149153, 0.021739526, 0.021992409, 0.022246602, 0.022514247, 0.02277531, 0.02304282, 0.023325388, 0.023590887, 0.02385785, 0.024130806, 0.024407336, 0.024695083, 0.024990257, 0.025279681, 0.025568798, 0.025868637, 0.02616843, 0.026482825, 0.026783048, 0.027099044, 0.027410685, 0.027730788, 0.028058081, 0.028372469, 0.028714981, 0.029054309, 0.02939348, 0.029738073, 0.030086838, 0.030447463, 0.030803786, 0.031164702, 0.031526441, 0.031888593, 0.032257269, 0.032627869, 0.033014322, 0.033403902, 0.03378436, 0.034167788, 0.03456021, 0.034965271, 0.03538025, 0.035794578, 0.036188385, 0.036616109, 0.037051644, 0.03748871, 0.03791356, 0.038355481, 0.038818998, 0.039282844, 0.039734698, 0.0401957, 0.040657765, 0.041143854, 0.041611208, 0.042076669, 0.042573072, 0.043062815, 0.043571414, 0.044085495, 0.044600245, 0.045140964, 0.045663528, 0.046187515, 0.046723169, 0.047267174, 0.047829929, 0.048386001, 0.048958803, 0.049550977, 0.050135109, 0.050729451, 0.051335523, 0.051930803, 0.052525926, 0.053125691, 0.053728763, 0.054356884, 0.054986896, 0.055627428, 0.056261619, 0.056917912, 0.057576154, 0.058241762, 0.05890784, 0.05958429, 0.060295983, 0.060989141, 0.061703659, 0.062424345, 0.063167199, 0.063882837, 0.064612425, 0.065387315, 0.066159205, 0.066937137, 0.067705687, 0.068478873, 0.06928452, 0.070107003, 0.070938806, 0.071762584, 0.072589234, 0.07344909, 0.074322353, 0.075202338, 0.076080115, 0.07696713, 0.077843215, 0.078749015, 0.079662908, 0.080605526, 0.081532992, 0.082490116, 0.083468841, 0.084461531, 0.085471766, 0.086490668, 0.087505908, 0.088538408, 0.089598091, 0.090637846, 0.091680295, 0.092742893, 0.093867425, 0.094981593, 0.096108692, 0.097238576, 0.098145782, 0.098387071, 0.099546163, 0.100707451, 0.101887982, 0.103083634, 0.104282477, 0.105497597, 0.106717768, 0.107980756, 0.109242205, 0.110521689, 0.111825166, 0.113135694, 0.114478149, 0.115822795, 0.11717763, 0.11856233, 0.119934555, 0.121355302, 0.12279279, 0.124217213, 0.125703239, 0.127147152, 0.128635854, 0.130143632, 0.131712147, 0.133260961, 0.134860132, 0.136458456, 0.138051489, 0.139679571, 0.14135716, 0.14299787, 0.144684446, 0.146388746, 0.148126265, 0.149860309, 0.151634206, 0.153435632, 0.155232123, 0.157038443, 0.158910643, 0.160828937, 0.162760547, 0.16471665, 0.166653622, 0.168633603, 0.17064477, 0.172673229, 0.174738041, 0.176801118, 0.17890264, 0.181041185, 0.183198041, 0.185385549, 0.187588075, 0.18979868, 0.192062379, 0.194358695, 0.196694416, 0.199068703, 0.20143532, 0.203815191, 0.206250554, 0.208642799, 0.211140495, 0.213691436, 0.216237989, 0.218849038, 0.221463411, 0.224056087, 0.22674043, 0.229474628, 0.232263108, 0.235051529, 0.237847573, 0.240676717, 0.243585808, 0.246503828, 0.249423073, 0.252426458, 0.25545919, 0.258560529, 0.261644852, 0.264780169, 0.267952551, 0.271108013, 0.274387195, 0.277680098, 0.281032299, 0.284436096, 0.287930551, 0.291392844, 0.294913221, 0.298464447, 0.302067865, 0.302866179, 0.305765385, 0.309499973, 0.313281163, 0.317024931, 0.320863042, 0.324767988, 0.328742382, 0.332784942, 0.336884245, 0.341012398, 0.345207072, 0.349495822, 0.353769971, 0.358136125, 0.362555614, 0.367029314, 0.371581937, 0.376201105, 0.380871492, 0.385594562, 0.390363844, 0.395213589, 0.400130828, 0.405083568, 0.410094579, 0.411142967, 0.415208794, 0.420385988, 0.425634291, 0.430947258, 0.436339581, 0.441758566, 0.447284784, 0.45283934, 0.458493395, 0.464250719, 0.470078457, 0.475989084, 0.481978556, 0.488186721, 0.494390803, 0.500659614, 0.5069182, 0.513335866, 0.519853628, 0.526433153, 0.533194312, 0.539972074, 0.546831044, 0.553858873, 0.560998548, 0.568223941, 0.575568732, 0.582930802, 0.590441819, 0.59811447, 0.605885845, 0.613730439, 0.621816271, 0.629924828, 0.638125071, 0.641625772, 0.64639394, 0.654882897, 0.663412644, 0.672162886, 0.680982311, 0.689984745, 0.699080533, 0.708362398, 0.717792309, 0.727375216, 0.737110552, 0.747140151, 0.757165129, 0.767396654, 0.777730774, 0.788352708, 0.799205904, 0.810188502, 0.821165443, 0.832495589, 0.843932535, 0.855583208, 0.867495303, 0.879591821, 0.891885809, 0.897069671, 0.904445966, 0.917334769, 0.930273848, 0.943564544, 0.957026111, 0.970740588, 0.984635751, 0.998886729, 1.013504371, 1.028289947, 1.043408279, 1.058838128, 1.074533627, 1.090653623, 1.10703649, 1.12377564, 1.140833833, 1.158139026, 1.175934777, 1.190389381, 1.223344276, 1.241695033, 1.259929639, 1.278140051, 1.296418503, 1.314758992, 1.332843576, 1.351072081, 1.369200395, 1.387473607, 1.405717115, 1.423841322, 1.442050346, 1.460176126, 1.478383854, 1.496489438, 1.514732699, 1.532836691, 1.543532804, 1.550909578, 1.568987845, 1.586977166, 1.605126541, 1.623231686, 1.641306711, 1.659490364, 1.677771581, 1.6959189, 1.71399534, 1.732282071, 1.750381662, 1.76851203, 1.786650804, 1.804829891, 1.823163932, 1.841365502, 1.859781362, 1.878052886, 1.896369509, 1.914555083, 1.932804026, 1.951207791, 1.969544488, 1.988001858, 1.998648816, 2.006568487, 2.025029377, 2.043483311, 2.061984762, 2.080526447, 2.099087856, 2.117964273, 2.136814162, 2.155561761, 2.174395219, 2.193129546, 2.211880715, 2.230759441, 2.249592048, 2.268505882, 2.287497344, 2.306659656, 2.325845501, 2.34505346, 2.36438555, 2.383692682, 2.403107458, 2.42246014, 2.441847727, 2.46146558, 2.481106634, 2.500851827, 2.52067845, 2.540459441, 2.560366445, 2.580267646, 2.600016837, 2.619908502, 2.640134651, 2.660528144, 2.676722365, 2.680911648, 2.701496917, 2.721845732, 2.742086461, 2.76263693, 2.783425016, 2.804113072, 2.824825713, 2.845854982, 2.867115101, 2.888483661, 2.909721328, 2.931324628, 2.952880628, 2.974426523, 2.996359045, 3.018151836, 3.040338996, 3.062564121, 3.084618751, 3.106767478, 3.129087548, 3.151949795, 3.174268846, 3.197325023, 3.214957342, 3.220055584, 3.243227524, 3.266543575, 3.289845114, 3.313525443, 3.336948938, 3.360804975, 3.384875949, 3.409251078, 3.433551089, 3.457674977, 3.482315638, 3.507305149, 3.532233625, 3.557411439, 3.582311305, 3.60768399, 3.633047387, 3.658693866, 3.684473274, 3.710545985, 3.736630047, 3.763068599, 3.789600896, 3.815879919, 3.842818705, 3.870443563, 3.897682001, 3.925288005, 3.953430454, 3.981463666, 4.009757473, 4.038593523, 4.067408415, 4.096485059, 4.125592162, 4.154997487, 4.184644105, 4.214237697, 4.244015142, 4.274031686, 4.304614323, 4.335417316, 4.366245081, 4.397552377, 4.429529384, 4.461454754, 4.493614847, 4.526068669, 4.558149457, 4.591443575, 4.624637156, 4.657445148, 4.690782066, 4.724888033, 4.758689777, 4.792872641, 4.826934207, 4.861205036, 4.895823693, 4.930694747, 4.965461324, 5.00099421, 5.036996045, 5.073537375, 5.109977083, 5.146154744, 5.182741297, 5.220301543, 5.257672098, 5.295594878, 5.33341371, 5.371444662, 5.409448231, 5.447766379, 5.486103557, 5.525331583, 5.564952086, 5.605136964, 5.645385357, 5.684714459, 5.724318925, 5.765124006, 5.805250946, 5.846419405, 5.887498485, 5.928816969, 5.970434187, 6.013029542, 6.055542665, 6.097530565, 6.139759494, 6.181938464, 6.224672682, 6.266919032, 6.310602644, 6.319228461, 6.354216069, 6.397330919, 6.441223077, 6.485744816, 6.530380118, 6.575784456, 6.619825517, 6.665108547, 6.710602577, 6.75663204, 6.803141006, 6.850104264, 6.896897732, 6.942793349, 6.989697344, 7.036717364, 7.085155543, 7.132727981, 7.18099408, 7.228371465, 7.27669633, 7.325209385, 7.374040645, 7.423356573, 7.472546127, 7.521695246, 7.569786515, 7.619802702, 7.670012191, 7.71910529, 7.769988525, 7.820946916, 7.872064392, 7.922901616, 7.975215454, 8.026144514, 8.07688214, 8.129637279, 8.182374528, 8.234662312, 8.288021092, 8.34057135, 8.394283163, 8.446082016, 8.499806804, 8.553675131, 8.609369488, 8.6620522, 8.715763926, 8.770086341, 8.824775254, 8.881693003, 8.937049413, 8.992898489, 9.049055245, 9.104894386, 9.160646475, 9.216956721, 9.275116328, 9.333340232, 9.390784923, 9.449016372, 9.50646488, 9.563686604, 9.622521719, 9.681531798, 9.738670099, 9.800107077, 9.85848011, 9.91956498, 9.976990243, 10.03463491, 10.093436221, 10.151692049, 10.212892633, 10.273951013, 10.335522331, 10.398225737, 10.458400533, 10.519311953, 10.580252786, 10.642322503, 10.70510135, 10.768778204, 10.830827661, 10.894366295, 10.960396927, 11.024767696, 11.08951034, 11.155880259, 11.222258719, 11.285870855, 11.352252173, 11.419608505, 11.485644473, 11.551440886, 11.615856704, 11.681192503, 11.750287242, 11.816001012, 11.883887722, 11.949926136, 12.020577384, 12.090693776, 12.159407341, 12.229277842, 12.299259644, 12.370316728, 12.439274951, 12.511092358, 12.581548866, 12.65227825, 12.721501997, 12.790438396, 12.861543615, 12.930779049, 13.000770429, 13.072080135, 13.143180366, 13.212809564, 13.285428981, 13.359380395, 13.431341531, 13.504044305, 13.575839527, 13.647261996, 13.721559067, 13.795718043, 13.869060812, 13.943432271, 14.019501646, 14.099102945, 14.174350835, 14.250755981, 14.328294253, 14.405651662, 14.482217891, 14.559847896, 14.637764536, 14.718470198, 14.79793134, 14.87649053, 14.955967338, 15.036405503, 15.117511011, 15.198831476, 15.283218208, 15.363329305, 15.441672615, 15.522314067, 15.60582989, 15.68537137, 15.771151705, 15.850688148, 15.933005664, 16.01262109, 16.101482506, 16.183814548, 16.268989192, 16.355948798, 16.439327088, 16.523613982, 16.610893142, 16.692920499, 16.779214643, 16.860652144, 16.947213437, 17.032206789, 17.11972712, 17.209762326, 17.295772149, 17.382041588, 17.471531336, 17.557492254, 17.648792976, 17.736008294, 17.823434188, 17.914142547, 18.005470864, 18.095088954, 18.182741695, 18.275305707, 18.369577609, 18.456380658, 18.555212297, 18.646882625, 18.735820822, 18.824593939, 18.909328632, 19.001431787, 19.095629735, 19.185234472, 19.2806776, 19.37414659, 19.473415555, 19.566581831, 19.666503903, 19.760605062, 19.860898976, 19.965429219, 19.9859773, 20.064950074, 20.159082046, 20.256768823, 20.354042192, 20.451186062, 20.545396182, 20.636420582, 20.742463188, 20.833976859, 20.941631322, 21.043264162, 21.159357681, 21.255764897, 21.365730503, 21.461982849, 21.561033598, 21.656395251, 21.75678034, 21.861898052, 21.96947395, 22.065206678, 22.173594889, 22.288187707, 22.38779479, 22.48580285, 22.600403678, 22.700338422, 22.797301166, 22.908715626, 23.019917859, 23.126405986, 23.238798651, 23.340786779, 23.442777929, 23.554125886, 23.670807147, 23.782232206, 23.898181451, 24.005250518, 24.110350567, 24.220675672, 24.330566636, 24.43895827, 24.571508017, 24.682207966, 24.795030034, 24.907368246, 25.022623764, 25.135683245, 25.253792982, 25.379412593, 25.492529282, 25.610061099, 25.749490176, 25.872807329, 25.997476102, 26.121050747, 26.23002038, 26.343981703, 26.462579927, 26.576578429, 26.697093245, 26.807030677, 26.937120612, 27.044940275, 27.168230057, 27.300077762, 27.423007439, 27.555139848, 27.675055011, 27.800557365, 27.915164363, 28.044188637, 28.162326573, 28.280562148, 28.405919259, 28.523030872, 28.669408278, 28.817504696, 28.952997537, 29.073190992, 29.191103657, 29.300394021, 29.426521415, 29.54448823, 29.659531813, 29.79081771, 29.918332517, 30.047590085, 30.167594994, 30.30426537, 30.435824742, 30.5640073, 30.695852072, 30.83477991, 30.964500437, 31.095271023, 31.227633587, 31.358786825, 31.49856077, 31.633751353, 31.762977956, 31.900222275, 32.016917968, 32.142966743, 32.272639404, 32.417842411, 32.57845748, 32.71610002, 32.872513345, 33.014897696, 33.140530225, 33.290345502, 33.424577229, 33.579212745, 33.751569261, 33.904713422, 34.043849783, 34.186554922, 34.35264227, 34.495360038, 34.647204411, 34.790056528, 34.954931964, 35.105109415, 35.260160194, 35.390649079, 35.570461617, 35.720331706, 35.877022805, 36.029290089, 36.179920903, 36.36586039, 36.524726106, 36.660428878, 36.79770728, 36.931554531, 37.100845858, 37.256673565, 37.414217752, 37.570193665, 37.721500583, 37.877191468, 38.029309219, 38.178942646, 38.318994734, 38.486111457, 38.646558175, 38.81730785, 38.995998302, 39.131339817, 39.295081229, 39.449178106, 39.590162102, 39.744463481, 39.894258439, 40.04279831, 40.197616194, 40.35186313, 40.517373771, 40.681355964, 40.847780981, 41.030728848, 41.209571401, 41.39298602, 41.548504038, 41.716651628, 41.902003817, 42.033179844, 42.223000977, 42.378928959, 42.525423084, 42.682316932, 42.833236976, 42.986745523, 43.139716574, 43.305227978, 43.463214002, 43.637174519, 43.821761434, 43.969838548, 44.147367919, 44.33349284, 44.513131051, 44.672468313, 44.860831049, 45.069472779, 45.262703108, 45.408208815, 45.612001166, 45.790935886, 45.974160855, 46.147554876, 46.310164374, 46.479135288, 46.631766944, 46.854931997, 47.026711487, 47.211373874, 47.392520311, 47.444267804, 47.599620005, 47.803528973, 47.962988212, 48.16351657, 48.317043883, 48.527408832, 48.712331506, 48.916998574, 49.106040004, 49.242068507, 49.43801286, 49.623064385, 49.8246239, 50.039845231, 50.217892299, 50.424061507, 50.605502238, 50.785192125, 50.946861814, 51.120437498, 51.313812223, 51.575699155, 51.76371781, 52.083012544, 52.297261725, 52.515104821, 52.709056962, 52.935190034, 53.132179257, 53.291722185, 53.498534609, 53.725532485, 53.911785619, 54.132286096, 54.327380597, 54.560402889, 54.737926107, 54.953883363, 55.152438322, 55.373668992, 55.59756117, 55.776336093, 55.979199967, 56.229384847, 56.46125835, 56.640243605, 56.816436874, 57.007429129, 57.213674807, 57.465554746, 57.620279566, 57.86934145, 58.067368041, 58.226435358, 58.470631273, 58.711195362, 58.985311286, 59.214948899, 59.47896391, 59.64032395, 59.817483287, 60.110994577, 60.377248787, 60.64026148, 60.909753918, 61.132109229, 61.353885499, 61.581454092, 61.708588944, 61.979374248, 62.259163443, 62.465466998, 62.843924637, 63.042576119, 63.257487572, 63.533838701, 63.741937703, 63.913545966, 64.027392163, 64.342879658, 64.569647866, 64.836478249, 64.984210443, 65.265788699, 65.454095958, 65.732401898, 65.954793394, 66.092898262, 66.33489902, 66.664698177, 66.975662561, 67.207247075, 67.46700461, 67.749702592, 67.950110013, 68.208857935, 68.437779424, 68.759661705, 69.032601786, 69.248924671, 69.407632145, 69.770840018, 70.085811938, 70.308574142, 70.451819405, 70.643657157, 70.865828746, 71.110948792, 71.263652962, 71.508761168, 71.727512947, 71.990814746, 72.154652118, 72.437434805, 72.717810938, 72.97155564, 73.132604357, 73.444351561, 73.686892162, 74.123365889, 74.339574791, 74.639576626, 74.889601653, 75.087648514, 75.347038165, 75.634658776, 75.844795138, 76.188090561, 76.412034558, 76.754802253, 77.022798967, 77.352898311, 77.556325173, 77.890942669, 78.130954524, 78.407111573, 78.691491787, 78.992449735, 79.22695994, 79.522656558, 79.807288044, 80.09361574, 80.326329179, 80.503875417, 80.714686652, 80.957172643, 81.329180156, 81.597886246, 81.845945644, 82.283833744, 82.537224429, 82.856471995, 83.03108103, 83.230005709, 83.487324539, 83.741797991, 84.024876701, 84.212157139, 84.397795214, 84.612835841, 84.897015014, 85.119241758, 85.452297538, 85.537105644, 85.789824138, 85.988925851, 86.285147657, 86.559642573, 86.766213874, 87.056631415, 87.355454834, 87.686476779, 87.927524426, 88.284321369, 88.782422055, 89.000104756, 89.172147359, 89.558718073, 89.792711548, 90.101448628, 90.395377065, 90.567468107, 90.989023411, 91.340142003, 91.492357433, 91.979132755, 92.360561213, 92.509027692, 92.727077468, 93.147930493, 93.369201642, 93.865180726, 94.442804987, 94.738619676, 95.035378562, 95.262206312, 95.652085786, 96.034797018, 96.320700157, 96.803298707, 97.236201607, 97.428213743, 97.655475304, 97.901223714, 98.109797852, 98.271089247, 98.687897937, 98.895617908, 99.156067897, 99.353253776, 99.526105691, 99.697430828, 100.208679731, 100.40560192, 100.836053715, 101.075007006, 101.682773305, 101.916597011, 102.285744305, 103.025965727, 103.493002676, 103.630410442, 104.001680848, 104.364029796, 104.761578674, 104.955528705, 105.313571983, 105.589806324, 105.921709585, 106.100173972, 106.222786823, 106.638331694, 106.94084932, 107.325246019, 107.625274975, 107.893441491, 108.367787813, 108.507041526, 108.719415221, 108.900811147, 109.077495715, 109.284140155, 110.358751024, 110.490369916, 110.631810481, 111.048746449, 111.538270853, 111.786151932, 112.470819804, 113.132351715, 113.427692227, 113.8394687, 114.303716552, 114.615806958, 115.17932686, 115.475137011, 115.769925784, 116.006903477, 116.265410554, 116.639226837, 117.249933157, 117.550767636, 117.892786729, 118.379305118, 118.506628227, 118.888893289, 119.018371205, 120.303393162, 120.511243772, 120.772383152, 121.06779382, 121.43919971, 122.017141891, 122.126027702, 122.400559633, 122.84113843, 122.994405824, 123.486689262, 123.597118998, 124.122056497, 124.537805158, 124.793372484, 125.380030839, 125.43549198, 125.728966358, 126.161799141, 126.372566715, 126.552562284, 126.633200907, 126.764228333, 126.771328563, 127.195916924, 127.687547295, 128.041555058, 128.314543611, 128.425594574, 128.807364195, 128.982890873, 129.171080161, 129.580369458, 129.778617759, 130.549455562, 130.807768178, 131.569525327, 131.884708787, 132.633064884, 133.184368793, 133.243752989, 133.400407284, 133.730267437, 134.00506061, 135.53264541, 135.970348108, 135.990834176, 136.286830846, 136.388315409, 136.683834232, 137.604891782, 138.423097682, 138.438229158, 139.177871354, 139.218644489, 139.40778058, 139.590905156, 139.751564313, 140.210275536, 140.70280496, 140.890712927, 141.956570663, 142.152200153, 142.264160895, 142.357345549, 142.534606479, 142.71300523, 142.829034193, 143.049391658, 143.097203521, 144.112741345, 144.210741426, 145.100980871 ), "150" = c(1.9209e-05, 1.9266e-05, 1.9301e-05, 1.9535e-05, 2.0039e-05, 2.0117e-05, 2.0198e-05, 2.0204e-05, 2.0249e-05, 2.0324e-05, 2.035e-05, 2.1512e-05, 2.1673e-05, 2.1829e-05, 2.1993e-05, 2.2179e-05, 2.2366e-05, 2.3111e-05, 2.3364e-05, 2.352e-05, 2.3613e-05, 2.366e-05, 2.4037e-05, 2.4195e-05, 2.4553e-05, 2.4653e-05, 2.5106e-05, 2.5199e-05, 2.5548e-05, 2.6034e-05, 2.6154e-05, 2.6735e-05, 2.6916e-05, 2.7002e-05, 2.7159e-05, 2.7403e-05, 2.7573e-05, 2.7828e-05, 2.7956e-05, 2.8197e-05, 2.8288e-05, 2.8699e-05, 2.9637e-05, 3.0071e-05, 3.0371e-05, 3.0501e-05, 3.0727e-05, 3.1221e-05, 3.1367e-05, 3.1558e-05, 3.1793e-05, 3.2056e-05, 3.2677e-05, 3.3674e-05, 3.4e-05, 3.4605e-05, 3.5032e-05, 3.5197e-05, 3.548e-05, 3.6065e-05, 3.6371e-05, 3.6883e-05, 3.7237e-05, 3.8027e-05, 3.8502e-05, 3.8891e-05, 3.9612e-05, 3.9756e-05, 4.0315e-05, 4.0638e-05, 4.0901e-05, 4.0978e-05, 4.154e-05, 4.2053e-05, 4.2476e-05, 4.2776e-05, 4.3082e-05, 4.4092e-05, 4.4418e-05, 4.5558e-05, 4.5951e-05, 4.7088e-05, 4.8377e-05, 4.9394e-05, 4.9651e-05, 5.0047e-05, 5.0922e-05, 5.1487e-05, 5.1885e-05, 5.3283e-05, 5.3711e-05, 5.4488e-05, 5.4753e-05, 5.6288e-05, 5.7102e-05, 5.7933e-05, 5.8333e-05, 5.8518e-05, 5.9063e-05, 6.0049e-05, 6.0527e-05, 6.126e-05, 6.1862e-05, 6.2151e-05, 6.268e-05, 6.364e-05, 6.5382e-05, 6.5684e-05, 6.7271e-05, 6.762e-05, 6.8295e-05, 6.8456e-05, 6.9219e-05, 6.9599e-05, 7.0224e-05, 7.0703e-05, 7.1836e-05, 7.2595e-05, 7.3442e-05, 7.4138e-05, 7.5643e-05, 7.6607e-05, 7.7083e-05, 7.7903e-05, 7.8991e-05, 8.0343e-05, 8.0803e-05, 8.1694e-05, 8.2245e-05, 8.2529e-05, 8.3792e-05, 8.5219e-05, 8.5946e-05, 8.6949e-05, 8.8239e-05, 8.9189e-05, 8.9904e-05, 9.0878e-05, 9.1554e-05, 9.2447e-05, 9.3341e-05, 9.5047e-05, 9.5904e-05, 9.6332e-05, 9.8204e-05, 9.9086e-05, 0.000100829, 0.000102437, 0.000103887, 0.000104378, 0.000106452, 0.000107481, 0.000108854, 0.000111219, 0.000112348, 0.000113042, 0.000114549, 0.00011565, 0.000116729, 0.000118046, 0.000119042, 0.000121094, 0.000122709, 0.000123284, 0.000126069, 0.000127537, 0.000129352, 0.000130951, 0.000132867, 0.00013494, 0.000137414, 0.000139637, 0.000140917, 0.000142684, 0.000145365, 0.000146804, 0.000149112, 0.000149886, 0.000150809, 0.000152012, 0.000153721, 0.000155046, 0.000157607, 0.000159211, 0.000162224, 0.000163138, 0.000164967, 0.00016671, 0.000168807, 0.000171142, 0.000172717, 0.000174608, 0.000176936, 0.000178293, 0.000180019, 0.000181391, 0.000182968, 0.000185453, 0.000188242, 0.000190804, 0.000193598, 0.000195793, 0.000198141, 0.000199567, 0.000202616, 0.000205451, 0.000207751, 0.000209888, 0.000212397, 0.000216493, 0.000220311, 0.000223579, 0.00022702, 0.000229481, 0.00023341, 0.000236008, 0.00023828, 0.000241997, 0.000245358, 0.000248036, 0.000250723, 0.000253303, 0.000256883, 0.00026097, 0.000264923, 0.000266807, 0.000269362, 0.000274145, 0.000276577, 0.000279066, 0.000281686, 0.000286045, 0.000288957, 0.000293109, 0.000296052, 0.000300781, 0.000303818, 0.000307882, 0.000311584, 0.00031394, 0.000317333, 0.000320439, 0.000323793, 0.00032794, 0.000331983, 0.000336753, 0.000341343, 0.000344421, 0.000348137, 0.000351596, 0.000355304, 0.000358702, 0.000363238, 0.000366897, 0.000369307, 0.000373568, 0.0003777, 0.000380811, 0.0003841, 0.000389384, 0.000393733, 0.000396633, 0.000402125, 0.000407118, 0.000412417, 0.000419166, 0.000424132, 0.000428141, 0.000431434, 0.000435846, 0.000441744, 0.000447026, 0.000452197, 0.000457972, 0.000463947, 0.000469749, 0.000474203, 0.000480184, 0.000485393, 0.000490314, 0.000497012, 0.000501512, 0.000505962, 0.000512703, 0.000517436, 0.00052214, 0.00052685, 0.000533264, 0.00053958, 0.000546622, 0.000553668, 0.000558398, 0.00056583, 0.000571899, 0.000576716, 0.000585049, 0.000592836, 0.000599855, 0.000605246, 0.000609586, 0.00061859, 0.000623986, 0.000632282, 0.000640022, 0.000648492, 0.000658548, 0.000665672, 0.000675037, 0.000682543, 0.000690109, 0.000697321, 0.000703117, 0.000711553, 0.000721094, 0.000731306, 0.000740175, 0.000749969, 0.000757918, 0.000766087, 0.000774596, 0.000785399, 0.000792099, 0.000801819, 0.000809301, 0.000819394, 0.000826904, 0.000835573, 0.00084507, 0.000855751, 0.000867107, 0.000876879, 0.000889382, 0.00089814, 0.000909527, 0.000921999, 0.00093197, 0.000941361, 0.000951956, 0.000961844, 0.000971769, 0.000981907, 0.000984219, 0.000992704, 0.001004394, 0.001014136, 0.001024868, 0.001035487, 0.001047662, 0.001059543, 0.001069911, 0.001082643, 0.001095399, 0.001106777, 0.001118147, 0.001129171, 0.001140519, 0.001152551, 0.001166198, 0.00118048, 0.001194656, 0.001208546, 0.001222889, 0.001239045, 0.001250223, 0.001262297, 0.001277119, 0.001293477, 0.001311051, 0.00132215, 0.001335341, 0.001350174, 0.001367013, 0.001382509, 0.001397501, 0.001411737, 0.00142731, 0.001444936, 0.001464886, 0.001482234, 0.001499864, 0.001517679, 0.001535527, 0.001551517, 0.001569959, 0.001589284, 0.001610149, 0.001626794, 0.001645596, 0.001664102, 0.001685776, 0.001708923, 0.001730672, 0.001750067, 0.001770937, 0.001788731, 0.001809514, 0.001830973, 0.001851454, 0.001874298, 0.001894531, 0.001916731, 0.001938906, 0.001957087, 0.001979217, 0.002004787, 0.002031799, 0.00205643, 0.002081182, 0.002103499, 0.002126747, 0.002152169, 0.00217749, 0.002203974, 0.002228975, 0.002259612, 0.002286029, 0.0023153, 0.00234346, 0.00237027, 0.002394372, 0.002427467, 0.002456457, 0.002484014, 0.002512054, 0.002541989, 0.002572352, 0.002604637, 0.002639559, 0.002668955, 0.002696096, 0.002721039, 0.002752422, 0.002780927, 0.002816409, 0.002844758, 0.002873905, 0.002906011, 0.002937581, 0.002970006, 0.003002503, 0.003039264, 0.003070429, 0.00310381, 0.003143803, 0.003181708, 0.003216285, 0.003250617, 0.003290988, 0.003331647, 0.003373168, 0.003409567, 0.003450917, 0.003485742, 0.003524639, 0.003566031, 0.003600709, 0.00363598, 0.003676708, 0.003716079, 0.003758229, 0.003804388, 0.003850031, 0.003894573, 0.003939693, 0.003983266, 0.004027376, 0.004073081, 0.004119863, 0.004166484, 0.004218594, 0.004267054, 0.004318628, 0.004366887, 0.004418196, 0.0044704, 0.004521671, 0.004569359, 0.004620276, 0.004671006, 0.004721935, 0.004782458, 0.004844255, 0.004906974, 0.004967281, 0.005023869, 0.005086915, 0.005147863, 0.005208199, 0.005269726, 0.005326915, 0.005394873, 0.005456659, 0.005518488, 0.005589432, 0.005652312, 0.005715877, 0.005785148, 0.005853957, 0.005925648, 0.005996879, 0.006064518, 0.00613666, 0.006205688, 0.00627108, 0.006346729, 0.00641574, 0.006487584, 0.0065577, 0.006627695, 0.006704586, 0.006778104, 0.006862298, 0.006940008, 0.007019684, 0.007094273, 0.007181114, 0.007269223, 0.007346352, 0.00743766, 0.007520812, 0.007604526, 0.007694145, 0.007787871, 0.007876896, 0.007968051, 0.008064467, 0.00815917, 0.00825965, 0.00835467, 0.008453838, 0.008553793, 0.008652778, 0.00874863, 0.00885062, 0.008953958, 0.009054532, 0.009153646, 0.009255317, 0.009362676, 0.009464359, 0.00956855, 0.00965899, 0.009683599, 0.009794953, 0.009908462, 0.010019258, 0.010132014, 0.010247506, 0.010374947, 0.010491109, 0.010617553, 0.010742057, 0.010864534, 0.010993838, 0.011119865, 0.011244577, 0.01137169, 0.011510356, 0.011637166, 0.011763629, 0.011906354, 0.012041406, 0.012176883, 0.012316055, 0.012448896, 0.01260042, 0.012757456, 0.012907494, 0.013056594, 0.013201688, 0.013349392, 0.013512159, 0.013676678, 0.013843369, 0.014005153, 0.01416332, 0.01432679, 0.014489734, 0.014657898, 0.014824118, 0.014988932, 0.015165028, 0.015346204, 0.015520916, 0.015703037, 0.015882276, 0.016065362, 0.016251736, 0.016449595, 0.016639782, 0.016838109, 0.017031241, 0.017232101, 0.017438966, 0.017650015, 0.017850685, 0.018058165, 0.01827138, 0.018484927, 0.018688502, 0.018901011, 0.019115238, 0.019334286, 0.019557331, 0.019793446, 0.020018629, 0.020251789, 0.020469302, 0.02071475, 0.020948897, 0.02118787, 0.021433971, 0.02168887, 0.02194115, 0.022207504, 0.022482188, 0.022737656, 0.023006649, 0.023257728, 0.023524258, 0.023788663, 0.024057881, 0.024338012, 0.024625854, 0.024912549, 0.025194394, 0.025498007, 0.025782923, 0.026077775, 0.026381096, 0.026687164, 0.02700652, 0.027329318, 0.02764156, 0.027983087, 0.028294943, 0.028628184, 0.028952782, 0.029289095, 0.029613275, 0.02996641, 0.030318435, 0.030671567, 0.031033978, 0.031400628, 0.031770589, 0.032138668, 0.032500274, 0.032860853, 0.033237082, 0.033633372, 0.03401924, 0.034424996, 0.034824139, 0.035231585, 0.035631552, 0.036048411, 0.03647871, 0.036909612, 0.03733694, 0.037763118, 0.03822293, 0.038674598, 0.039118793, 0.039576998, 0.040031581, 0.040513355, 0.04099384, 0.041476738, 0.041955281, 0.042460166, 0.042962506, 0.043462464, 0.043976968, 0.044490141, 0.045007743, 0.045537144, 0.046079805, 0.046610763, 0.047164328, 0.047710712, 0.048262004, 0.048803022, 0.049374493, 0.049951988, 0.050532784, 0.051123868, 0.05171429, 0.052331877, 0.052934776, 0.053555453, 0.05420203, 0.054847554, 0.055480076, 0.056143167, 0.056804618, 0.057474366, 0.058164362, 0.058846488, 0.059531407, 0.060207672, 0.060922599, 0.061634598, 0.062362757, 0.063084271, 0.063834237, 0.064593961, 0.065353001, 0.066115954, 0.066911169, 0.067719084, 0.068534602, 0.069341583, 0.070170131, 0.071005563, 0.071839742, 0.07266433, 0.073511696, 0.074341789, 0.075222515, 0.076107836, 0.077009206, 0.077903871, 0.078815314, 0.079745747, 0.080671582, 0.081626961, 0.082572326, 0.083533787, 0.08453035, 0.085521444, 0.086526662, 0.087536672, 0.088554301, 0.089593384, 0.090653149, 0.091725828, 0.092808557, 0.093908738, 0.094998315, 0.096136735, 0.097278905, 0.098176157, 0.098412309, 0.099543202, 0.100734052, 0.101897018, 0.103094858, 0.104334122, 0.10557443, 0.106825384, 0.108104276, 0.109386581, 0.110677161, 0.111994266, 0.113322766, 0.114679571, 0.116039815, 0.117414018, 0.118777364, 0.120151828, 0.121542323, 0.122979912, 0.124445556, 0.125926394, 0.127401592, 0.128878936, 0.130418263, 0.131984142, 0.133537039, 0.135118768, 0.136722454, 0.138370796, 0.140024473, 0.141697778, 0.143384769, 0.145117843, 0.146842324, 0.148617637, 0.150399009, 0.152180567, 0.153991164, 0.155847046, 0.157693722, 0.159548181, 0.161437609, 0.163376298, 0.165345115, 0.167297701, 0.169303745, 0.171363683, 0.173388819, 0.175455913, 0.177579386, 0.179700162, 0.181825652, 0.183993413, 0.186190792, 0.18842856, 0.190687565, 0.192979258, 0.195337401, 0.197654163, 0.200027412, 0.202428448, 0.204871914, 0.20731886, 0.209798911, 0.212316168, 0.214850911, 0.217415847, 0.220044854, 0.222687158, 0.225381043, 0.228125375, 0.230892041, 0.233692454, 0.23652038, 0.239346873, 0.242247909, 0.2451886, 0.248178074, 0.251181702, 0.254221443, 0.257295703, 0.260425371, 0.263593842, 0.266817695, 0.270049137, 0.273396651, 0.276688871, 0.280046411, 0.283400174, 0.28689764, 0.290446511, 0.294036905, 0.297603518, 0.301264558, 0.304953539, 0.305768251, 0.30872109, 0.312545747, 0.31643173, 0.320269832, 0.324229703, 0.328239636, 0.332297222, 0.336387533, 0.34054535, 0.344791243, 0.34907268, 0.353397449, 0.357815892, 0.362214495, 0.366720616, 0.371282002, 0.375925639, 0.380599146, 0.385282603, 0.390104285, 0.395025723, 0.399939513, 0.405037514, 0.410085008, 0.415242229, 0.416318529, 0.420446161, 0.425741929, 0.431128059, 0.436545067, 0.442131587, 0.447668589, 0.453368629, 0.459158945, 0.46495933, 0.470908015, 0.476919741, 0.48295277, 0.489105404, 0.495388019, 0.501714505, 0.5080855, 0.514565686, 0.521179752, 0.527873493, 0.534722434, 0.541630909, 0.548608661, 0.555744433, 0.563038393, 0.570363212, 0.577818951, 0.585339038, 0.593085013, 0.600890839, 0.608792205, 0.616832066, 0.625002554, 0.63328792, 0.641680087, 0.650151915, 0.653791163, 0.658785949, 0.667541697, 0.676479017, 0.68550293, 0.694685314, 0.704076276, 0.713545799, 0.723292472, 0.733126825, 0.743197246, 0.753354382, 0.763704123, 0.774228709, 0.784903205, 0.795723431, 0.806705282, 0.817884797, 0.829242268, 0.840772728, 0.852578403, 0.864544684, 0.876773225, 0.88915324, 0.901751453, 0.914667526, 0.919992957, 0.927853313, 0.941219337, 0.954915962, 0.968787294, 0.983010706, 0.997460685, 1.012195279, 1.027148186, 1.042409492, 1.057951064, 1.073872073, 1.090089567, 1.106738999, 1.123660718, 1.140914803, 1.158483603, 1.176456015, 1.194786311, 1.21364817, 1.228988638, 1.263899681, 1.283092052, 1.302245419, 1.321478917, 1.340804783, 1.359878908, 1.379025305, 1.398404019, 1.417720878, 1.437015955, 1.456331263, 1.475583287, 1.494763583, 1.51403115, 1.533209632, 1.552469461, 1.571579208, 1.590869144, 1.602059938, 1.609921574, 1.628952389, 1.648040394, 1.667275613, 1.686256888, 1.70544642, 1.724510948, 1.743807567, 1.762879892, 1.782099228, 1.801168486, 1.820364982, 1.839696734, 1.858777096, 1.877969407, 1.897300212, 1.916660327, 1.936083281, 1.955532039, 1.974773445, 1.994096791, 2.01343133, 2.032804082, 2.052201449, 2.071476677, 2.082625216, 2.090883697, 2.110365732, 2.129818754, 2.149201968, 2.168664682, 2.188301879, 2.207850257, 2.227503553, 2.247233134, 2.267056488, 2.286557549, 2.306379768, 2.326196514, 2.346144146, 2.36584226, 2.385659055, 2.405513167, 2.425612482, 2.44577107, 2.465872158, 2.485872603, 2.506154441, 2.526308077, 2.546537254, 2.566698965, 2.587199825, 2.607754844, 2.62809371, 2.648871064, 2.669342264, 2.689797998, 2.710415792, 2.731220205, 2.75185095, 2.772815392, 2.789468646, 2.793779953, 2.814889031, 2.835991018, 2.857014957, 2.878180484, 2.899222618, 2.920521504, 2.941971562, 2.963347643, 2.985024711, 3.006855294, 3.028514056, 3.050428723, 3.072443648, 3.094589812, 3.116342126, 3.138640297, 3.160844844, 3.183085567, 3.205420505, 3.227820387, 3.250354435, 3.27287626, 3.295374459, 3.317700779, 3.335572458, 3.34066878, 3.363654278, 3.38664237, 3.409930827, 3.433326123, 3.456470972, 3.480066384, 3.503739987, 3.5276592, 3.551634902, 3.575248894, 3.599220043, 3.623321351, 3.647576016, 3.672384114, 3.696916172, 3.721446905, 3.74599116, 3.770898942, 3.796142142, 3.821488138, 3.847201958, 3.873183511, 3.898832894, 3.924644533, 3.95067504, 3.976764808, 4.002996545, 4.028910522, 4.05554462, 4.0819449, 4.108665059, 4.135594854, 4.162982416, 4.190314987, 4.217973411, 4.245509425, 4.273407304, 4.301634164, 4.329574761, 4.357764825, 4.386404699, 4.414728159, 4.443847358, 4.472758331, 4.501775439, 4.530980609, 4.560204882, 4.589632054, 4.619621588, 4.650036963, 4.680558962, 4.7111407, 4.741947196, 4.772771885, 4.803435526, 4.834288059, 4.865738199, 4.897332763, 4.928716135, 4.960858053, 4.992977516, 5.025250368, 5.058042516, 5.09062992, 5.123874724, 5.15726287, 5.190639149, 5.22412927, 5.257881804, 5.291950184, 5.326403924, 5.360841857, 5.395402145, 5.430794777, 5.46591735, 5.501136022, 5.536728739, 5.572849897, 5.608270132, 5.643414926, 5.679543094, 5.716579126, 5.753491009, 5.790155866, 5.826989719, 5.863877875, 5.900788105, 5.938836104, 5.976292972, 6.014345824, 6.05369238, 6.092503849, 6.131287735, 6.170954773, 6.209940382, 6.218244651, 6.249274787, 6.288673135, 6.328793735, 6.368711815, 6.408809428, 6.449309352, 6.490471537, 6.531628593, 6.5724677, 6.614271642, 6.656041702, 6.698733614, 6.741479165, 6.78408798, 6.826176864, 6.868457831, 6.910717357, 6.95419047, 6.997197301, 7.040490342, 7.0838244, 7.126722972, 7.170762369, 7.215889032, 7.259807009, 7.304854488, 7.34906056, 7.394813012, 7.442716949, 7.487876978, 7.534068448, 7.579655872, 7.625361408, 7.670278126, 7.716939368, 7.762691803, 7.809283307, 7.855620691, 7.902363062, 7.948221336, 7.994626752, 8.042806842, 8.090490943, 8.139535437, 8.187107, 8.236001777, 8.285207488, 8.332845675, 8.382319939, 8.431507822, 8.481324011, 8.530332087, 8.580520558, 8.629512642, 8.679398664, 8.728809916, 8.780474745, 8.830941551, 8.883177964, 8.933966989, 8.985254392, 9.035658292, 9.085363442, 9.135780872, 9.186670979, 9.237491328, 9.289983018, 9.341241777, 9.395001643, 9.447298173, 9.499060001, 9.552540339, 9.607500954, 9.660551317, 9.714706409, 9.769169735, 9.823341978, 9.877919465, 9.933945738, 9.988586028, 10.042290144, 10.09773533, 10.152542944, 10.2086893, 10.263669234, 10.319335404, 10.378578374, 10.434531599, 10.492996975, 10.548724776, 10.605893969, 10.662732168, 10.720024988, 10.778782761, 10.83803235, 10.896441145, 10.953396269, 11.011170223, 11.070391406, 11.129889423, 11.191591451, 11.25150065, 11.312335717, 11.37368522, 11.434101089, 11.495814735, 11.558197208, 11.618822013, 11.679866823, 11.742269202, 11.803053721, 11.865590042, 11.927425992, 11.988182339, 12.050378393, 12.113386106, 12.178229991, 12.238566272, 12.301996494, 12.366712977, 12.429187201, 12.4970749, 12.565285395, 12.63242785, 12.696345647, 12.758253174, 12.823228141, 12.890890156, 12.954059553, 13.023429223, 13.090104649, 13.160154633, 13.226974018, 13.294955456, 13.361624127, 13.429643537, 13.501107279, 13.570070648, 13.637213338, 13.707380645, 13.775601833, 13.844464829, 13.914392577, 13.983901644, 14.053795569, 14.127320703, 14.201164818, 14.269442399, 14.340328559, 14.407761051, 14.481858246, 14.555890656, 14.627843818, 14.698391439, 14.770029173, 14.841740956, 14.916590636, 14.987521051, 15.060422634, 15.132387934, 15.204080589, 15.277752128, 15.346554112, 15.4247981, 15.494487129, 15.571482928, 15.647368696, 15.725762317, 15.807202948, 15.881872162, 15.95762509, 16.032645734, 16.10757998, 16.186654963, 16.265327794, 16.340827671, 16.418073051, 16.493097045, 16.574672446, 16.655598977, 16.733136216, 16.814195744, 16.894296904, 16.971773311, 17.048584831, 17.127850551, 17.211572745, 17.289662521, 17.371926383, 17.453964902, 17.530388359, 17.61089009, 17.692679213, 17.771410325, 17.853956979, 17.939639445, 18.025395515, 18.104442145, 18.183549711, 18.267441923, 18.284662954, 18.350070797, 18.438150349, 18.523182917, 18.610147845, 18.69312926, 18.775366505, 18.858783562, 18.94853262, 19.034474505, 19.118915993, 19.202202217, 19.288157352, 19.37588032, 19.459207745, 19.550700046, 19.639404368, 19.730392143, 19.823324872, 19.909235586, 20.00124172, 20.094775065, 20.179529225, 20.266007322, 20.355041299, 20.443519508, 20.535639187, 20.622304749, 20.712032534, 20.807270878, 20.899019132, 21.005937513, 21.104916375, 21.19975323, 21.292758952, 21.385154091, 21.486564237, 21.578409514, 21.665648918, 21.754104141, 21.856912721, 21.948925903, 22.051888743, 22.143247496, 22.240964955, 22.337985216, 22.439677371, 22.533825211, 22.642516024, 22.731364487, 22.826609879, 22.926710012, 23.021424739, 23.120865967, 23.221988811, 23.316972581, 23.419320654, 23.517520205, 23.620515839, 23.728205212, 23.834633548, 23.930271151, 24.038851613, 24.146088478, 24.243135459, 24.339301119, 24.441338671, 24.546136231, 24.653160544, 24.762509631, 24.860530871, 24.967707536, 25.064465975, 25.183034126, 25.301744892, 25.409394687, 25.508607258, 25.611405817, 25.713602733, 25.821592959, 25.925758148, 26.029308767, 26.138375087, 26.240983979, 26.366841709, 26.48189632, 26.588243355, 26.700230326, 26.806412814, 26.916228884, 27.02612163, 27.139969821, 27.251518165, 27.364519358, 27.478455053, 27.574224885, 27.676738541, 27.80493614, 27.92766427, 28.04124914, 28.158975752, 28.276331003, 28.386924827, 28.50682812, 28.617692003, 28.733397598, 28.844657743, 28.966054599, 29.113993841, 29.235966265, 29.348217021, 29.474532857, 29.586448881, 29.698707991, 29.817276477, 29.935632125, 30.054812943, 30.168777068, 30.289124287, 30.407279396, 30.539791091, 30.664465683, 30.797933351, 30.920090535, 31.056674474, 31.174176123, 31.284817637, 31.407654055, 31.556960526, 31.681500827, 31.815707235, 31.946883149, 32.072851986, 32.2007432, 32.336588616, 32.466500293, 32.599487101, 32.738094267, 32.863332148, 32.972170844, 33.106176995, 33.272477821, 33.389633483, 33.533499454, 33.672718191, 33.835902037, 33.963880068, 34.092696995, 34.212697187, 34.335509782, 34.472248111, 34.618256087, 34.736731127, 34.856149868, 35.012330776, 35.136305059, 35.269171878, 35.416146466, 35.538960216, 35.693082589, 35.810482294, 35.943883838, 36.110198849, 36.253154794, 36.387187411, 36.562147206, 36.693376701, 36.83608153, 36.992485171, 37.139566476, 37.267063237, 37.405605243, 37.539385418, 37.705852678, 37.855654329, 38.004734076, 38.131697518, 38.260821175, 38.398728269, 38.522675238, 38.644662118, 38.811868655, 38.942624928, 39.107181931, 39.248291205, 39.37763067, 39.535448819, 39.688538863, 39.83272592, 39.974445565, 40.156933524, 40.314548943, 40.449244148, 40.620607475, 40.753267246, 40.905510714, 41.059373094, 41.216669239, 41.396509419, 41.531204715, 41.689675314, 41.712915785, 41.822429505, 41.958077118, 42.120697661, 42.325762547, 42.524704096, 42.665937193, 42.831410314, 42.992697816, 43.161381676, 43.301190999, 43.454568672, 43.619811065, 43.805449747, 43.963447813, 44.113215257, 44.291819552, 44.431779851, 44.600845312, 44.778555936, 44.94508012, 45.103218213, 45.289346245, 45.507210325, 45.68091046, 45.84033842, 46.006359718, 46.147118244, 46.280130207, 46.453748866, 46.620696606, 46.809104588, 47.004695163, 47.099198122, 47.280243034, 47.434295688, 47.612747639, 47.745331148, 47.892350165, 48.097294021, 48.263678236, 48.484588977, 48.657536917, 48.819812233, 49.00850858, 49.193071808, 49.375617172, 49.553510616, 49.776053167, 49.928045804, 50.130686354, 50.317121978, 50.491366299, 50.685694626, 50.884383876, 51.108329326, 51.255784518, 51.390244664, 51.595071457, 51.731658974, 51.903382006, 52.123556514, 52.328826702, 52.487319222, 52.696353867, 52.911456714, 53.185203421, 53.386873343, 53.545522515, 53.712945549, 53.91457674, 54.106682703, 54.25693709, 54.38890716, 54.590516004, 54.809708722, 54.937697825, 55.156648744, 55.405741033, 55.691990692, 55.856788013, 56.033952988, 56.179614644, 56.423014921, 56.649110296, 56.796119707, 57.02603986, 57.248791508, 57.436175759, 57.721114677, 57.996637493, 58.233471666, 58.374964422, 58.523273635, 58.702811404, 58.860729466, 59.182038038, 59.382771074, 59.580384417, 59.771838792, 59.948069013, 60.098335768, 60.294237534, 60.458415791, 60.647062942, 60.811086094, 60.974473075, 61.19175168, 61.394393375, 61.602029385, 61.77196373, 61.974715774, 62.189746587, 62.405119423, 62.648591693, 62.846388486, 62.995747513, 63.229361704, 63.394877887, 63.551556128, 63.786425153, 64.015790052, 64.286496448, 64.538849881, 64.683318973, 64.786162871, 64.971834399, 65.157983104, 65.367461552, 65.514241554, 65.708323939, 65.823609966, 66.092103134, 66.19795172, 66.440758602, 66.601566747, 66.93669226, 67.099946805, 67.273351165, 67.501869005, 67.68456076, 67.845817523, 68.127284918, 68.296983179, 68.444393797, 68.721363514, 68.935150755, 69.091932876, 69.391845032, 69.625883646, 69.862222902, 70.061045559, 70.258922589, 70.682206693, 70.972035962, 71.23497067, 71.468214184, 71.593079103, 71.760056246, 71.870314024, 71.976940497, 72.12897241, 72.418103886, 72.58011066, 72.812942854, 73.242885397, 73.694689057, 74.020807682, 74.243411704, 74.431780659, 74.742091381, 74.87380285, 75.264784775, 75.329518769, 75.603299298, 75.796405759, 76.028932357, 76.496469318, 76.669027056, 77.046998272, 77.289822068, 77.521829352, 77.79532109, 77.93191839, 78.293177117, 78.482247118, 78.931621122, 79.085183366, 79.30430046, 79.564928235, 79.970190875, 80.292773044, 80.70935374, 80.894917376, 80.992732855, 81.142954556, 81.341075829, 81.665616295, 81.739644264, 82.014387968, 82.406429306, 82.606499108, 82.69401089, 83.194140565, 83.363863663, 83.763035651, 84.036021322, 84.573069426, 84.804418825, 85.206461797, 85.347888477, 85.519732285, 85.695328579, 86.322893153, 86.754714386, 87.221275818, 87.37577449, 87.604192887, 87.969769716, 88.066768059, 88.241059266, 88.419519505, 88.599986167, 88.881373443, 89.203839874, 89.370277352, 89.550356681, 89.635580163, 89.893652918, 90.202337805, 90.670814166, 90.804583082, 90.951729226, 91.277238472, 91.569690866, 91.677524709, 91.847404312, 92.039090724, 92.180680152, 92.307414317, 92.583843435, 93.005981837, 93.700550728, 94.456859936, 94.581693803, 95.102880208, 95.562090237, 95.609385944, 95.813106521, 96.155005253, 96.70417523, 97.065745103, 97.293777524, 97.564486136, 97.788876371, 98.029374153, 98.210728844, 98.36566515, 98.513544133, 98.814789963, 99.318378249, 99.502890023, 100.157649313, 100.208979339, 100.544209853, 101.314563052, 101.846579642, 101.962494859, 102.252103634, 102.635716389, 102.794067674, 103.224928888, 103.472835681, 103.966524855, 104.366526708, 104.725762659, 104.842643487, 104.867126103, 105.190874976, 105.244888414, 105.387687089, 105.49526082, 105.58070767, 106.060291913, 106.447970581, 106.966834137, 107.210577625, 107.265886291, 108.234541543, 108.81521351, 109.03096719, 109.18432753, 109.521676321, 109.608622847, 109.785218701, 109.95608561, 110.086046898, 110.70640086, 110.95032831, 111.124088474, 111.549262037, 111.57264881, 112.328399817, 112.907398037, 113.776148019, 113.952913642, 114.640236529, 115.302287876, 115.477509226, 116.202323228, 117.366893575, 117.425215005, 117.602484375, 117.767606988, 118.054945041, 118.285974691, 118.363912982, 118.625795695, 118.741753297, 119.29791533, 119.533339446, 120.026177301, 120.256734263, 120.490747476, 120.640560254, 120.868682469, 122.193519437, 122.452736993, 122.516255501, 122.759462284, 123.56389322, 123.880086358, 123.929853593, 124.859012097, 125.264156223, 125.757184848, 126.04863531, 126.368628376, 126.60945319, 127.028283541, 127.028687015), "200" = c(1.8636e-05, 1.9213e-05, 1.9232e-05, 1.9704e-05, 1.9718e-05, 1.9897e-05, 2.0203e-05, 2.0472e-05, 2.0805e-05, 2.098e-05, 2.1046e-05, 2.1483e-05, 2.1744e-05, 2.1922e-05, 2.1938e-05, 2.2356e-05, 2.2914e-05, 2.3012e-05, 2.3626e-05, 2.3852e-05, 2.4254e-05, 2.4464e-05, 2.5054e-05, 2.521e-05, 2.5568e-05, 2.5723e-05, 2.6082e-05, 2.6093e-05, 2.6527e-05, 2.7124e-05, 2.7411e-05, 2.7874e-05, 2.7991e-05, 2.8156e-05, 2.8418e-05, 2.8572e-05, 2.8666e-05, 2.9334e-05, 2.9429e-05, 2.9583e-05, 2.97e-05, 3.013e-05, 3.095e-05, 3.1271e-05, 3.1302e-05, 3.1597e-05, 3.1915e-05, 3.2588e-05, 3.314e-05, 3.3365e-05, 3.3942e-05, 3.467e-05, 3.4986e-05, 3.5262e-05, 3.5726e-05, 3.6029e-05, 3.6043e-05, 3.6148e-05, 3.6611e-05, 3.6937e-05, 3.7137e-05, 3.7571e-05, 3.7733e-05, 3.8403e-05, 3.911e-05, 3.9502e-05, 4.0587e-05, 4.0879e-05, 4.176e-05, 4.2466e-05, 4.2742e-05, 4.3117e-05, 4.3664e-05, 4.3904e-05, 4.4467e-05, 4.4697e-05, 4.5742e-05, 4.636e-05, 4.6932e-05, 4.8466e-05, 4.9113e-05, 4.9927e-05, 5.0533e-05, 5.1645e-05, 5.2242e-05, 5.2442e-05, 5.3204e-05, 5.4129e-05, 5.4849e-05, 5.5246e-05, 5.5854e-05, 5.6111e-05, 5.6312e-05, 5.6722e-05, 5.737e-05, 5.8837e-05, 5.9687e-05, 6.0363e-05, 6.1074e-05, 6.1271e-05, 6.1636e-05, 6.2422e-05, 6.3414e-05, 6.3665e-05, 6.4261e-05, 6.4851e-05, 6.65e-05, 6.6869e-05, 6.7877e-05, 6.8643e-05, 6.9486e-05, 7.0551e-05, 7.1543e-05, 7.2023e-05, 7.325e-05, 7.4106e-05, 7.4423e-05, 7.6256e-05, 7.6695e-05, 7.7144e-05, 7.7513e-05, 7.8922e-05, 7.9314e-05, 8.1084e-05, 8.1933e-05, 8.2978e-05, 8.424e-05, 8.4965e-05, 8.5519e-05, 8.6465e-05, 8.7058e-05, 8.8135e-05, 8.8729e-05, 9.0135e-05, 9.1051e-05, 9.2841e-05, 9.3547e-05, 9.3939e-05, 9.51e-05, 9.6759e-05, 9.8934e-05, 0.000100323, 0.000101066, 0.000101908, 0.000103578, 0.000104666, 0.000107027, 0.000108159, 0.000109576, 0.000110451, 0.000111113, 0.000112635, 0.000113699, 0.000114645, 0.000115044, 0.000116234, 0.00011674, 0.000117748, 0.000119689, 0.000121057, 0.000122354, 0.000123621, 0.000124916, 0.000126427, 0.000128402, 0.000130348, 0.000131843, 0.000133781, 0.000135121, 0.000135967, 0.000137393, 0.000138675, 0.00014017, 0.000143162, 0.00014471, 0.000147298, 0.000149209, 0.000150672, 0.000151543, 0.000153535, 0.000154805, 0.000156719, 0.000158916, 0.000161186, 0.000162251, 0.000163802, 0.000165148, 0.000166639, 0.000168844, 0.000170789, 0.000174667, 0.000176802, 0.000178001, 0.000180665, 0.000182909, 0.000184865, 0.000186243, 0.000189682, 0.000191329, 0.000193209, 0.000195273, 0.000200568, 0.000202424, 0.00020403, 0.00020641, 0.000209406, 0.000210857, 0.000213229, 0.000215127, 0.000216838, 0.000219794, 0.000222775, 0.000224718, 0.000226465, 0.000227711, 0.00022918, 0.000231863, 0.000234754, 0.000236938, 0.000240967, 0.000243657, 0.000245168, 0.00024794, 0.000250607, 0.000251986, 0.000255835, 0.00025843, 0.000260384, 0.000262374, 0.00026526, 0.000268084, 0.000270915, 0.000273269, 0.000276266, 0.000278931, 0.000281352, 0.000285889, 0.000288106, 0.000291717, 0.000295053, 0.000298494, 0.000302464, 0.000308077, 0.000311148, 0.000314344, 0.000319998, 0.000324207, 0.000329727, 0.000332571, 0.000335357, 0.00033907, 0.000343501, 0.000347506, 0.000350806, 0.000355224, 0.000358465, 0.0003634, 0.000368383, 0.000373065, 0.000376463, 0.000381795, 0.000386381, 0.000390592, 0.000394659, 0.000399685, 0.000405705, 0.000410026, 0.0004156, 0.0004202, 0.000423147, 0.000428265, 0.000432606, 0.000438762, 0.000442666, 0.000447524, 0.000451722, 0.000459106, 0.000464626, 0.000468742, 0.000474915, 0.000479997, 0.000488534, 0.000494311, 0.000499717, 0.00050414, 0.000511822, 0.000518393, 0.000524082, 0.000529974, 0.000534372, 0.000541378, 0.000548251, 0.00055505, 0.000560229, 0.000566375, 0.000572599, 0.000579543, 0.000587117, 0.000593716, 0.000602215, 0.000608265, 0.000615558, 0.000623587, 0.000631318, 0.000637739, 0.000646247, 0.000654436, 0.000661276, 0.000668727, 0.000675739, 0.000684243, 0.000691679, 0.000700963, 0.000710871, 0.000717996, 0.000726604, 0.000736848, 0.000744711, 0.000754958, 0.000764012, 0.000772257, 0.000779154, 0.000787516, 0.000798813, 0.000808192, 0.000816631, 0.000824918, 0.000836883, 0.00084813, 0.000855657, 0.000868043, 0.000877798, 0.000886432, 0.000895475, 0.000908221, 0.000918255, 0.000929525, 0.000939035, 0.000948888, 0.000958652, 0.000968359, 0.000969876, 0.000980905, 0.000991868, 0.001002077, 0.001013777, 0.001023903, 0.00103429, 0.001046722, 0.00105786, 0.001069415, 0.001082703, 0.001096922, 0.001107378, 0.001122616, 0.001137419, 0.001149493, 0.001160372, 0.00117501, 0.001188356, 0.00120182, 0.001218298, 0.001233003, 0.001244216, 0.001259633, 0.001274956, 0.001293711, 0.001307482, 0.001321872, 0.001336854, 0.001355619, 0.001369931, 0.001385321, 0.001403443, 0.001419927, 0.001436244, 0.001454611, 0.001470302, 0.001487046, 0.001504962, 0.001522199, 0.001538988, 0.001559332, 0.001575863, 0.001591542, 0.00161372, 0.001629682, 0.001645857, 0.00166541, 0.001687192, 0.001706494, 0.001726837, 0.001747109, 0.001767527, 0.00179032, 0.001811993, 0.001830563, 0.001850797, 0.001873823, 0.001894346, 0.00191731, 0.001940305, 0.001963323, 0.0019814, 0.002002824, 0.002024741, 0.002048417, 0.00206877, 0.002093077, 0.002117632, 0.00214743, 0.002169793, 0.002195027, 0.002221812, 0.002246458, 0.002270474, 0.0022945, 0.00232506, 0.002354154, 0.002383784, 0.002413561, 0.00244441, 0.002470785, 0.002500162, 0.002526505, 0.002556812, 0.002590508, 0.002618943, 0.002650213, 0.00267705, 0.002706798, 0.002741068, 0.00277123, 0.002806126, 0.002837426, 0.002874071, 0.002904996, 0.002940871, 0.002972902, 0.003008194, 0.003041873, 0.003076286, 0.003106361, 0.003144506, 0.003179303, 0.003214812, 0.003250668, 0.003285169, 0.00332233, 0.003362555, 0.003397766, 0.003440486, 0.003484029, 0.003528346, 0.003567445, 0.00361041, 0.003656506, 0.003696836, 0.003741734, 0.003790018, 0.003835233, 0.003880564, 0.003929148, 0.00397557, 0.004014799, 0.004064482, 0.004107896, 0.004160721, 0.004211434, 0.004255754, 0.004300305, 0.004348065, 0.004397154, 0.004446507, 0.00449987, 0.00455317, 0.004605118, 0.004656998, 0.004708154, 0.004763113, 0.004818406, 0.00487695, 0.004936955, 0.004990665, 0.005050818, 0.005111181, 0.005165068, 0.005225665, 0.005286184, 0.005351968, 0.005412143, 0.005477135, 0.005535261, 0.005602001, 0.005662953, 0.005734093, 0.005798341, 0.005862579, 0.005928264, 0.005999368, 0.006066714, 0.006140033, 0.006211306, 0.006292629, 0.006372148, 0.006450939, 0.006533447, 0.006609052, 0.006684714, 0.006756851, 0.006838988, 0.006923507, 0.007007105, 0.007089463, 0.007165184, 0.007247284, 0.007328469, 0.007407872, 0.007492555, 0.007580202, 0.007665227, 0.007754288, 0.007845082, 0.007937065, 0.008032675, 0.008130521, 0.00823234, 0.008330306, 0.008422014, 0.008524285, 0.008624331, 0.008715513, 0.008819424, 0.008924958, 0.009021932, 0.009117123, 0.009214659, 0.009316627, 0.009431332, 0.009544219, 0.009651135, 0.009735376, 0.00975775, 0.009876774, 0.009995504, 0.010105024, 0.010220441, 0.010336726, 0.010457245, 0.010574215, 0.010699849, 0.010820631, 0.01094908, 0.011076971, 0.011199548, 0.011319421, 0.011451062, 0.011590155, 0.011724306, 0.01185725, 0.011996628, 0.012136317, 0.012280874, 0.01242082, 0.012570277, 0.012712658, 0.012861217, 0.013018819, 0.013164963, 0.013310636, 0.013467251, 0.013618424, 0.013771455, 0.01393094, 0.014090198, 0.014252515, 0.014423584, 0.014600756, 0.014769463, 0.014942907, 0.015112242, 0.01529081, 0.015468011, 0.015648196, 0.015828806, 0.016014868, 0.01620707, 0.016396163, 0.016583302, 0.016775035, 0.016978805, 0.017166717, 0.017373863, 0.017576629, 0.017778667, 0.017974725, 0.018182786, 0.018389635, 0.018597012, 0.018811853, 0.019035356, 0.019253256, 0.019462046, 0.019692114, 0.019901372, 0.02012977, 0.020362329, 0.020597038, 0.020828249, 0.021070732, 0.021325507, 0.021571398, 0.021827307, 0.022079104, 0.022333397, 0.022596667, 0.022860254, 0.023129639, 0.023389831, 0.023658388, 0.023928536, 0.024206127, 0.024483943, 0.024768648, 0.025062739, 0.025353605, 0.025653183, 0.025945174, 0.026241078, 0.026540924, 0.026847516, 0.027147472, 0.0274531, 0.027779204, 0.028115318, 0.028455781, 0.028794059, 0.029136912, 0.029491239, 0.029825249, 0.030175704, 0.03052925, 0.030878543, 0.031231839, 0.031595759, 0.031958276, 0.032332646, 0.032719573, 0.033098374, 0.033488525, 0.033869294, 0.034267266, 0.034682705, 0.035066825, 0.035473487, 0.035866309, 0.036286152, 0.036714756, 0.037147876, 0.037575004, 0.038015222, 0.038469257, 0.038917346, 0.039364709, 0.039813758, 0.04027474, 0.040737438, 0.041233876, 0.041707807, 0.042195368, 0.042670456, 0.043177195, 0.043685177, 0.044207404, 0.044717508, 0.045238255, 0.045746829, 0.046264458, 0.046790664, 0.047341751, 0.047912274, 0.048465871, 0.049029156, 0.049604469, 0.050181274, 0.050765026, 0.051340778, 0.051938478, 0.052542991, 0.053157135, 0.053795025, 0.054433683, 0.055067955, 0.055718836, 0.056358214, 0.057016808, 0.057684392, 0.05836487, 0.059042351, 0.059748154, 0.060449234, 0.06117771, 0.061879246, 0.062605492, 0.063337822, 0.064070053, 0.064823467, 0.06559567, 0.066365071, 0.067137861, 0.067923133, 0.068704759, 0.069506434, 0.070305462, 0.071118011, 0.071941437, 0.07279858, 0.073659977, 0.074508644, 0.075400693, 0.076288275, 0.07718141, 0.078094654, 0.079014458, 0.079949233, 0.080866774, 0.081852202, 0.082816911, 0.083773172, 0.084734998, 0.085727658, 0.08673367, 0.087730857, 0.088775486, 0.089852987, 0.090936911, 0.092016902, 0.093103408, 0.094203391, 0.095330008, 0.096475502, 0.097620148, 0.098544536, 0.09877277, 0.099974701, 0.101146114, 0.102334592, 0.103546736, 0.104747265, 0.105962606, 0.10722774, 0.10848837, 0.109768033, 0.111072075, 0.112399257, 0.113731514, 0.115093055, 0.116487472, 0.117877632, 0.119273948, 0.120679424, 0.122090238, 0.123559805, 0.125021594, 0.126530132, 0.128037995, 0.129553655, 0.131105084, 0.13265533, 0.134232255, 0.135822368, 0.13746299, 0.13906442, 0.140731961, 0.142369707, 0.144060554, 0.145782782, 0.147490782, 0.1492541, 0.151064506, 0.152886983, 0.15468909, 0.156524161, 0.158435529, 0.160345667, 0.162295393, 0.16423719, 0.16619505, 0.168188289, 0.170187792, 0.172193173, 0.174262726, 0.176356117, 0.178486941, 0.180659794, 0.182819488, 0.185007467, 0.187248042, 0.189477289, 0.191767672, 0.194053318, 0.196376774, 0.198736661, 0.201167338, 0.20354455, 0.206009213, 0.208522702, 0.211062441, 0.213631798, 0.216234354, 0.218862433, 0.221539933, 0.224232656, 0.226971498, 0.229753949, 0.232492793, 0.235289289, 0.238156997, 0.24105281, 0.243986055, 0.246974154, 0.250049192, 0.253085231, 0.256221563, 0.259334778, 0.262490539, 0.265632696, 0.268873678, 0.272160531, 0.275503682, 0.278843598, 0.282259332, 0.285693675, 0.289187029, 0.292714487, 0.296305652, 0.299952914, 0.303658532, 0.307391111, 0.308206834, 0.31122571, 0.315095416, 0.318973134, 0.322901015, 0.32690405, 0.330938616, 0.335083367, 0.339194457, 0.343408424, 0.347659013, 0.352022118, 0.356386807, 0.360861146, 0.365417873, 0.370046464, 0.37463788, 0.379265913, 0.384019504, 0.388766201, 0.393668419, 0.398636474, 0.403678432, 0.40878006, 0.414001851, 0.41924891, 0.420326516, 0.424533958, 0.42993483, 0.435350499, 0.440918189, 0.446522727, 0.452240483, 0.458080134, 0.46398987, 0.469922433, 0.47588112, 0.481963183, 0.488131808, 0.494392097, 0.500788603, 0.507188454, 0.513769963, 0.520421191, 0.527122386, 0.534023597, 0.541034914, 0.548035689, 0.555201431, 0.562414822, 0.569836122, 0.577264237, 0.584880001, 0.592642548, 0.600475956, 0.608397077, 0.616534013, 0.624790313, 0.633088559, 0.641596996, 0.650144714, 0.658783353, 0.66251263, 0.667637858, 0.676625138, 0.685816804, 0.695123929, 0.704523699, 0.714096283, 0.723783632, 0.733746002, 0.743802063, 0.753966755, 0.764431645, 0.775098038, 0.785866544, 0.796745555, 0.807939091, 0.819226055, 0.830656034, 0.842385865, 0.854257456, 0.866476839, 0.878855747, 0.891403751, 0.904209932, 0.917256039, 0.930440928, 0.935945673, 0.943891485, 0.957657637, 0.971642146, 0.98605472, 1.000503495, 1.015344212, 1.030429598, 1.0460056, 1.06184131, 1.077933795, 1.094154527, 1.110759015, 1.127751306, 1.145098222, 1.162828483, 1.18099477, 1.199547256, 1.218569738, 1.237851369, 1.253591767, 1.289393896, 1.309311412, 1.329189177, 1.349032796, 1.368884357, 1.388887566, 1.408731625, 1.428480398, 1.448384258, 1.46842933, 1.488017014, 1.507793418, 1.527512168, 1.547282218, 1.567099212, 1.587009541, 1.606912381, 1.626638258, 1.63820754, 1.646476437, 1.666432619, 1.686228766, 1.705852287, 1.72542747, 1.745229761, 1.765113468, 1.785032723, 1.805036447, 1.824934335, 1.844897511, 1.864651179, 1.884632423, 1.904578033, 1.924423167, 1.944334499, 1.96410882, 1.983988622, 2.003809497, 2.023771154, 2.043520871, 2.063537681, 2.083348738, 2.103329714, 2.123563522, 2.135021231, 2.143375966, 2.163583266, 2.183598231, 2.203998194, 2.224098434, 2.244329128, 2.264307784, 2.284578176, 2.304631548, 2.324843856, 2.345145621, 2.365563349, 2.385825244, 2.406239904, 2.42639859, 2.446845911, 2.467406762, 2.487657829, 2.508205331, 2.528769177, 2.549501872, 2.569995224, 2.590866391, 2.611622361, 2.632220492, 2.652951498, 2.673672193, 2.694450439, 2.715474932, 2.736292066, 2.757209347, 2.778203477, 2.799128209, 2.820131414, 2.841420122, 2.858191232, 2.862517581, 2.883439903, 2.904775995, 2.926259373, 2.947720524, 2.969187645, 2.990918215, 3.012366444, 3.03407187, 3.055734632, 3.07777233, 3.099787099, 3.121661799, 3.143808771, 3.166015535, 3.187770933, 3.210207448, 3.232684508, 3.255130518, 3.277754009, 3.300437264, 3.323042095, 3.345643735, 3.368215495, 3.390912706, 3.408644918, 3.413487735, 3.436364238, 3.459330576, 3.4825545, 3.505682068, 3.528763536, 3.552240843, 3.57556027, 3.599196263, 3.622687853, 3.646368218, 3.670081175, 3.694197306, 3.718612262, 3.742765816, 3.766807402, 3.79128352, 3.815795227, 3.840305005, 3.864943409, 3.889446712, 3.914472269, 3.939219914, 3.964161489, 3.989298116, 4.014521592, 4.039470887, 4.064723828, 4.089959972, 4.115418618, 4.141434841, 4.167151009, 4.193207622, 4.219410286, 4.245265081, 4.271795277, 4.298598364, 4.32530948, 4.351700717, 4.379030163, 4.405958249, 4.433045934, 4.460143199, 4.487371224, 4.51528676, 4.542988218, 4.570785451, 4.599190428, 4.627139115, 4.655396757, 4.684234218, 4.713116076, 4.742119985, 4.770804327, 4.79998944, 4.829877202, 4.859607441, 4.888888226, 4.917583175, 4.947322475, 4.977811394, 5.008210082, 5.039025664, 5.069635972, 5.100385473, 5.13117422, 5.162507246, 5.19333023, 5.225527106, 5.257648592, 5.289813999, 5.321543708, 5.354046525, 5.386416659, 5.418201481, 5.451132407, 5.48445374, 5.517873023, 5.550812938, 5.583797745, 5.616979633, 5.650291054, 5.684400347, 5.719065312, 5.753362559, 5.78741594, 5.822128081, 5.856606595, 5.891779031, 5.927418415, 5.96305232, 5.998319556, 6.033867752, 6.070084572, 6.105773662, 6.14177495, 6.149254512, 6.178291672, 6.215415329, 6.251982207, 6.288593285, 6.325864839, 6.362690101, 6.401043976, 6.437863347, 6.475981541, 6.514407383, 6.552343737, 6.59017869, 6.629102988, 6.667254556, 6.706632538, 6.746340655, 6.786191206, 6.825867751, 6.865708795, 6.904803794, 6.944873512, 6.985518923, 7.027281028, 7.069131984, 7.109400003, 7.152286573, 7.194059564, 7.236742202, 7.277475301, 7.319381877, 7.360405657, 7.40310346, 7.445209538, 7.487772918, 7.530912999, 7.572945386, 7.616622185, 7.660166598, 7.703368781, 7.74647237, 7.790774999, 7.835731806, 7.879938237, 7.92470079, 7.969013666, 8.013756675, 8.059360897, 8.104917816, 8.150846108, 8.196343666, 8.241621845, 8.288283643, 8.333996286, 8.380311477, 8.426730123, 8.472901068, 8.518539603, 8.565958492, 8.614206635, 8.660192526, 8.706033165, 8.754252772, 8.803187267, 8.851401208, 8.898870184, 8.947897225, 8.998337365, 9.04519606, 9.095058268, 9.143144768, 9.192069011, 9.241580184, 9.289824885, 9.340317658, 9.390496657, 9.440605284, 9.490009067, 9.540083503, 9.590499956, 9.642502527, 9.692597631, 9.743444614, 9.794333812, 9.846529464, 9.898368195, 9.950277083, 10.003603213, 10.056727367, 10.109774873, 10.162274513, 10.214743321, 10.267143205, 10.321199455, 10.372026018, 10.423638314, 10.475611195, 10.529270362, 10.582930612, 10.636574662, 10.69157518, 10.748335265, 10.802025038, 10.856691752, 10.910330597, 10.964616495, 11.018809816, 11.075318005, 11.132653705, 11.189787161, 11.245719723, 11.303242359, 11.360874884, 11.416695867, 11.475322314, 11.530537083, 11.589879303, 11.6486315, 11.70799926, 11.765705109, 11.823186067, 11.881532265, 11.9391904, 12.001853875, 12.061135007, 12.121226697, 12.183225423, 12.243826415, 12.304047582, 12.36276449, 12.423480804, 12.484094388, 12.54520049, 12.607006629, 12.666487374, 12.725708208, 12.790119381, 12.850215386, 12.912369859, 12.975951644, 13.041596183, 13.103659273, 13.167344342, 13.230070095, 13.295634035, 13.356845142, 13.420721062, 13.485399103, 13.54741414, 13.612038789, 13.674163608, 13.736280043, 13.801357479, 13.868016571, 13.93100509, 13.996015781, 14.061335817, 14.125711938, 14.189719488, 14.25885632, 14.323394663, 14.39047329, 14.456146254, 14.522720821, 14.585799932, 14.654761129, 14.723475261, 14.789377934, 14.858826742, 14.923157221, 14.992101384, 15.063935046, 15.130997476, 15.200739437, 15.261799144, 15.330967571, 15.402903799, 15.475465667, 15.548509979, 15.62084701, 15.692771549, 15.758371428, 15.830227948, 15.899759074, 15.971222279, 16.041004395, 16.110288062, 16.180594851, 16.25100964, 16.324014171, 16.39829739, 16.470660567, 16.546425371, 16.626053565, 16.695859795, 16.772377753, 16.847603243, 16.9210289, 16.994400404, 17.06963003, 17.141656842, 17.155589687, 17.21225867, 17.282142193, 17.359755179, 17.437289269, 17.512600173, 17.587649703, 17.662218623, 17.737055743, 17.812720208, 17.889422943, 17.961420513, 18.032983416, 18.111247756, 18.185473714, 18.264609389, 18.337447102, 18.418432626, 18.499648524, 18.578471892, 18.65259713, 18.741028321, 18.826756339, 18.905333585, 18.987153685, 19.065917473, 19.149289041, 19.225736716, 19.312945598, 19.393589446, 19.469206134, 19.5496455, 19.637021214, 19.719066148, 19.806847583, 19.887532241, 19.973476221, 20.05288714, 20.129488566, 20.209628824, 20.286657163, 20.370212855, 20.453879832, 20.541101632, 20.632929945, 20.717598409, 20.798256856, 20.891831678, 20.971717902, 21.053063618, 21.144092852, 21.229180997, 21.313130788, 21.414109502, 21.504835221, 21.588120065, 21.673305646, 21.771155496, 21.862987837, 21.940502544, 22.033669563, 22.122487537, 22.222803675, 22.31104445, 22.408895629, 22.502984508, 22.591089408, 22.679079574, 22.771966713, 22.85936858, 22.952630765, 23.046614028, 23.146974768, 23.229052147, 23.324979338, 23.414929269, 23.510793344, 23.602235133, 23.697351516, 23.79332145, 23.896597706, 23.997165269, 24.097319692, 24.180200789, 24.273271144, 24.366115217, 24.457460229, 24.56592532, 24.665170195, 24.76275921, 24.854563523, 24.957252207, 25.057575737, 25.167911447, 25.271930335, 25.368404335, 25.473239876, 25.579528749, 25.672276661, 25.772623118, 25.868261876, 25.95990979, 26.059359404, 26.164759753, 26.275555902, 26.384427982, 26.49105829, 26.609052357, 26.735268823, 26.850479496, 26.949089394, 27.05931773, 27.157399328, 27.258962763, 27.363648688, 27.471450244, 27.572731335, 27.680224161, 27.783500682, 27.887351305, 27.987602589, 28.09331525, 28.205556821, 28.292382599, 28.402793929, 28.497462221, 28.598007395, 28.731706787, 28.839935938, 28.935079205, 29.043169903, 29.146429756, 29.25309353, 29.379088539, 29.487831399, 29.594728051, 29.70773233, 29.8158949, 29.935178851, 30.046920386, 30.157467568, 30.279122439, 30.386050134, 30.484624767, 30.589612035, 30.690337731, 30.797188595, 30.929234075, 31.032636876, 31.153942812, 31.287774567, 31.40486342, 31.509695169, 31.608282487, 31.730573083, 31.852519508, 31.999073219, 32.128745294, 32.243312463, 32.382975708, 32.532494641, 32.634858679, 32.767329496, 32.886119733, 32.986530541, 33.093921631, 33.229429122, 33.360370598, 33.493755624, 33.605288061, 33.718558838, 33.849187836, 33.957493423, 34.090959636, 34.224662894, 34.356917412, 34.462660061, 34.600421623, 34.7450766, 34.852543641, 34.975607386, 35.084964176, 35.196939452, 35.305394428, 35.417459648, 35.545870008, 35.68086729, 35.816526255, 35.974467826, 36.078503639, 36.209726303, 36.325125044, 36.457407402, 36.611542519, 36.743595245, 36.875386738, 37.005274097, 37.119312105, 37.218990846, 37.365904004, 37.50358233, 37.524144267, 37.632658614, 37.762809606, 37.869729817, 37.982158445, 38.141085194, 38.27200866, 38.412874682, 38.529457077, 38.654878478, 38.787395146, 38.942997952, 39.07469668, 39.230090378, 39.355640194, 39.463010075, 39.616785313, 39.739932487, 39.842464819, 39.959872887, 40.069801088, 40.169840708, 40.33944118, 40.474904955, 40.617587148, 40.760370885, 40.893935474, 41.040671638, 41.185758214, 41.298776906, 41.424411518, 41.540129743, 41.705433528, 41.831327967, 42.002211472, 42.168476371, 42.292618007, 42.424554546, 42.57667584, 42.725967968, 42.92266187, 43.095985035, 43.225155596, 43.346838732, 43.517270043, 43.733776982, 43.872754737, 44.071888565, 44.226277488, 44.360688154, 44.515174581, 44.673961747, 44.826340502, 44.966120158, 45.17537499, 45.307591814, 45.479782758, 45.655395003, 45.819505943, 45.981001163, 46.105982578, 46.219803927, 46.331451641, 46.480642867, 46.663820984, 46.808454727, 46.977474269, 47.110616719, 47.26647254, 47.395713148, 47.558866271, 47.765825909, 47.914882468, 48.092224758, 48.212204438, 48.360635744, 48.495899393, 48.614907839, 48.771585189, 48.976620513, 49.137120355, 49.275983232, 49.482698411, 49.624851745, 49.780760907, 49.91009775, 50.042681915, 50.278311881, 50.462763906, 50.623029135, 50.760414181, 50.977033813, 51.121993452, 51.300104057, 51.561956784, 51.685807535, 51.833533419, 51.973717108, 52.171596835, 52.333853059, 52.438546667, 52.633699299, 52.798214885, 52.989942078, 53.172671246, 53.321126702, 53.459467445, 53.651958598, 53.784009567, 53.990813364, 54.142473607, 54.334508736, 54.531833715, 54.673490445, 54.800390385, 54.951286312, 55.113367153, 55.238990005, 55.405970965, 55.600955548, 55.777946678, 55.914374748, 56.140852473, 56.349635266, 56.660403469, 56.81945408, 57.027815937, 57.249297824, 57.411856101, 57.506742524, 57.697167529, 58.026102709, 58.222700068, 58.314448725, 58.582571842, 58.729533363, 58.879258943, 59.06859432, 59.210758228, 59.386701089, 59.599951257, 59.796965484, 59.9550775, 60.120246791, 60.322031073, 60.482747917, 60.688406733, 60.842738391, 61.085487585, 61.231641686, 61.461300402, 61.697695823, 61.944979854, 62.087499379, 62.256141638, 62.607353093, 62.846803039, 63.09443414, 63.312983284, 63.536142351, 63.822343526, 64.029650434, 64.248192204, 64.458039626, 64.653171251, 64.816313447, 65.044893395, 65.305329132, 65.449282034, 65.671633671, 65.826384664, 65.954526357, 66.100148931, 66.306695366, 66.678261944, 66.976064103, 67.177442874, 67.312804058, 67.573976282, 67.891638189, 68.105114274, 68.317694984, 68.598623332, 68.774576331, 68.989480998, 69.159704762, 69.494810479, 69.786481431, 69.893570421, 70.157425708, 70.358771239, 70.489290863, 70.721003495, 71.018416385, 71.276621836, 71.585232626, 71.871170288, 72.260588262, 72.66393895, 72.983922891, 73.2650231, 73.535025807, 73.736707596, 73.815833406, 73.898991442, 74.11235073, 74.388104162, 74.626280882, 74.801524961, 75.01194028, 75.417777408, 75.543836306, 75.620534248, 75.843681015, 75.998204068, 76.296730263, 76.612598354, 76.858948164, 77.341389189, 77.526995161, 77.802480388, 78.104362542, 78.413656253, 78.668838755, 78.964684047, 79.03414987, 79.269147582, 79.663117037, 80.172334824, 80.450658603, 80.659122593, 80.957901193, 81.102643835, 81.264957316, 81.367486546, 81.562811528, 82.062840607, 82.288446942, 82.380158453, 82.625199318, 82.796351469, 82.870921411, 83.115666528, 83.479875449, 83.604987442, 83.810624111, 84.361931671, 84.509860984, 84.826035951, 85.017909509, 85.298648745, 85.545390294, 85.815839518, 86.233354514, 86.405859782, 86.597944978, 86.927384156, 87.166009655, 87.498677227, 87.610388951, 88.022562668, 88.425392429, 88.519432712, 88.642249618, 89.145419845, 89.798235781, 90.068771988, 90.20839128, 90.577801247, 90.874263146, 91.206690598, 91.32782688, 91.478583617, 91.614531256, 91.70393229, 92.541810545, 92.635386104, 92.872202025, 93.079860078, 93.166258289, 93.317619451, 93.542463605, 93.770281442, 94.007954449, 94.380468999, 94.809084445, 94.927246199, 95.074374462, 95.15900041, 95.261176296, 95.338496935, 95.598058832, 96.15664072, 96.34633546, 96.401267232, 96.93744457, 97.127068064, 97.441467943, 97.618983636, 97.827069307, 97.937286048, 97.977902264, 98.29424893, 98.443088233, 99.073355646, 99.420148146, 99.55166846, 100.213840398, 100.344890539, 100.590990234, 101.550268895, 101.553877109, 101.873257328, 102.226779312, 102.227853579, 102.481848587, 102.67932765, 102.969760257, 103.248680503, 103.540700979, 103.545883043, 103.760473408, 103.939613938, 104.026635264, 104.642273705, 105.050434126, 105.586357375, 105.804818035, 105.97494225, 106.138004121, 107.370832448, 107.767710322, 107.792296213, 108.774176058, 109.24672626, 109.309625236, 109.682944576, 109.744572439, 109.987799235, 110.04558376, 110.070904945), "300" = c(1.9087e-05, 1.9332e-05, 1.9338e-05, 1.9612e-05, 1.9839e-05, 1.9909e-05, 2.0128e-05, 2.0205e-05, 2.141e-05, 2.1527e-05, 2.1544e-05, 2.2177e-05, 2.2204e-05, 2.2232e-05, 2.2472e-05, 2.2657e-05, 2.3425e-05, 2.3781e-05, 2.4379e-05, 2.4411e-05, 2.4604e-05, 2.4656e-05, 2.4852e-05, 2.5047e-05, 2.5295e-05, 2.5338e-05, 2.5819e-05, 2.6025e-05, 2.6626e-05, 2.6746e-05, 2.6796e-05, 2.7301e-05, 2.7409e-05, 2.7529e-05, 2.7754e-05, 2.7804e-05, 2.8049e-05, 2.8508e-05, 2.8775e-05, 2.8877e-05, 2.9206e-05, 2.9407e-05, 2.9604e-05, 2.9971e-05, 3.0335e-05, 3.1044e-05, 3.1491e-05, 3.1781e-05, 3.2345e-05, 3.2569e-05, 3.3025e-05, 3.3139e-05, 3.3661e-05, 3.3842e-05, 3.3912e-05, 3.4007e-05, 3.4379e-05, 3.4787e-05, 3.5415e-05, 3.6148e-05, 3.6427e-05, 3.6686e-05, 3.7053e-05, 3.7652e-05, 3.7913e-05, 3.8297e-05, 3.8788e-05, 3.9553e-05, 4.0323e-05, 4.0378e-05, 4.1899e-05, 4.2262e-05, 4.2491e-05, 4.2792e-05, 4.3085e-05, 4.4161e-05, 4.5194e-05, 4.5605e-05, 4.5763e-05, 4.6086e-05, 4.6286e-05, 4.7013e-05, 4.8155e-05, 4.8281e-05, 4.8788e-05, 4.9551e-05, 4.9859e-05, 5.0515e-05, 5.1611e-05, 5.3549e-05, 5.4194e-05, 5.4634e-05, 5.51e-05, 5.5864e-05, 5.7323e-05, 5.7931e-05, 5.9042e-05, 5.9709e-05, 6.0254e-05, 6.1166e-05, 6.137e-05, 6.2421e-05, 6.289e-05, 6.3792e-05, 6.5545e-05, 6.6118e-05, 6.6648e-05, 6.7274e-05, 6.7471e-05, 6.8264e-05, 6.9129e-05, 7.0703e-05, 7.1732e-05, 7.2992e-05, 7.3802e-05, 7.4297e-05, 7.4739e-05, 7.5832e-05, 7.6687e-05, 7.751e-05, 7.7993e-05, 7.8227e-05, 7.9343e-05, 8.1618e-05, 8.2815e-05, 8.3317e-05, 8.391e-05, 8.465e-05, 8.51e-05, 8.5835e-05, 8.7312e-05, 8.8639e-05, 8.923e-05, 9.0093e-05, 9.1327e-05, 9.2068e-05, 9.3069e-05, 9.4449e-05, 9.5319e-05, 9.6644e-05, 9.8258e-05, 0.000100619, 0.000101625, 0.000102775, 0.000103746, 0.000104664, 0.000105545, 0.000106226, 0.000108413, 0.000109258, 0.000110308, 0.000112019, 0.000113194, 0.000114922, 0.00011623, 0.000116974, 0.00011816, 0.00011883, 0.000120299, 0.000122613, 0.000124469, 0.000125279, 0.000126634, 0.000127945, 0.000129274, 0.000130058, 0.000131684, 0.000132749, 0.000135233, 0.000136519, 0.00013774, 0.000139689, 0.000140874, 0.000142057, 0.00014411, 0.000145628, 0.000147836, 0.000148915, 0.000151674, 0.0001534, 0.000155096, 0.000157337, 0.000158458, 0.000159474, 0.000161177, 0.000162411, 0.000164044, 0.000165096, 0.000166314, 0.000167594, 0.000168872, 0.000169814, 0.00017237, 0.000175016, 0.000176535, 0.000179147, 0.000181441, 0.000183986, 0.000186282, 0.000188917, 0.00019079, 0.000193156, 0.000194979, 0.000197373, 0.000199454, 0.000202034, 0.000204425, 0.000206484, 0.000207537, 0.000209895, 0.000212987, 0.000217102, 0.000220819, 0.000222272, 0.000225474, 0.000227448, 0.000228964, 0.000231192, 0.000234124, 0.000237233, 0.000240298, 0.000241873, 0.000246176, 0.000250192, 0.000253457, 0.00025689, 0.000259518, 0.000264291, 0.00026849, 0.000272755, 0.000275855, 0.000278937, 0.000282382, 0.000288152, 0.000291452, 0.000294065, 0.000297999, 0.000300084, 0.00030214, 0.000304723, 0.000310045, 0.000314278, 0.000317407, 0.000321455, 0.000325995, 0.000329806, 0.00033364, 0.000336149, 0.000338037, 0.000342425, 0.000346378, 0.000350411, 0.000355369, 0.000358284, 0.000362876, 0.000366631, 0.00036967, 0.000374428, 0.000379274, 0.00038336, 0.000388201, 0.000393538, 0.000399278, 0.000404938, 0.000408497, 0.000412514, 0.000418056, 0.000422606, 0.00042823, 0.000432608, 0.000437874, 0.000443213, 0.000446679, 0.000451743, 0.000455162, 0.000461611, 0.00046836, 0.000473414, 0.000477972, 0.000483147, 0.000488357, 0.000494907, 0.000501081, 0.000508039, 0.000514447, 0.000518705, 0.00052556, 0.000531495, 0.00053695, 0.000541634, 0.000546463, 0.000552729, 0.000558698, 0.00056645, 0.000571538, 0.000576786, 0.000583082, 0.000590113, 0.000597351, 0.000605398, 0.000612807, 0.000620299, 0.000627636, 0.000632587, 0.000638867, 0.000649246, 0.000656053, 0.000664808, 0.000671967, 0.00068091, 0.000687882, 0.000696226, 0.000704155, 0.000712414, 0.000719326, 0.000730654, 0.000738913, 0.000747223, 0.0007565, 0.00076516, 0.000775272, 0.000784426, 0.000795125, 0.000803627, 0.000813208, 0.000825752, 0.000835159, 0.000844141, 0.000854039, 0.000868711, 0.000878066, 0.000889747, 0.000899167, 0.000910703, 0.000922475, 0.000934059, 0.000945268, 0.000955175, 0.000965957, 0.000975633, 0.00098424, 0.000987034, 0.000996822, 0.001008061, 0.00102186, 0.001034384, 0.001048513, 0.001060112, 0.001072452, 0.001083517, 0.001098441, 0.001109753, 0.001124114, 0.001136094, 0.001147298, 0.001157864, 0.001171216, 0.001185279, 0.001199691, 0.001211711, 0.001227647, 0.001239501, 0.001251695, 0.001266602, 0.001282222, 0.00129646, 0.00130932, 0.001321207, 0.001336787, 0.00135033, 0.001365703, 0.001380564, 0.001397868, 0.001413164, 0.001430932, 0.001447326, 0.001462744, 0.001482443, 0.001503365, 0.001518496, 0.001536632, 0.001554337, 0.001569718, 0.001589168, 0.001607901, 0.001624456, 0.001642999, 0.001658663, 0.001680993, 0.001702483, 0.001722469, 0.001742523, 0.001761454, 0.001779252, 0.001801673, 0.001821305, 0.001839324, 0.001860134, 0.001882392, 0.001903433, 0.001926032, 0.001946337, 0.001972518, 0.001995879, 0.00202458, 0.002048945, 0.002072349, 0.002095042, 0.002121843, 0.002149502, 0.002173636, 0.002196294, 0.002223306, 0.002250253, 0.002275175, 0.002300392, 0.002326707, 0.002353856, 0.002378692, 0.002402059, 0.002428653, 0.002457244, 0.002482654, 0.002507338, 0.002535387, 0.002562352, 0.002590664, 0.002621356, 0.002652535, 0.002681807, 0.00271205, 0.002744047, 0.002776923, 0.002809024, 0.002839992, 0.002873651, 0.002907045, 0.002939849, 0.00297317, 0.003004815, 0.003041535, 0.003077671, 0.003110854, 0.003149724, 0.003191214, 0.003223273, 0.003264026, 0.003306453, 0.003344419, 0.0033848, 0.003426641, 0.003465652, 0.003502313, 0.003543123, 0.003587834, 0.003623553, 0.003668131, 0.003711475, 0.003759089, 0.0038025, 0.003847424, 0.003891292, 0.003939333, 0.003984853, 0.00403006, 0.004079343, 0.004126803, 0.00417572, 0.004227694, 0.004269541, 0.004316952, 0.004364783, 0.004415727, 0.004467046, 0.004519398, 0.004574272, 0.004625755, 0.00467834, 0.004731261, 0.004790355, 0.004844773, 0.004899672, 0.004954102, 0.005008321, 0.005065865, 0.005125678, 0.005185946, 0.005242005, 0.00530067, 0.00535942, 0.005423442, 0.005483337, 0.00554625, 0.005611636, 0.005672218, 0.005739257, 0.005800053, 0.005867203, 0.005927657, 0.005996269, 0.006065751, 0.006141852, 0.006217915, 0.006287729, 0.006355394, 0.006425831, 0.006498608, 0.006566091, 0.006643253, 0.006720284, 0.006800723, 0.006878689, 0.006959649, 0.007045243, 0.007129076, 0.007208403, 0.007295135, 0.0073787, 0.007460221, 0.007548922, 0.00764502, 0.00773719, 0.007823177, 0.007920985, 0.008014114, 0.008107085, 0.008195817, 0.008290218, 0.008399718, 0.008500579, 0.008595087, 0.00869057, 0.008787535, 0.008893321, 0.008997173, 0.009101655, 0.009204832, 0.00930841, 0.009419618, 0.009529949, 0.009644836, 0.009732203, 0.009753369, 0.009872621, 0.010001239, 0.010105596, 0.010224849, 0.010348911, 0.010468678, 0.010590131, 0.010713871, 0.010831679, 0.010959708, 0.011084372, 0.011212773, 0.011349906, 0.011477108, 0.011612292, 0.011752188, 0.011876578, 0.012015782, 0.012164229, 0.012308984, 0.012448955, 0.012593118, 0.012736479, 0.012884089, 0.01302912, 0.013172017, 0.013321327, 0.013477562, 0.013633515, 0.013786587, 0.013947586, 0.014114776, 0.014279578, 0.014448141, 0.014613965, 0.014787641, 0.014954839, 0.01513954, 0.015313284, 0.015487373, 0.01566419, 0.015845022, 0.016029482, 0.01621414, 0.016407936, 0.016607842, 0.016807044, 0.016997585, 0.017196331, 0.017398729, 0.017611989, 0.017821983, 0.018040877, 0.018235352, 0.018444692, 0.018660641, 0.0188686, 0.019091658, 0.019315847, 0.019542469, 0.019766496, 0.019989686, 0.020224088, 0.020463392, 0.020693516, 0.020927082, 0.021177022, 0.021433357, 0.021679765, 0.021931464, 0.022182028, 0.022443883, 0.022698857, 0.022968803, 0.023235849, 0.023504034, 0.023774381, 0.02405783, 0.024340156, 0.024621945, 0.024908732, 0.025187977, 0.025491747, 0.025788609, 0.026096511, 0.026402192, 0.026699354, 0.026994529, 0.027311611, 0.027639651, 0.027956998, 0.028291412, 0.028634313, 0.028965138, 0.029311339, 0.029648234, 0.029998201, 0.03034332, 0.030702186, 0.031052829, 0.031417265, 0.031784407, 0.032169706, 0.032549544, 0.032938366, 0.033327378, 0.033704401, 0.034105844, 0.034497567, 0.034887289, 0.035301499, 0.035701939, 0.036113386, 0.036528249, 0.036957822, 0.037384029, 0.037822902, 0.03826398, 0.038713053, 0.039176135, 0.039622776, 0.040083857, 0.040556416, 0.041041214, 0.041514883, 0.042008619, 0.042503806, 0.042991733, 0.043489954, 0.044004042, 0.044538253, 0.045034, 0.045554199, 0.046091627, 0.046646091, 0.04718862, 0.047715135, 0.048271222, 0.048844693, 0.049410007, 0.049980481, 0.050550677, 0.051138066, 0.051735984, 0.052327678, 0.052924346, 0.053529954, 0.054170371, 0.054805875, 0.055442472, 0.056084441, 0.05672317, 0.057392575, 0.058068681, 0.058735359, 0.059414269, 0.060124658, 0.060842672, 0.061580211, 0.062298397, 0.063051539, 0.063787213, 0.064537366, 0.065283842, 0.066047875, 0.066822007, 0.067607635, 0.068394006, 0.069204212, 0.070021073, 0.070862005, 0.071699313, 0.072527276, 0.073378054, 0.074230993, 0.075111618, 0.076012259, 0.076915538, 0.077806951, 0.078737246, 0.079697082, 0.080632591, 0.08162023, 0.082572133, 0.08353105, 0.084517055, 0.085501063, 0.086501146, 0.087521842, 0.088539982, 0.089576696, 0.090640562, 0.091686375, 0.092757534, 0.093844297, 0.094939967, 0.09605792, 0.097178582, 0.098366153, 0.09930958, 0.09955393, 0.100739591, 0.10194473, 0.103132352, 0.104364977, 0.105566312, 0.106822762, 0.10805741, 0.109337794, 0.110628089, 0.111972316, 0.113322227, 0.114657834, 0.116019013, 0.117392826, 0.11876706, 0.120177467, 0.121587343, 0.123032361, 0.124523154, 0.126016455, 0.127504056, 0.129004872, 0.130540134, 0.132120996, 0.133677661, 0.135278693, 0.13691735, 0.13854684, 0.140232394, 0.141891028, 0.143606851, 0.14532046, 0.147029056, 0.14877237, 0.150556234, 0.15234505, 0.154140328, 0.155956008, 0.157817737, 0.159682892, 0.161573687, 0.163512694, 0.165491328, 0.167508428, 0.16955935, 0.171581228, 0.173626931, 0.175701721, 0.177812212, 0.17996001, 0.182098969, 0.184282445, 0.186512792, 0.188790872, 0.191052012, 0.193340662, 0.195666988, 0.198038625, 0.200448685, 0.202871575, 0.205343514, 0.207840608, 0.210379608, 0.212956005, 0.215515282, 0.218160845, 0.220802515, 0.223516542, 0.226226438, 0.229024412, 0.231829033, 0.234691177, 0.237593271, 0.240490256, 0.243438996, 0.246406163, 0.249422885, 0.252455544, 0.255570192, 0.258713575, 0.26187484, 0.265095762, 0.26833329, 0.271603272, 0.274917043, 0.278308496, 0.281758521, 0.285235408, 0.288788575, 0.292351928, 0.295932063, 0.299550269, 0.30325344, 0.30701843, 0.310838386, 0.311680668, 0.314673337, 0.318581629, 0.322523756, 0.326547269, 0.330595112, 0.334718944, 0.33887486, 0.343095843, 0.347379217, 0.351737477, 0.356156686, 0.360651878, 0.36518786, 0.369767332, 0.374453753, 0.379175528, 0.383937526, 0.388814883, 0.39376857, 0.398792481, 0.403858897, 0.408899773, 0.414086162, 0.419343747, 0.42465002, 0.42574664, 0.430098158, 0.435497752, 0.441071309, 0.446701504, 0.452391074, 0.458108375, 0.463941611, 0.469950407, 0.475986986, 0.482110283, 0.488339593, 0.494688845, 0.501103207, 0.507706893, 0.514272349, 0.521008376, 0.527765433, 0.534638599, 0.541597767, 0.548754525, 0.555972659, 0.56330119, 0.570711414, 0.578260546, 0.585912212, 0.593761274, 0.601576555, 0.609635624, 0.617823499, 0.626048753, 0.63450087, 0.643074274, 0.651724749, 0.660623167, 0.669647466, 0.673451769, 0.67874401, 0.687926369, 0.697332342, 0.706911912, 0.716668348, 0.726507986, 0.736562899, 0.746839561, 0.757253651, 0.767763594, 0.778433226, 0.789242022, 0.800339231, 0.811580185, 0.823005571, 0.834630958, 0.846464603, 0.858596075, 0.87101139, 0.883512883, 0.896233922, 0.909236815, 0.922419484, 0.935872624, 0.949670262, 0.955440208, 0.963692301, 0.977790598, 0.992319429, 1.007124351, 1.022177732, 1.037513126, 1.053179588, 1.069160185, 1.085420373, 1.102105374, 1.119119883, 1.136326101, 1.154039419, 1.172026647, 1.190625736, 1.209479766, 1.228713788, 1.248339713, 1.268419464, 1.284573287, 1.321639362, 1.342272788, 1.362982694, 1.383557776, 1.404172208, 1.424717429, 1.445346956, 1.466109536, 1.486743558, 1.50731015, 1.527901032, 1.548570269, 1.569160195, 1.589818618, 1.610373325, 1.630926231, 1.651296888, 1.6717993, 1.683985695, 1.692470813, 1.713058868, 1.733561761, 1.754068315, 1.774671533, 1.795251148, 1.815888073, 1.836465441, 1.857220372, 1.877883177, 1.898644687, 1.919343311, 1.940040504, 1.960783269, 1.981272282, 2.001958552, 2.022493137, 2.043221768, 2.064102652, 2.084688097, 2.105348588, 2.125878877, 2.146750614, 2.167517857, 2.188262054, 2.200339442, 2.209150257, 2.229922151, 2.250779745, 2.271510262, 2.292365533, 2.313091359, 2.333993595, 2.355093362, 2.37601713, 2.397002683, 2.417999798, 2.439139822, 2.460261012, 2.48130311, 2.502156437, 2.523542037, 2.544661658, 2.565841366, 2.586674902, 2.607832329, 2.629271917, 2.650655046, 2.67168481, 2.693133031, 2.714260852, 2.735529673, 2.757065259, 2.77859457, 2.799976656, 2.82139857, 2.842790766, 2.864028486, 2.885699258, 2.907258302, 2.929147849, 2.946180164, 2.950752243, 2.972720065, 2.994601921, 3.016672139, 3.038656344, 3.060818347, 3.082813812, 3.104965901, 3.127013767, 3.149260912, 3.171504942, 3.193858861, 3.2162127, 3.238628307, 3.260908359, 3.28336206, 3.305656622, 3.32802014, 3.350363301, 3.372636555, 3.395329315, 3.418168983, 3.440874391, 3.463512199, 3.48658826, 3.504469608, 3.509562085, 3.53241123, 3.555374175, 3.578673729, 3.601990387, 3.625083391, 3.648260501, 3.671710265, 3.695146217, 3.718529478, 3.742065682, 3.765631529, 3.789165666, 3.812906431, 3.836868473, 3.860997857, 3.884929784, 3.909061313, 3.933240899, 3.957446023, 3.981430549, 4.005536511, 4.029852826, 4.054606346, 4.079111314, 4.103872024, 4.128593247, 4.15341375, 4.178151025, 4.203117016, 4.22830198, 4.253041353, 4.278538093, 4.303947437, 4.329276012, 4.35471727, 4.380527794, 4.406411084, 4.431938335, 4.457783404, 4.483829115, 4.510179523, 4.536371088, 4.563108387, 4.589343527, 4.616078711, 4.641845068, 4.668366153, 4.694623603, 4.721344721, 4.748186031, 4.774970427, 4.801900909, 4.829124922, 4.856471319, 4.884234435, 4.912157482, 4.93986162, 4.967664893, 4.995252061, 5.023271175, 5.05136667, 5.079754205, 5.107768971, 5.136233292, 5.164382591, 5.193800929, 5.223264227, 5.252421698, 5.281439149, 5.310579708, 5.340026948, 5.369766026, 5.399875459, 5.430239327, 5.459964812, 5.490118474, 5.520173935, 5.550437788, 5.580372518, 5.610513218, 5.641549577, 5.672279615, 5.703207627, 5.733745963, 5.764776724, 5.796226147, 5.827932334, 5.859777139, 5.892006702, 5.923903596, 5.955564198, 5.988000023, 6.020788212, 6.053347654, 6.085829355, 6.092458146, 6.119485946, 6.152368204, 6.18497756, 6.219272103, 6.253143057, 6.287258207, 6.320964193, 6.355056044, 6.389817216, 6.423600284, 6.458056725, 6.493014459, 6.526972482, 6.561279225, 6.596212589, 6.631986246, 6.667439185, 6.702988837, 6.737537991, 6.774032075, 6.810035283, 6.845477207, 6.881774115, 6.918132893, 6.954506569, 6.990622635, 7.027203853, 7.064007537, 7.101599088, 7.137714009, 7.175196264, 7.212979989, 7.250432895, 7.288135691, 7.325505591, 7.364112319, 7.402237568, 7.441408991, 7.479538909, 7.519254155, 7.558502738, 7.596909745, 7.635898125, 7.675591236, 7.71522184, 7.754434236, 7.793762139, 7.833612765, 7.873658911, 7.914049403, 7.954950937, 7.995005268, 8.03475742, 8.07464853, 8.114760601, 8.155643333, 8.197054627, 8.238720786, 8.279884155, 8.321561683, 8.365412223, 8.408735198, 8.451301333, 8.493771736, 8.536356254, 8.577114604, 8.620044556, 8.660700068, 8.703769188, 8.747156516, 8.789871, 8.834265227, 8.878548959, 8.923838216, 8.967494432, 9.010749257, 9.05733793, 9.102325008, 9.146125483, 9.191856802, 9.240260057, 9.285359264, 9.329607027, 9.374516915, 9.419639637, 9.464845975, 9.509167384, 9.555804173, 9.600952891, 9.646896998, 9.694008777, 9.740328458, 9.78682622, 9.832579076, 9.87879154, 9.927539069, 9.97430561, 10.02186452, 10.071087239, 10.119248981, 10.170338348, 10.220149125, 10.268403035, 10.316606051, 10.365110346, 10.413777061, 10.461853065, 10.510402409, 10.560750472, 10.610620211, 10.660012871, 10.710360265, 10.760990028, 10.808423607, 10.856726494, 10.906510564, 10.957801798, 11.008168817, 11.057974289, 11.109290872, 11.161157479, 11.210586146, 11.264079576, 11.314258283, 11.366590084, 11.417608699, 11.468715011, 11.522585336, 11.574983983, 11.625973118, 11.678095491, 11.728874727, 11.781379003, 11.832272762, 11.88613428, 11.940300589, 11.991479917, 12.044033727, 12.097139726, 12.149169323, 12.201442842, 12.256681731, 12.311959977, 12.364127735, 12.418561934, 12.474139204, 12.525817559, 12.581844148, 12.636539851, 12.695379832, 12.751402927, 12.807027106, 12.865752819, 12.923426872, 12.978686201, 13.036804073, 13.091074293, 13.144753943, 13.20309434, 13.258738372, 13.313410092, 13.370522317, 13.42992948, 13.48777027, 13.546099945, 13.602302127, 13.659976091, 13.718611013, 13.778944643, 13.836824804, 13.892893069, 13.951240969, 14.008323966, 14.065578153, 14.122786617, 14.18338984, 14.247440683, 14.309038672, 14.367322104, 14.421583202, 14.481870146, 14.541091579, 14.599444127, 14.657918123, 14.720336414, 14.783480528, 14.844676767, 14.909272396, 14.974679383, 15.035148549, 15.101607485, 15.166862086, 15.233456369, 15.297882842, 15.364401176, 15.427923517, 15.491143719, 15.551126027, 15.611360062, 15.676272864, 15.688788981, 15.738177819, 15.805231793, 15.868125519, 15.936280487, 15.996160302, 16.062882312, 16.126102437, 16.189001821, 16.253005339, 16.316881228, 16.38219183, 16.452607623, 16.520149576, 16.586930477, 16.650767363, 16.716649427, 16.787081275, 16.851178118, 16.915573691, 16.986815594, 17.046213355, 17.112507303, 17.182867894, 17.258674628, 17.32847402, 17.397945902, 17.467722045, 17.531480952, 17.60154609, 17.675351224, 17.748197248, 17.811500605, 17.876363856, 17.95514218, 18.027542112, 18.098793132, 18.168009851, 18.233302712, 18.301314188, 18.380448017, 18.446667317, 18.515106497, 18.585673658, 18.658280829, 18.728630739, 18.79793989, 18.868606947, 18.937077452, 19.005572935, 19.068236117, 19.139257452, 19.213528516, 19.293014909, 19.361923595, 19.437547106, 19.51859661, 19.594194941, 19.671706302, 19.750447928, 19.815661015, 19.894181786, 19.964643477, 20.043222981, 20.11968579, 20.192526802, 20.26811786, 20.344141639, 20.424038024, 20.49609047, 20.575278341, 20.649487876, 20.725433715, 20.800636703, 20.87475852, 20.956674609, 21.039976212, 21.11946536, 21.194307988, 21.267459395, 21.345332688, 21.4201833, 21.498029434, 21.581756309, 21.653618184, 21.729477883, 21.815030515, 21.890799323, 21.975475034, 22.055556787, 22.137696914, 22.221375531, 22.302854579, 22.38647792, 22.469143506, 22.553970771, 22.630862482, 22.711567994, 22.794066681, 22.872643651, 22.946196787, 23.028839616, 23.116275591, 23.20718837, 23.30125571, 23.381125252, 23.470297797, 23.553918784, 23.639891105, 23.722692867, 23.802456031, 23.883410805, 23.976649417, 24.065167977, 24.16828007, 24.283107438, 24.37288418, 24.45705714, 24.553748468, 24.647664343, 24.727967718, 24.824199026, 24.911756746, 24.997690662, 25.095568321, 25.183765455, 25.273868154, 25.360616958, 25.437108589, 25.521000882, 25.616168891, 25.700834515, 25.767479136, 25.856350786, 25.951573089, 26.029939764, 26.109312557, 26.205400367, 26.290803909, 26.394082449, 26.498194169, 26.593068061, 26.68053386, 26.778906424, 26.87187343, 26.958317208, 27.05604682, 27.152114947, 27.250965719, 27.322918754, 27.397707899, 27.488660848, 27.574933427, 27.687431023, 27.826490326, 27.933988634, 28.026068067, 28.123089268, 28.211508468, 28.292108244, 28.40770038, 28.523512805, 28.610398375, 28.702910603, 28.809385108, 28.920854669, 29.020639831, 29.10249943, 29.190488635, 29.294813102, 29.391177183, 29.478205221, 29.584203651, 29.708322482, 29.796443266, 29.90685421, 30.024465906, 30.147896591, 30.244801941, 30.321304184, 30.432348724, 30.541558986, 30.633427483, 30.741421127, 30.859838638, 30.952433423, 31.045138958, 31.149805426, 31.250755119, 31.354462958, 31.485599219, 31.612786368, 31.713272641, 31.823166156, 31.959267657, 32.048982105, 32.150148017, 32.262405687, 32.375226177, 32.472261857, 32.556845977, 32.579439537, 32.652378611, 32.770832365, 32.926519411, 33.0698871, 33.174325964, 33.325934711, 33.452925667, 33.58132586, 33.72897591, 33.833433927, 33.940992988, 34.081508598, 34.202566363, 34.31729451, 34.442211032, 34.538608894, 34.656003856, 34.736329629, 34.851079948, 34.954199931, 35.08209198, 35.194321886, 35.295039325, 35.390833875, 35.482731847, 35.606794616, 35.719633662, 35.844736725, 35.966767873, 36.096817642, 36.235677461, 36.344762266, 36.450605921, 36.556068723, 36.661544707, 36.784236709, 36.924255998, 37.020517356, 37.136820491, 37.211736102, 37.337083101, 37.45197252, 37.583901629, 37.709131502, 37.846322928, 37.980336628, 38.10136568, 38.189401999, 38.307848573, 38.459911387, 38.577783057, 38.680748082, 38.800734057, 38.953377846, 39.087798509, 39.220065532, 39.33046205, 39.437779151, 39.587205046, 39.694632064, 39.850918062, 39.964820334, 40.050171844, 40.218076174, 40.391751673, 40.509948263, 40.625621617, 40.758439512, 40.921556903, 41.02538218, 41.15638064, 41.28440626, 41.421204114, 41.543248896, 41.677606339, 41.805604604, 41.99173644, 42.113656218, 42.229028819, 42.354421234, 42.470063385, 42.565830989, 42.674902611, 42.835707567, 42.963450727, 43.116212286, 43.220941839, 43.349999963, 43.467051436, 43.622608002, 43.739359743, 43.861585363, 43.981756383, 44.055050028, 44.172141648, 44.286492039, 44.41799461, 44.563047498, 44.690258344, 44.792321106, 44.948511483, 45.129020465, 45.236866212, 45.380872636, 45.481569175, 45.587261257, 45.723941197, 45.815994898, 45.994982967, 46.155507591, 46.300439285, 46.525311516, 46.745955337, 46.834397609, 46.9759107, 47.127268236, 47.256851593, 47.343882945, 47.469767794, 47.590042276, 47.704004602, 47.842224752, 47.965281196, 48.130880661, 48.249598292, 48.414075931, 48.508881882, 48.613717357, 48.696960346, 48.903444337, 49.015990933, 49.269755065, 49.463911846, 49.592440362, 49.725988258, 49.841233547, 50.021015081, 50.19713033, 50.374835085, 50.529856958, 50.783723907, 51.061421949, 51.206029168, 51.400599599, 51.489432924, 51.605883774, 51.761362833, 51.93454465, 52.165021094, 52.293927755, 52.374530163, 52.509759374, 52.647606807, 52.807475207, 52.972900934, 53.224596514, 53.402449521, 53.513920131, 53.61306836, 53.749342772, 53.890570831, 54.057048744, 54.146160941, 54.236195145, 54.482788839, 54.580983189, 54.863526418, 55.113865761, 55.262274549, 55.408646429, 55.613969193, 55.692846575, 55.857414341, 55.925698066, 56.073820325, 56.217187679, 56.305445012, 56.472038969, 56.565442188, 56.912445348, 57.178476351, 57.303349524, 57.580141994, 57.801895371, 57.891361588, 58.087076905, 58.397744804, 58.574840465, 58.772743036, 58.965996171, 59.093217119, 59.25062406, 59.493871632, 59.771810995, 60.047577313, 60.174698933, 60.429835294, 60.570693981, 60.83587879, 61.055046613, 61.411802903, 61.537326941, 61.737380689, 61.811396205, 62.05833106, 62.292763054, 62.408802675, 62.495176099, 62.657041983, 62.75375763, 62.979816993, 63.124716489, 63.343134876, 63.544214773, 63.690019088, 63.877477271, 64.079216847, 64.345686683, 64.517202053, 64.751400444, 64.938097741, 65.250508374, 65.386393998, 65.751598488, 65.9370796, 66.201001133, 66.416031694, 66.75376154, 66.878536523, 66.990974981, 67.130480494, 67.2040714, 67.326438866, 67.441642871, 67.636025211, 68.054447254, 68.176630802, 68.511974182, 68.644317239, 68.794866624, 68.995827568, 69.168872399, 69.519025161, 69.640821428, 69.740916418, 69.880351356, 70.164464237, 70.35480103, 70.394126052, 70.479649804, 70.614052871, 70.955358349, 71.199471438, 71.609215262, 71.65558816, 71.827032225, 71.932431278, 72.219496937, 72.354165379, 72.428538236, 72.525042598, 72.569267777, 72.687652999, 72.854233513, 73.273157871, 73.41170583, 73.7820163, 73.858262564, 74.198313466, 74.250389328, 74.380197959, 74.422749945, 74.664260877, 74.954266994, 75.189406521, 75.371494657, 75.561270458, 75.74400318, 76.038301527, 76.083965641, 76.585055223, 76.728008585, 76.823534319, 77.109007087, 77.526347613, 77.741686544, 77.932022, 78.109018685, 78.290622628, 78.40670286, 78.642369516, 78.772056863, 79.085083227, 79.41920218, 79.746599796, 79.876978945, 79.89027833, 79.986354038, 80.192640924, 80.220118074, 80.228772874, 80.342773432, 80.604354208, 80.805180304, 80.984728073, 81.307549957, 81.311944457, 81.465300195, 81.563148052, 81.639796217, 81.666937949, 81.850788785, 82.207255894, 82.325674477, 82.63091307, 82.856215301, 83.195624484, 83.202771087, 83.510743103, 83.57616216, 84.072782868, 84.252073469, 84.364236645, 84.629921624, 84.746423784, 84.886318259, 84.912137754, 85.014864268, 85.067113038, 85.320290885, 85.458397964, 85.599074607, 85.871143975, 85.925313707, 86.190437996, 86.250100145, 86.329171101, 86.693697706, 86.968610227, 86.971093193 ), "500" = c(1.97e-05, 1.9944e-05, 1.9983e-05, 2.0238e-05, 2.0244e-05, 2.0285e-05, 2.0325e-05, 2.0736e-05, 2.1091e-05, 2.1204e-05, 2.1281e-05, 2.2057e-05, 2.2115e-05, 2.229e-05, 2.2512e-05, 2.2851e-05, 2.313e-05, 2.3532e-05, 2.3571e-05, 2.368e-05, 2.3739e-05, 2.3872e-05, 2.4161e-05, 2.4179e-05, 2.4441e-05, 2.449e-05, 2.5053e-05, 2.5068e-05, 2.5197e-05, 2.5337e-05, 2.5861e-05, 2.6467e-05, 2.6514e-05, 2.6871e-05, 2.7309e-05, 2.7427e-05, 2.7442e-05, 2.8577e-05, 2.8783e-05, 2.9131e-05, 2.9258e-05, 2.954e-05, 2.9907e-05, 3.0175e-05, 3.14e-05, 3.1577e-05, 3.2466e-05, 3.274e-05, 3.3532e-05, 3.3878e-05, 3.4036e-05, 3.4207e-05, 3.4509e-05, 3.4703e-05, 3.4968e-05, 3.5446e-05, 3.5665e-05, 3.6668e-05, 3.7155e-05, 3.799e-05, 3.8296e-05, 3.8625e-05, 3.8927e-05, 3.9559e-05, 3.964e-05, 3.9812e-05, 4.0118e-05, 4.0137e-05, 4.0367e-05, 4.0492e-05, 4.1057e-05, 4.169e-05, 4.2832e-05, 4.3505e-05, 4.3596e-05, 4.3814e-05, 4.4471e-05, 4.4701e-05, 4.5484e-05, 4.6175e-05, 4.7398e-05, 4.8349e-05, 4.851e-05, 4.9741e-05, 5.0642e-05, 5.1103e-05, 5.1802e-05, 5.2618e-05, 5.3055e-05, 5.3496e-05, 5.3662e-05, 5.4177e-05, 5.4649e-05, 5.5044e-05, 5.5234e-05, 5.5743e-05, 5.6493e-05, 5.7328e-05, 5.8191e-05, 5.894e-05, 5.9704e-05, 6.1206e-05, 6.1443e-05, 6.1626e-05, 6.2086e-05, 6.3076e-05, 6.4848e-05, 6.571e-05, 6.6692e-05, 6.8113e-05, 7.0122e-05, 7.0436e-05, 7.1023e-05, 7.2005e-05, 7.2972e-05, 7.3904e-05, 7.4264e-05, 7.5809e-05, 7.7062e-05, 7.7802e-05, 7.8477e-05, 7.9415e-05, 8.022e-05, 8.1138e-05, 8.2012e-05, 8.2705e-05, 8.4549e-05, 8.4785e-05, 8.6967e-05, 8.7618e-05, 8.8601e-05, 8.9938e-05, 9.0656e-05, 9.1397e-05, 9.2234e-05, 9.2691e-05, 9.3366e-05, 9.4076e-05, 9.4667e-05, 9.5603e-05, 9.6394e-05, 9.8617e-05, 9.9596e-05, 0.00010081, 0.000102696, 0.000103561, 0.000105044, 0.000105745, 0.000107135, 0.000109165, 0.000110916, 0.000111876, 0.000112684, 0.00011353, 0.000114921, 0.000116752, 0.000118428, 0.000120226, 0.000122814, 0.000124159, 0.00012693, 0.000128407, 0.000129883, 0.000131533, 0.000133238, 0.000134704, 0.000135865, 0.000138226, 0.000139409, 0.000140705, 0.000142384, 0.000146004, 0.000149602, 0.000150779, 0.000152058, 0.000154972, 0.000156466, 0.000157537, 0.000160011, 0.000162907, 0.000164615, 0.000167151, 0.000168396, 0.000170381, 0.000172046, 0.000174711, 0.00017683, 0.000178973, 0.000180837, 0.000182141, 0.000183649, 0.000184857, 0.000186404, 0.000189918, 0.000192693, 0.000194373, 0.000197199, 0.000198555, 0.000200209, 0.000202486, 0.000205435, 0.000206989, 0.000209848, 0.000213838, 0.000216693, 0.000218422, 0.000221093, 0.00022381, 0.000225557, 0.000228925, 0.000231284, 0.0002343, 0.000237468, 0.000240286, 0.000242273, 0.000245297, 0.00024898, 0.000252378, 0.000255657, 0.000258206, 0.000260337, 0.000262056, 0.000264133, 0.000267489, 0.000269818, 0.000272336, 0.000276012, 0.000278198, 0.000282051, 0.000284641, 0.00028829, 0.000291269, 0.000294198, 0.000297389, 0.000302201, 0.000305018, 0.000308845, 0.00031323, 0.000316407, 0.000319657, 0.000322816, 0.000327732, 0.000331208, 0.000336997, 0.000340226, 0.000343539, 0.000346992, 0.00034998, 0.000352988, 0.000355662, 0.00035913, 0.000363089, 0.000367133, 0.000370487, 0.000375114, 0.000380365, 0.00038405, 0.000388166, 0.000392428, 0.000396587, 0.000401087, 0.000404903, 0.000409736, 0.000415312, 0.000419328, 0.000424049, 0.000430218, 0.000433421, 0.000438705, 0.000442534, 0.00044626, 0.000452213, 0.000458034, 0.00046298, 0.000469792, 0.000475702, 0.000482393, 0.000489115, 0.000494765, 0.00050104, 0.000506087, 0.000513102, 0.00051937, 0.000523753, 0.000531199, 0.000538758, 0.000544299, 0.000549686, 0.000553736, 0.000559418, 0.000567113, 0.00057399, 0.000581225, 0.000587304, 0.000593946, 0.000600864, 0.000606527, 0.000613226, 0.000618437, 0.000625763, 0.000634865, 0.000645351, 0.000654454, 0.000661152, 0.000670038, 0.000677093, 0.000684377, 0.000691344, 0.000697905, 0.000704475, 0.000709912, 0.000718457, 0.000725613, 0.000732882, 0.000739818, 0.000746306, 0.000754762, 0.000763565, 0.000770902, 0.000778932, 0.000787266, 0.000798047, 0.000810289, 0.00081893, 0.000828753, 0.000838138, 0.000849021, 0.000860539, 0.000869692, 0.000881994, 0.000891243, 0.000901577, 0.000912615, 0.000923754, 0.000933915, 0.00094278, 0.000955433, 0.000964704, 0.000975864, 0.000987972, 0.000996228, 0.000998289, 0.001011446, 0.001025966, 0.001038797, 0.001050427, 0.001063202, 0.001077491, 0.00109058, 0.001103811, 0.001114912, 0.001128197, 0.001139917, 0.001154491, 0.001166947, 0.001179503, 0.001191707, 0.001204658, 0.001217521, 0.001232613, 0.00124883, 0.001264102, 0.001278377, 0.001296099, 0.001309706, 0.001323689, 0.001341117, 0.001355673, 0.001371666, 0.001387257, 0.001404922, 0.001418401, 0.001434993, 0.001453185, 0.001468345, 0.001483339, 0.001498794, 0.001512723, 0.001532127, 0.001549396, 0.00156466, 0.001583566, 0.001603135, 0.001620737, 0.001636756, 0.001653349, 0.001674848, 0.001692437, 0.001713233, 0.001731685, 0.001750003, 0.001767867, 0.001790564, 0.001812403, 0.001836621, 0.001856474, 0.001876067, 0.001899063, 0.001922769, 0.001943074, 0.001967506, 0.001986681, 0.002009203, 0.002030947, 0.002054146, 0.002079176, 0.002103867, 0.002129129, 0.002153058, 0.002176376, 0.002202615, 0.002228694, 0.00225659, 0.002279068, 0.002307734, 0.002337141, 0.002362277, 0.002388474, 0.002417281, 0.002444215, 0.002471354, 0.00249934, 0.00253213, 0.002560206, 0.002586961, 0.002622037, 0.002647132, 0.002674516, 0.002706007, 0.002736184, 0.002765154, 0.002793209, 0.002819409, 0.002858238, 0.002888903, 0.00291575, 0.002948836, 0.002987097, 0.003015453, 0.003053146, 0.003089763, 0.003121222, 0.003153287, 0.003183766, 0.00322596, 0.00326276, 0.003294227, 0.003331335, 0.003370408, 0.003412199, 0.00344956, 0.003489948, 0.003533415, 0.0035732, 0.003613696, 0.003658453, 0.003701226, 0.003746879, 0.003792429, 0.003834269, 0.003877497, 0.003924373, 0.003968051, 0.004013051, 0.004059906, 0.004110375, 0.004157271, 0.004211352, 0.004260205, 0.004308627, 0.004358076, 0.004411577, 0.004461445, 0.004514042, 0.004568073, 0.004621293, 0.004677201, 0.004732631, 0.00478636, 0.004839322, 0.004895318, 0.004948547, 0.005004741, 0.005061532, 0.005115878, 0.005172406, 0.005228346, 0.00528848, 0.005349877, 0.005407188, 0.005471568, 0.005534579, 0.005599721, 0.005666649, 0.005736224, 0.005800532, 0.005869781, 0.005942246, 0.006012544, 0.006085984, 0.00615612, 0.006220708, 0.006288287, 0.006360389, 0.006444181, 0.006518026, 0.006592994, 0.006663444, 0.006744742, 0.00682145, 0.006896436, 0.006969377, 0.007047639, 0.007129305, 0.007209968, 0.007289341, 0.007370093, 0.00745556, 0.007544798, 0.007634132, 0.007722977, 0.007810447, 0.007903546, 0.007990608, 0.008085429, 0.008180621, 0.008277731, 0.008377622, 0.008474104, 0.008576991, 0.008670032, 0.00877322, 0.008875303, 0.008971242, 0.009077409, 0.009177906, 0.009278141, 0.00938234, 0.00949319, 0.009597469, 0.009710022, 0.009804856, 0.009826319, 0.009951527, 0.010063638, 0.010184044, 0.010308565, 0.010425699, 0.010547371, 0.010664089, 0.010788515, 0.010900412, 0.011023268, 0.011150013, 0.011284519, 0.011408973, 0.011541029, 0.011665342, 0.011804744, 0.011943172, 0.012088401, 0.012228158, 0.012368974, 0.012501117, 0.012653009, 0.012807731, 0.012959454, 0.013110476, 0.013252675, 0.013415943, 0.013572353, 0.013733341, 0.013892527, 0.014056672, 0.014215885, 0.014379751, 0.01455405, 0.01472471, 0.014892915, 0.015066768, 0.01523584, 0.015413346, 0.015589366, 0.01577671, 0.015957867, 0.016142334, 0.016331621, 0.016531673, 0.016720406, 0.01691199, 0.017102795, 0.017294199, 0.017481852, 0.017687483, 0.017885158, 0.018082419, 0.018306292, 0.018504279, 0.018714142, 0.018951513, 0.019171128, 0.019394184, 0.019605482, 0.019830118, 0.020058196, 0.020285916, 0.020536247, 0.02077748, 0.021033338, 0.021292928, 0.021542596, 0.021793982, 0.022050311, 0.022310138, 0.022571149, 0.022825189, 0.023091918, 0.023356528, 0.023638442, 0.023911346, 0.024198393, 0.024467791, 0.024741915, 0.025017292, 0.025304712, 0.025603532, 0.025906872, 0.026202457, 0.026498064, 0.026809601, 0.027109765, 0.02742716, 0.027750473, 0.028068445, 0.028394141, 0.028729113, 0.029079292, 0.029418175, 0.029754094, 0.030101793, 0.030442487, 0.03079557, 0.031158446, 0.031520292, 0.031881374, 0.032267385, 0.032643884, 0.033028329, 0.033409475, 0.033791961, 0.034184057, 0.034585558, 0.035002073, 0.035420676, 0.035831154, 0.036242219, 0.036679966, 0.037106225, 0.037536914, 0.037985319, 0.038445855, 0.038904837, 0.039363937, 0.039835449, 0.04030913, 0.040779193, 0.041272767, 0.041752603, 0.042243748, 0.042736618, 0.043229083, 0.043733217, 0.044241122, 0.044758646, 0.045272801, 0.04578619, 0.04632146, 0.04685639, 0.047382241, 0.047923098, 0.048490071, 0.049049804, 0.049625813, 0.050202515, 0.050780716, 0.051378455, 0.051960502, 0.052575071, 0.053189203, 0.053826321, 0.054453624, 0.055075876, 0.05572356, 0.056375629, 0.057044552, 0.057725179, 0.058391762, 0.059058433, 0.059750035, 0.060453552, 0.061177912, 0.061902092, 0.06265109, 0.063386742, 0.06412957, 0.064891575, 0.065694349, 0.066458303, 0.067262268, 0.068054507, 0.068853437, 0.069644421, 0.070476291, 0.071310045, 0.072130398, 0.072964973, 0.073838409, 0.074693518, 0.075586243, 0.076479538, 0.07738226, 0.078283726, 0.079197481, 0.080137992, 0.081091649, 0.082075983, 0.083043655, 0.084036607, 0.085041779, 0.086022798, 0.08705722, 0.088083532, 0.089127876, 0.090195634, 0.091253413, 0.092318669, 0.093437004, 0.094570048, 0.095702388, 0.096837986, 0.097973434, 0.099131808, 0.100072291, 0.100320201, 0.101513417, 0.102698149, 0.10391127, 0.105144001, 0.106412041, 0.107675654, 0.108978731, 0.110242422, 0.111575239, 0.112888246, 0.114231775, 0.115601612, 0.116990482, 0.118374852, 0.119743853, 0.121155327, 0.122596344, 0.124090471, 0.125571515, 0.127090103, 0.128599865, 0.130153986, 0.131708626, 0.133279775, 0.134857118, 0.136460305, 0.138123575, 0.139776351, 0.141443196, 0.143132084, 0.144810165, 0.146553683, 0.148333836, 0.150122392, 0.15194274, 0.153762944, 0.155631505, 0.157479967, 0.159405529, 0.16136957, 0.163315123, 0.165267465, 0.167222146, 0.169219418, 0.171244337, 0.173322507, 0.175366517, 0.177485068, 0.179655372, 0.181779709, 0.184005067, 0.186248711, 0.188497792, 0.190755255, 0.193047542, 0.1953721, 0.19777337, 0.200181484, 0.202630071, 0.205106395, 0.207572188, 0.210093357, 0.212656639, 0.215229749, 0.217861582, 0.220516809, 0.223241078, 0.225992385, 0.228733537, 0.231563725, 0.234361444, 0.237193673, 0.240155489, 0.243129407, 0.246084799, 0.249113988, 0.252164324, 0.255295566, 0.258398858, 0.261579603, 0.26476068, 0.268021502, 0.271296517, 0.274618228, 0.278014058, 0.281484027, 0.284950085, 0.288484707, 0.292138151, 0.295742103, 0.299400894, 0.303123112, 0.306901369, 0.310718428, 0.314579857, 0.315436447, 0.318519723, 0.322543976, 0.326613684, 0.330686582, 0.33479719, 0.338985599, 0.343161639, 0.347431236, 0.351822197, 0.356317594, 0.360781573, 0.365365758, 0.369930643, 0.37455834, 0.379300568, 0.384124524, 0.388936969, 0.393837002, 0.398871141, 0.403922579, 0.409105152, 0.414267633, 0.41961366, 0.42496687, 0.430485784, 0.43161693, 0.435985642, 0.441588473, 0.447261385, 0.453016587, 0.458851875, 0.464816239, 0.47075364, 0.476846005, 0.483063724, 0.489303247, 0.495588391, 0.501987382, 0.508526286, 0.515118436, 0.521876733, 0.528727072, 0.535676838, 0.542747452, 0.549916789, 0.557148928, 0.56452152, 0.572000243, 0.579656106, 0.587387097, 0.595236125, 0.603236987, 0.611435693, 0.619651933, 0.628024504, 0.636428813, 0.64499214, 0.653739987, 0.662698497, 0.671668955, 0.68084657, 0.684779376, 0.69011536, 0.699581745, 0.709248264, 0.719032737, 0.728947774, 0.739078313, 0.749368438, 0.759833201, 0.770498616, 0.781371953, 0.792353585, 0.803520229, 0.814938289, 0.826545773, 0.838274306, 0.850262924, 0.862436965, 0.874897669, 0.887557002, 0.900431277, 0.913695201, 0.927023516, 0.940679916, 0.954620249, 0.96871756, 0.974574147, 0.983079611, 0.997679643, 1.01267496, 1.027832416, 1.043368252, 1.059190054, 1.075386324, 1.091947718, 1.108820162, 1.126071813, 1.143645297, 1.161546972, 1.179774126, 1.198469917, 1.217562804, 1.237080328, 1.256978788, 1.277391382, 1.298110271, 1.314961558, 1.353460623, 1.374886945, 1.396180855, 1.417510506, 1.438840846, 1.460115682, 1.481477664, 1.502863887, 1.524250281, 1.545562548, 1.566843687, 1.588247254, 1.609545595, 1.630819739, 1.652212026, 1.673682126, 1.694856465, 1.716248928, 1.728743609, 1.737581797, 1.758736928, 1.780027218, 1.801316787, 1.822756027, 1.844278817, 1.865711095, 1.886938482, 1.908424436, 1.930113413, 1.951484823, 1.972931702, 1.994484026, 2.015789811, 2.037349815, 2.058802054, 2.080236793, 2.101721081, 2.123306575, 2.144636665, 2.166227664, 2.187660963, 2.209191036, 2.230746412, 2.252247027, 2.264608035, 2.273756135, 2.295308987, 2.316960761, 2.338495179, 2.360032016, 2.381912198, 2.403518422, 2.424948846, 2.446526922, 2.468108272, 2.489726773, 2.511382009, 2.533013014, 2.554678881, 2.576414699, 2.598193546, 2.619787737, 2.641339168, 2.663088069, 2.684731333, 2.70643649, 2.728393448, 2.750123736, 2.771934097, 2.793887825, 2.815750151, 2.837626829, 2.859596351, 2.881707041, 2.903873094, 2.925836544, 2.94787248, 2.970031409, 2.99217461, 3.014345616, 3.03208964, 3.036671758, 3.059046279, 3.081248763, 3.1035679, 3.12588334, 3.148244279, 3.170573832, 3.192853822, 3.215451041, 3.237747304, 3.260133041, 3.28246644, 3.304824738, 3.327143631, 3.349999192, 3.372479787, 3.395179266, 3.417749455, 3.440487879, 3.462971172, 3.485836225, 3.508663951, 3.531701586, 3.554634357, 3.577584154, 3.595245373, 3.600315073, 3.623523079, 3.646603142, 3.669440499, 3.692714006, 3.716102105, 3.739199875, 3.762576909, 3.785862635, 3.809221213, 3.832675143, 3.856137632, 3.879687524, 3.903029091, 3.926871056, 3.950344083, 3.974185554, 3.997658432, 4.021526295, 4.045251112, 4.069206659, 4.093399884, 4.117153396, 4.141151445, 4.16496735, 4.189201653, 4.21347343, 4.23762429, 4.261841505, 4.286341501, 4.310675139, 4.335179354, 4.359468648, 4.383783194, 4.408380545, 4.433551277, 4.458696924, 4.483077203, 4.507982505, 4.532737691, 4.557976931, 4.582652438, 4.607772282, 4.632611069, 4.657710626, 4.682934654, 4.708236048, 4.733691499, 4.759325542, 4.784381534, 4.809745331, 4.835335399, 4.86032553, 4.886197688, 4.912344972, 4.93782563, 4.963898939, 4.989883119, 5.015829429, 5.042736522, 5.068829712, 5.095698305, 5.122685583, 5.149148733, 5.176081124, 5.202689278, 5.230032404, 5.25653991, 5.283066239, 5.31006036, 5.337150202, 5.364856513, 5.391422672, 5.418294959, 5.445206121, 5.472665132, 5.500604861, 5.528373943, 5.556043246, 5.583358897, 5.611603446, 5.63963887, 5.667275979, 5.695262699, 5.724193194, 5.75270062, 5.781740196, 5.810958605, 5.840624419, 5.869167608, 5.897674599, 5.926443407, 5.955914816, 5.985315264, 6.014549632, 6.043728889, 6.049655438, 6.07292758, 6.102373632, 6.132204144, 6.162200589, 6.191102907, 6.221486434, 6.251129691, 6.281926125, 6.312207541, 6.34289062, 6.373207948, 6.403852959, 6.434823335, 6.465140737, 6.496311001, 6.528421081, 6.559358266, 6.590335719, 6.621238519, 6.652888703, 6.684748067, 6.716725626, 6.747804056, 6.780452514, 6.812444437, 6.844583081, 6.877323886, 6.910149748, 6.943783461, 6.975607308, 7.007954351, 7.040786757, 7.073987297, 7.107190663, 7.14057606, 7.17325032, 7.207333647, 7.240147458, 7.275012567, 7.308373545, 7.342467284, 7.376980257, 7.411720302, 7.445263375, 7.479858674, 7.514062765, 7.548456853, 7.584222237, 7.620034162, 7.653837768, 7.688398246, 7.723817438, 7.758375198, 7.792585746, 7.829135064, 7.864587114, 7.900083837, 7.935229632, 7.971195855, 8.007451713, 8.043261435, 8.080101646, 8.117274938, 8.153552797, 8.190161448, 8.227582119, 8.264812378, 8.30237384, 8.339235792, 8.376005909, 8.413187647, 8.450019308, 8.486229476, 8.52355978, 8.561429162, 8.598826978, 8.635277298, 8.672974254, 8.711490584, 8.749096205, 8.787616235, 8.826184791, 8.864413402, 8.90244856, 8.941071731, 8.980620649, 9.020017893, 9.060321991, 9.099480893, 9.139955826, 9.178350701, 9.217803088, 9.25831286, 9.298756437, 9.338514827, 9.379766641, 9.419698892, 9.461694392, 9.501706771, 9.541884484, 9.584348095, 9.626121558, 9.666595918, 9.708971148, 9.751851482, 9.793636981, 9.834655135, 9.877370026, 9.917993769, 9.95939969, 10.000303379, 10.042298134, 10.087097681, 10.130225649, 10.17424344, 10.218876053, 10.261360957, 10.303065821, 10.345419129, 10.389759186, 10.43209536, 10.473429145, 10.517403399, 10.561713836, 10.605322388, 10.648439138, 10.692552509, 10.734681247, 10.778158291, 10.824499998, 10.870063643, 10.916230157, 10.962806112, 11.006263664, 11.050800143, 11.092996119, 11.135127693, 11.181092262, 11.227555561, 11.270805372, 11.315460124, 11.360598234, 11.405571661, 11.450047618, 11.498209635, 11.543342618, 11.590228471, 11.635567596, 11.682601089, 11.72947624, 11.77632491, 11.824852059, 11.869456739, 11.917888379, 11.963890266, 12.010741397, 12.057600952, 12.107167418, 12.152821429, 12.198587396, 12.247742336, 12.29096171, 12.338659361, 12.386763156, 12.432677794, 12.479559076, 12.528434359, 12.575431976, 12.62285412, 12.67184735, 12.721492224, 12.771738615, 12.822260367, 12.873978099, 12.923227915, 12.974567607, 13.025770448, 13.075069278, 13.128010097, 13.176756879, 13.225490267, 13.275210678, 13.327460415, 13.377245568, 13.427565442, 13.480206394, 13.531701093, 13.582942734, 13.634294081, 13.683198379, 13.734206582, 13.788302286, 13.843154494, 13.894021613, 13.943224657, 13.993044985, 14.042461523, 14.096946715, 14.14900589, 14.20063466, 14.211196745, 14.253395282, 14.303325663, 14.356659649, 14.413074136, 14.464604646, 14.517272678, 14.567619326, 14.620637942, 14.676135821, 14.728504125, 14.780923879, 14.834070033, 14.88805798, 14.938942139, 14.990469544, 15.044076032, 15.099953233, 15.156412884, 15.214235817, 15.271213138, 15.325798609, 15.378597177, 15.438135445, 15.491867021, 15.543077721, 15.599954339, 15.655099226, 15.708897669, 15.766123228, 15.824043884, 15.879576539, 15.939120348, 15.992220692, 16.044966872, 16.101306686, 16.161617882, 16.216714661, 16.272656164, 16.329363337, 16.387933775, 16.449113047, 16.505669995, 16.555903753, 16.610588781, 16.672664881, 16.729278013, 16.78697127, 16.838599093, 16.895893754, 16.956822843, 17.018039892, 17.084414287, 17.143379198, 17.200685619, 17.259229469, 17.321749126, 17.381149615, 17.443208858, 17.503905954, 17.560281903, 17.614933678, 17.681351405, 17.74221697, 17.802667037, 17.858522943, 17.917738437, 17.97863753, 18.037817944, 18.098155391, 18.159425683, 18.211840657, 18.27526074, 18.33692478, 18.396258526, 18.458238818, 18.514456863, 18.573363424, 18.636278843, 18.698026625, 18.758652828, 18.819790183, 18.885907793, 18.947757511, 19.015342568, 19.071780516, 19.130766847, 19.190779655, 19.250576806, 19.307703312, 19.37973949, 19.444307555, 19.513320431, 19.578422798, 19.641058076, 19.701525268, 19.765950912, 19.831485681, 19.898244367, 19.970120491, 20.040461079, 20.113085378, 20.182634957, 20.250021823, 20.316093874, 20.385526512, 20.452960709, 20.528490799, 20.590835456, 20.657576237, 20.734601163, 20.796432382, 20.857074999, 20.924296268, 20.981758081, 21.050520711, 21.101586835, 21.169267627, 21.23809613, 21.307697124, 21.375825204, 21.439853831, 21.505956285, 21.573004444, 21.643790428, 21.712069434, 21.778388207, 21.849227372, 21.922472106, 21.99394987, 22.067064639, 22.133753656, 22.206486166, 22.279696782, 22.353360427, 22.425205731, 22.503982638, 22.588001214, 22.660306287, 22.719754145, 22.784789866, 22.845650145, 22.917175247, 22.98864013, 23.058736717, 23.126449875, 23.206097285, 23.281201599, 23.353807142, 23.438471345, 23.513137164, 23.581148347, 23.651792828, 23.720141593, 23.789544528, 23.865779724, 23.936527792, 24.020555006, 24.107845845, 24.199307866, 24.263359017, 24.347087384, 24.4346385, 24.507818781, 24.571974714, 24.646841362, 24.710487497, 24.783059591, 24.856796319, 24.950652825, 25.042550922, 25.123896877, 25.193670372, 25.274957094, 25.349462172, 25.435576491, 25.51316589, 25.586882888, 25.657849681, 25.756303689, 25.835507009, 25.907729142, 25.994210371, 26.075654291, 26.156078657, 26.237219479, 26.323004184, 26.392211925, 26.467561447, 26.538090853, 26.617539618, 26.686705331, 26.769525404, 26.856198329, 26.928412953, 27.013049688, 27.094563009, 27.172581464, 27.248735817, 27.326394553, 27.416558689, 27.431447543, 27.48948758, 27.56575701, 27.637779629, 27.727198467, 27.819583175, 27.89072311, 27.967084764, 28.044717681, 28.132956826, 28.206619771, 28.28977456, 28.38057562, 28.457359878, 28.535054562, 28.609218937, 28.70687242, 28.798699172, 28.87704667, 28.94972847, 29.045949652, 29.116868084, 29.207316102, 29.281657173, 29.365005391, 29.45307, 29.538765423, 29.609066235, 29.666093065, 29.747033087, 29.823210163, 29.910621168, 29.985310853, 30.069042216, 30.193806117, 30.286142091, 30.349338339, 30.433071836, 30.533425606, 30.629249697, 30.718788208, 30.816179692, 30.931175554, 31.021387436, 31.110903951, 31.202371237, 31.271299302, 31.379835205, 31.486582745, 31.570969892, 31.68538211, 31.781328558, 31.863820266, 31.947949911, 32.028391635, 32.103321532, 32.171981007, 32.24530075, 32.333256798, 32.443546143, 32.53381135, 32.617076506, 32.725431383, 32.810984415, 32.910608235, 32.973158191, 33.088711761, 33.192357766, 33.283193512, 33.371393106, 33.475948005, 33.559347219, 33.658391025, 33.750009475, 33.818083105, 33.90824308, 33.9838755, 34.080877763, 34.146295692, 34.250507807, 34.371608214, 34.476316879, 34.533721491, 34.640746452, 34.749101717, 34.863275024, 34.964454776, 35.050573054, 35.123931035, 35.207383079, 35.295835004, 35.380436979, 35.47389825, 35.607238842, 35.703077944, 35.777426108, 35.880933773, 35.964963294, 36.074860653, 36.24639341, 36.308937188, 36.412852652, 36.520897541, 36.614058124, 36.678693471, 36.825285754, 36.911731444, 37.00304522, 37.103617561, 37.240839212, 37.324188178, 37.442605899, 37.594380244, 37.689401444, 37.783864425, 37.868888391, 37.965533896, 38.032190738, 38.121662374, 38.216231759, 38.32931494, 38.485550915, 38.587984541, 38.741413355, 38.834721886, 38.942599059, 39.049938067, 39.157737534, 39.275502717, 39.397776124, 39.481108636, 39.566361926, 39.655743772, 39.761800044, 39.846485686, 39.925713715, 40.038230526, 40.164410971, 40.261000263, 40.372527731, 40.472335121, 40.583788392, 40.670698911, 40.791787272, 40.912643027, 41.104750893, 41.228516347, 41.342489963, 41.511861814, 41.608119358, 41.780778758, 41.926089127, 42.081861777, 42.202222703, 42.264025815, 42.445242848, 42.541322329, 42.657827999, 42.77568877, 42.823277773, 42.935205122, 43.025586067, 43.129570971, 43.205017138, 43.271345137, 43.462115004, 43.60013578, 43.756092841, 43.938932433, 44.149401556, 44.264182962, 44.434910694, 44.581969545, 44.703570962, 44.796600856, 44.947405349, 45.089628008, 45.267919786, 45.36112533, 45.608989372, 45.715181997, 45.8500343, 45.944624804, 46.131300224, 46.258716502, 46.355977484, 46.438045156, 46.595332139, 46.667334279, 46.775681755, 46.91836877, 47.006755457, 47.123090488, 47.308801367, 47.535576793, 47.649553016, 47.781304591, 47.898501697, 47.999404392, 48.102567936, 48.25556793, 48.450372783, 48.504637579, 48.651699065, 48.69032531, 48.862987574, 48.997370434, 49.128709174, 49.222352914, 49.44965026, 49.58989109, 49.774413399, 49.893380294, 49.988531117, 50.050008469, 50.108822427, 50.204190817, 50.307292073, 50.522654511, 50.612358502, 50.677841791, 50.869632516, 51.050259049, 51.108077675, 51.204289716, 51.387720181, 51.542672449, 51.620595912, 51.782608466, 51.891135673, 52.021941434, 52.141056866, 52.208811497, 52.369019918, 52.491592533, 52.690732579, 52.913379394, 52.986028544, 53.027035955, 53.077566526, 53.185383664, 53.243235923, 53.299567343, 53.414008843, 53.564701117, 53.883016079, 53.950198336, 54.054204705, 54.206611743, 54.376925407, 54.43146155, 54.457764314, 54.621225025, 54.77791546, 54.846948549, 54.982962435, 55.076132239, 55.186184502, 55.406078433, 55.517433791, 55.542549545, 55.652733031, 55.857984019, 56.002805709, 56.084355346, 56.141074618, 56.657298498, 56.785265565, 56.939642344, 56.998013267, 57.040987899, 57.309535748, 57.337197562, 57.36815285, 57.555620079, 57.668623466, 57.69157889, 58.067514642, 58.287528205, 58.360098721, 58.585726772, 58.802189428, 59.020926565, 59.120140031, 59.229413804, 59.37564499, 59.509482713, 59.893036155, 59.935568408, 60.160397592, 60.602575441, 60.84460666, 60.981398125, 61.181194777, 61.308163952, 61.359593739, 61.684023446, 61.889594463, 61.944413133, 61.964160486, 62.303363846, 62.404444046, 62.506208328, 62.541168016, 62.826164005, 62.853688955, 63.045562184, 63.206955035, 63.243528429, 64.06303519, 64.171759143, 64.232523107, 64.337782626, 64.349614158, 64.368753581, 64.430457602, 64.500135056, 64.68965015, 64.82217617, 64.877767252, 65.057042406, 65.379512885, 65.474871588, 65.983938144, 66.257717242, 66.285394449, 66.383499839, 66.386942025, 66.607800951, 66.661988401, 66.753245688, 66.897145459, 66.953560625, 67.008028367, 67.115040522, 67.77741031, 67.787354346, 67.973519995, 68.195748441, 68.239942723, 68.248092333), "800" = c(2.1893e-05, 2.1902e-05, 2.2009e-05, 2.266e-05, 2.2676e-05, 2.2721e-05, 2.2914e-05, 2.3017e-05, 2.3423e-05, 2.345e-05, 2.3513e-05, 2.3763e-05, 2.3792e-05, 2.4215e-05, 2.4554e-05, 2.5176e-05, 2.5287e-05, 2.5443e-05, 2.5991e-05, 2.5997e-05, 2.6229e-05, 2.6301e-05, 2.6455e-05, 2.6556e-05, 2.7122e-05, 2.7165e-05, 2.7312e-05, 2.7466e-05, 2.8109e-05, 2.8329e-05, 2.858e-05, 2.9273e-05, 2.9941e-05, 3.0024e-05, 3.0363e-05, 3.0808e-05, 3.1331e-05, 3.1931e-05, 3.2726e-05, 3.3217e-05, 3.3476e-05, 3.3758e-05, 3.3946e-05, 3.4071e-05, 3.4556e-05, 3.522e-05, 3.5651e-05, 3.5973e-05, 3.6554e-05, 3.6954e-05, 3.7381e-05, 3.7978e-05, 3.8078e-05, 3.8399e-05, 3.8886e-05, 3.9406e-05, 4.0024e-05, 4.0122e-05, 4.0319e-05, 4.0933e-05, 4.277e-05, 4.323e-05, 4.3591e-05, 4.4218e-05, 4.431e-05, 4.4524e-05, 4.5251e-05, 4.5416e-05, 4.5876e-05, 4.6116e-05, 4.6365e-05, 4.6688e-05, 4.7616e-05, 4.7863e-05, 4.9092e-05, 4.9639e-05, 5.0232e-05, 5.0554e-05, 5.0733e-05, 5.1021e-05, 5.1514e-05, 5.1771e-05, 5.2004e-05, 5.2709e-05, 5.3655e-05, 5.4334e-05, 5.4747e-05, 5.4906e-05, 5.5313e-05, 5.665e-05, 5.7395e-05, 5.8157e-05, 5.8722e-05, 5.9079e-05, 5.9402e-05, 6.0363e-05, 6.0897e-05, 6.1575e-05, 6.334e-05, 6.3806e-05, 6.459e-05, 6.5698e-05, 6.6313e-05, 6.6872e-05, 6.7939e-05, 6.8746e-05, 6.9874e-05, 7.0824e-05, 7.169e-05, 7.2554e-05, 7.3318e-05, 7.5074e-05, 7.6365e-05, 7.7243e-05, 7.7418e-05, 7.7963e-05, 7.9888e-05, 8.0361e-05, 8.1935e-05, 8.4886e-05, 8.5553e-05, 8.653e-05, 8.6842e-05, 8.9222e-05, 9.0786e-05, 9.1307e-05, 9.2643e-05, 9.3598e-05, 9.5172e-05, 9.6337e-05, 9.7605e-05, 9.8755e-05, 9.9836e-05, 0.000100424, 0.000103086, 0.000104228, 0.000106217, 0.000107273, 0.000109191, 0.000110832, 0.000111734, 0.000112587, 0.000113577, 0.000115047, 0.000116802, 0.000117927, 0.000118735, 0.000119217, 0.000120207, 0.000121418, 0.000122531, 0.00012359, 0.000124389, 0.000125864, 0.000126465, 0.000127486, 0.000128304, 0.000130423, 0.000131529, 0.000132888, 0.00013391, 0.00013503, 0.000136359, 0.000137481, 0.000139368, 0.000139933, 0.000140946, 0.000143432, 0.000144724, 0.000146572, 0.000148128, 0.000149323, 0.000150918, 0.000153289, 0.000154081, 0.000155665, 0.000158201, 0.00015933, 0.000162022, 0.000164503, 0.000165915, 0.000167519, 0.000169083, 0.00017096, 0.00017251, 0.000173973, 0.000176431, 0.000179508, 0.000180385, 0.000184865, 0.000185983, 0.000187985, 0.000189375, 0.000190749, 0.000191786, 0.000194657, 0.000196482, 0.000197806, 0.000198736, 0.000201775, 0.00020399, 0.0002057, 0.000209008, 0.000211062, 0.000213917, 0.000215152, 0.000217809, 0.000218658, 0.000220943, 0.000223293, 0.000226876, 0.000229599, 0.000232357, 0.000234291, 0.000236596, 0.000240029, 0.000242794, 0.000246294, 0.000250072, 0.000252709, 0.000255721, 0.000259856, 0.00026259, 0.000266243, 0.000267987, 0.000270875, 0.00027313, 0.000277023, 0.000281084, 0.00028328, 0.000285663, 0.00028816, 0.000290253, 0.000293171, 0.000296414, 0.000299633, 0.00030456, 0.000308232, 0.000311586, 0.000315057, 0.000317871, 0.000321626, 0.00032407, 0.000327871, 0.000333027, 0.00033725, 0.00034093, 0.000344211, 0.000349868, 0.000354533, 0.000357877, 0.000362396, 0.000366756, 0.000369826, 0.000373055, 0.000376904, 0.000381521, 0.000385033, 0.000387353, 0.000390587, 0.000394571, 0.000398687, 0.000402215, 0.00040681, 0.000409704, 0.000414273, 0.000418482, 0.000425298, 0.000431251, 0.000434446, 0.000441245, 0.00044567, 0.000451293, 0.000456763, 0.000461034, 0.000466459, 0.000472551, 0.000476219, 0.000481997, 0.00048657, 0.000494044, 0.000498925, 0.00050474, 0.000510148, 0.000515132, 0.000520106, 0.000526909, 0.000533595, 0.000540787, 0.000546664, 0.00055316, 0.000559215, 0.000565504, 0.00056962, 0.000579005, 0.00058409, 0.000590503, 0.000597237, 0.000604523, 0.000612222, 0.000619853, 0.000625454, 0.000632735, 0.000641787, 0.000646966, 0.000655684, 0.000664097, 0.000670137, 0.000679031, 0.000688298, 0.000693453, 0.000701739, 0.000710478, 0.000718121, 0.000726332, 0.000733597, 0.000743798, 0.000754744, 0.00076243, 0.000772565, 0.000781084, 0.000789398, 0.000797051, 0.000805367, 0.000812958, 0.000820608, 0.000829814, 0.00083849, 0.000849068, 0.00085729, 0.000868924, 0.000882317, 0.000892775, 0.000905387, 0.0009142, 0.000926095, 0.000935957, 0.000946719, 0.000955582, 0.000964835, 0.000975535, 0.000978027, 0.000989677, 0.001002425, 0.001013647, 0.001025301, 0.001038343, 0.001049223, 0.001059754, 0.001074322, 0.001086267, 0.001096376, 0.001107606, 0.001121111, 0.00113392, 0.001148533, 0.001163598, 0.001177995, 0.001192658, 0.001205774, 0.001222305, 0.001232428, 0.001246027, 0.001259694, 0.001272485, 0.001286247, 0.001301557, 0.001318183, 0.001332928, 0.001346852, 0.00136382, 0.001380124, 0.001396616, 0.001412953, 0.001429477, 0.001448531, 0.00146338, 0.001479385, 0.001497569, 0.001513477, 0.001530031, 0.001545452, 0.001562343, 0.001582354, 0.001602998, 0.001624102, 0.001640631, 0.001660048, 0.001676688, 0.00169588, 0.00171578, 0.001735114, 0.001752758, 0.001772751, 0.001794321, 0.001814492, 0.001837852, 0.001859488, 0.001882692, 0.001907399, 0.001930547, 0.001953546, 0.001977064, 0.001997619, 0.002018371, 0.002042553, 0.002066635, 0.002091066, 0.00211045, 0.002132572, 0.002157048, 0.002181055, 0.002202417, 0.002228629, 0.002253783, 0.002284293, 0.002311309, 0.00233943, 0.002363998, 0.002393925, 0.002422803, 0.00245502, 0.002487043, 0.002515692, 0.002544325, 0.00257122, 0.002599607, 0.002629866, 0.002659069, 0.002689838, 0.002722049, 0.002752441, 0.002786692, 0.002818533, 0.002850075, 0.002883164, 0.00291698, 0.002949004, 0.002982972, 0.003021833, 0.003056928, 0.003093081, 0.003126405, 0.003161834, 0.003197792, 0.003236167, 0.003274769, 0.003314445, 0.003349982, 0.003391251, 0.003429288, 0.003463771, 0.003501516, 0.003543242, 0.003583591, 0.00362566, 0.003667097, 0.003712741, 0.00376017, 0.003801897, 0.003849918, 0.003890579, 0.003936804, 0.003978508, 0.004019743, 0.004069363, 0.004117139, 0.004163419, 0.004211549, 0.004257328, 0.004308134, 0.004360544, 0.004414358, 0.004465139, 0.004518793, 0.004570038, 0.00462457, 0.004682671, 0.004736812, 0.004789042, 0.004843169, 0.004899443, 0.004949941, 0.005003634, 0.005057592, 0.005110574, 0.005171471, 0.00523075, 0.00528807, 0.005346244, 0.005411608, 0.005476439, 0.005539967, 0.005601882, 0.005667017, 0.00573001, 0.005793323, 0.005860569, 0.005935708, 0.006008763, 0.00607753, 0.006149349, 0.006222253, 0.006298778, 0.006370354, 0.006445616, 0.006516818, 0.006588337, 0.006660636, 0.006747091, 0.006827054, 0.006901024, 0.006983115, 0.00706461, 0.007143028, 0.007232914, 0.007320005, 0.007401199, 0.0074872, 0.007576984, 0.007657817, 0.007749743, 0.007841012, 0.007933139, 0.008030785, 0.008129027, 0.008223166, 0.008327276, 0.008425086, 0.008524674, 0.008632296, 0.008733218, 0.008836098, 0.008937887, 0.009043222, 0.009152198, 0.009254235, 0.009367703, 0.009473852, 0.009575527, 0.009686481, 0.009769218, 0.009792217, 0.009902418, 0.010026022, 0.010146904, 0.010266542, 0.010384129, 0.01050974, 0.010635592, 0.010751319, 0.010873001, 0.011004728, 0.011135711, 0.011257777, 0.011385405, 0.011521332, 0.011666669, 0.011809837, 0.011943742, 0.012082127, 0.012222172, 0.012365701, 0.012509281, 0.012651573, 0.012797467, 0.012960157, 0.013112849, 0.013260049, 0.013415051, 0.013576135, 0.013738897, 0.013895495, 0.014039967, 0.014209334, 0.014379092, 0.014545903, 0.014700954, 0.014862792, 0.015034728, 0.015213007, 0.015393285, 0.01557109, 0.015752577, 0.015945395, 0.016136139, 0.016321526, 0.016514897, 0.016707772, 0.016908357, 0.017106486, 0.017304843, 0.017506921, 0.017712706, 0.017918313, 0.018118253, 0.018330266, 0.018549923, 0.018758818, 0.018982637, 0.019200861, 0.019416119, 0.019644887, 0.01986298, 0.020103442, 0.02034397, 0.020588293, 0.020827861, 0.021063946, 0.021307471, 0.021570898, 0.021816949, 0.022083201, 0.022343371, 0.022594253, 0.02287206, 0.023154642, 0.023434142, 0.023700869, 0.023976413, 0.024261397, 0.024538661, 0.024829309, 0.025125379, 0.025424826, 0.025711322, 0.026014637, 0.026318188, 0.026610296, 0.026927895, 0.027245928, 0.02755476, 0.027884533, 0.028208641, 0.0285382, 0.028864484, 0.029194034, 0.029542145, 0.029891379, 0.03023763, 0.030598527, 0.030963777, 0.031333738, 0.031691125, 0.032058322, 0.032443967, 0.032820665, 0.033193418, 0.033590285, 0.033989198, 0.034382465, 0.034774929, 0.035180574, 0.035595082, 0.036009271, 0.036459304, 0.03687094, 0.03729721, 0.037725616, 0.038170023, 0.038614859, 0.039070676, 0.039534443, 0.039990994, 0.04046947, 0.040967968, 0.041444551, 0.041927187, 0.042403978, 0.042900614, 0.043409676, 0.043905071, 0.044410698, 0.044944462, 0.045484966, 0.046019253, 0.046560907, 0.047083615, 0.047625864, 0.048188976, 0.048754097, 0.049328825, 0.049899915, 0.050467578, 0.051077114, 0.05166214, 0.052268136, 0.052884235, 0.053503218, 0.054135817, 0.054794348, 0.055418525, 0.056097142, 0.056767614, 0.057433286, 0.058122365, 0.058812838, 0.059538491, 0.060245854, 0.060946019, 0.061653976, 0.062390087, 0.063139449, 0.063905329, 0.064656737, 0.065419071, 0.066182582, 0.06696832, 0.067764235, 0.068576976, 0.069394604, 0.07019258, 0.071055138, 0.071879723, 0.072715215, 0.073574886, 0.074413495, 0.075307484, 0.076177311, 0.077078194, 0.077989004, 0.078898069, 0.079817065, 0.080752404, 0.08170525, 0.082680811, 0.083659657, 0.084660089, 0.085650587, 0.086653397, 0.087694544, 0.088719524, 0.089765393, 0.090832988, 0.091929296, 0.09301539, 0.094131263, 0.095250453, 0.09636557, 0.097497818, 0.098642968, 0.099815722, 0.100741097, 0.100986829, 0.102184206, 0.103414452, 0.104628164, 0.105879026, 0.107133302, 0.108424716, 0.109708981, 0.111001187, 0.112330242, 0.113673553, 0.11506138, 0.116423135, 0.117813754, 0.119233761, 0.120642659, 0.122056329, 0.123517768, 0.124988957, 0.126461191, 0.127934509, 0.129467213, 0.131000046, 0.132560615, 0.134156971, 0.135765881, 0.137395538, 0.138999871, 0.140643275, 0.142339564, 0.144033827, 0.145748547, 0.147508402, 0.149280574, 0.151063694, 0.152885029, 0.154729303, 0.156582149, 0.158462153, 0.16038291, 0.162297565, 0.164263056, 0.166258044, 0.168312664, 0.170353174, 0.172373984, 0.174467498, 0.176545447, 0.178661064, 0.18088925, 0.183078598, 0.185295442, 0.187507078, 0.189790353, 0.192093644, 0.194379918, 0.19669623, 0.199086957, 0.20150316, 0.20394855, 0.206473153, 0.208999474, 0.211566514, 0.214127965, 0.216744224, 0.219370674, 0.2220666, 0.224777677, 0.227538004, 0.230321505, 0.233185515, 0.236092347, 0.238981513, 0.241908837, 0.244921732, 0.247913854, 0.250960539, 0.254054172, 0.257205407, 0.260347177, 0.263557157, 0.266853651, 0.270136154, 0.273482276, 0.276883861, 0.280325081, 0.283840042, 0.287310663, 0.290894022, 0.294518394, 0.298186838, 0.301876385, 0.305627291, 0.309459209, 0.313306182, 0.317227568, 0.31810622, 0.321232361, 0.325252638, 0.329343622, 0.33343904, 0.33771673, 0.341939035, 0.346262294, 0.350638607, 0.355083949, 0.359585177, 0.364173845, 0.368796446, 0.373510116, 0.378203576, 0.382990266, 0.387798296, 0.392750128, 0.397764329, 0.402821634, 0.407967615, 0.413165566, 0.418395838, 0.423742201, 0.429214152, 0.434788661, 0.435947563, 0.440380609, 0.44605069, 0.45181447, 0.45765743, 0.463628461, 0.469656492, 0.475781671, 0.481964566, 0.488229742, 0.494605222, 0.501064905, 0.507597788, 0.514243547, 0.520972875, 0.527792493, 0.534740625, 0.541748744, 0.548977472, 0.55625362, 0.563658153, 0.571142141, 0.578844812, 0.586676595, 0.59446735, 0.602515793, 0.610628109, 0.618843446, 0.62719823, 0.635679778, 0.644317963, 0.653088605, 0.66206949, 0.67114144, 0.680290568, 0.689714788, 0.693715706, 0.699205616, 0.708831122, 0.718643229, 0.728607294, 0.738789671, 0.749037416, 0.759507997, 0.770107344, 0.780814381, 0.791757493, 0.802913037, 0.814388577, 0.826054603, 0.837820779, 0.84982377, 0.862095671, 0.874630872, 0.8873844, 0.900359476, 0.913451738, 0.926766185, 0.940384575, 0.95419243, 0.968408647, 0.98275778, 0.988795118, 0.997327417, 1.012415841, 1.027758592, 1.043240467, 1.059245802, 1.075472089, 1.092016025, 1.108829724, 1.12614191, 1.143620887, 1.161456298, 1.179829906, 1.198374782, 1.217455712, 1.236858219, 1.256840163, 1.277297237, 1.298269818, 1.319367771, 1.336728906, 1.376043392, 1.398217521, 1.420067403, 1.442151297, 1.464159984, 1.48617226, 1.508023269, 1.529902955, 1.551905604, 1.573671871, 1.595480024, 1.617231801, 1.639158823, 1.660872542, 1.682773073, 1.704677541, 1.726515544, 1.748398169, 1.761260373, 1.770217205, 1.792231389, 1.814008731, 1.83597056, 1.857833336, 1.879722705, 1.901778315, 1.923717778, 1.945535539, 1.967571615, 1.989602417, 2.011643036, 2.033444537, 2.055292805, 2.077319108, 2.099385655, 2.121316178, 2.14325926, 2.165251789, 2.187053153, 2.209248578, 2.231237312, 2.253088568, 2.275088607, 2.297119967, 2.309767155, 2.31921637, 2.341216257, 2.363280221, 2.385120609, 2.407158119, 2.429176811, 2.451144148, 2.473386666, 2.495501082, 2.517585983, 2.539896478, 2.562060141, 2.584042276, 2.606360476, 2.628522692, 2.650842902, 2.672808473, 2.694698735, 2.717006377, 2.739196552, 2.761113627, 2.78336799, 2.805639758, 2.827843603, 2.850219248, 2.872549379, 2.895181632, 2.917627156, 2.940019478, 2.962280424, 2.984832201, 3.007365256, 3.029681056, 3.052329001, 3.074827523, 3.092300771, 3.096874714, 3.119575495, 3.142136539, 3.164588553, 3.186810249, 3.209313801, 3.232024346, 3.254615378, 3.277063208, 3.299862458, 3.322566339, 3.345330293, 3.368014196, 3.39088405, 3.413524629, 3.436075156, 3.458880349, 3.481891559, 3.504861983, 3.528040224, 3.55109573, 3.57391785, 3.596861112, 3.620123357, 3.643165536, 3.661131955, 3.666145579, 3.688867259, 3.712041864, 3.735238996, 3.758247082, 3.781165398, 3.804362563, 3.827442807, 3.850660684, 3.874025317, 3.897369852, 3.921043839, 3.94458255, 3.968156226, 3.991506999, 4.015172432, 4.038670573, 4.062266609, 4.085533913, 4.109116041, 4.132775056, 4.156717224, 4.180188832, 4.204401977, 4.228159823, 4.251897218, 4.276002014, 4.29981368, 4.324016166, 4.347907391, 4.371936769, 4.395820556, 4.419589814, 4.443979471, 4.468068928, 4.492329479, 4.516321934, 4.540715617, 4.564998548, 4.589390031, 4.613919575, 4.637869153, 4.66226927, 4.686662101, 4.711917469, 4.736846053, 4.760957669, 4.785995667, 4.810252856, 4.835027217, 4.860195484, 4.885270147, 4.909938551, 4.9347809, 4.959488489, 4.984315386, 5.009385868, 5.034513536, 5.059719777, 5.084988269, 5.11017069, 5.13537018, 5.160499257, 5.185999059, 5.211067067, 5.236926146, 5.262136134, 5.287822919, 5.313337418, 5.338841438, 5.364197051, 5.389806563, 5.415768144, 5.442181049, 5.4679655, 5.493675047, 5.519392774, 5.545573632, 5.57169423, 5.598234637, 5.62427682, 5.650839368, 5.677492878, 5.704290346, 5.731379446, 5.757543187, 5.784113581, 5.810768616, 5.83734246, 5.863921935, 5.890431601, 5.917054645, 5.944186162, 5.970959458, 5.99881401, 6.025396998, 6.03089898, 6.052340459, 6.079771825, 6.106655769, 6.134683647, 6.162407944, 6.190608383, 6.218316948, 6.245662719, 6.273890775, 6.302184973, 6.329999975, 6.357144692, 6.384763923, 6.412369835, 6.440686528, 6.46952286, 6.498057177, 6.526283145, 6.5543846, 6.583585695, 6.612140952, 6.640366961, 6.668816972, 6.697844948, 6.726909172, 6.75675271, 6.785967402, 6.815588411, 6.844665528, 6.874757375, 6.904090732, 6.933740514, 6.963282194, 6.993320614, 7.02289244, 7.051698685, 7.080798593, 7.11009493, 7.139514759, 7.169046369, 7.198828947, 7.228328411, 7.258845106, 7.288239995, 7.318815319, 7.349604464, 7.379561882, 7.409312393, 7.44018222, 7.470760318, 7.502016472, 7.533623656, 7.56535796, 7.596207331, 7.628385955, 7.659384824, 7.691742835, 7.723026167, 7.754222882, 7.786070681, 7.817886813, 7.84997606, 7.88123126, 7.911936023, 7.94496744, 7.97645191, 8.008498446, 8.040909145, 8.073808722, 8.105421479, 8.138219601, 8.171721295, 8.205119666, 8.237791944, 8.270105585, 8.303522463, 8.337566954, 8.372361125, 8.406577199, 8.439260106, 8.473503932, 8.507778883, 8.541934327, 8.575753034, 8.608879293, 8.642501161, 8.676440446, 8.71189948, 8.743923165, 8.777167537, 8.812294972, 8.847180873, 8.881888556, 8.917488393, 8.952729018, 8.98716833, 9.022540719, 9.057842104, 9.092485723, 9.126744044, 9.160402521, 9.195788719, 9.23116562, 9.265794187, 9.301202475, 9.338162972, 9.373484655, 9.408353611, 9.444393176, 9.479036449, 9.517213353, 9.553721606, 9.589615136, 9.626004982, 9.660891424, 9.697208687, 9.736625667, 9.773432944, 9.810521077, 9.847454873, 9.885706029, 9.92339542, 9.961316879, 9.998292698, 10.035453688, 10.071997963, 10.109658308, 10.148422956, 10.188809961, 10.226848413, 10.265468258, 10.303608119, 10.341843931, 10.382266285, 10.419944273, 10.459886116, 10.499809752, 10.53804072, 10.577180535, 10.616327221, 10.655973896, 10.695804431, 10.735939387, 10.776561902, 10.815704153, 10.854146661, 10.893888875, 10.933147962, 10.970662027, 11.011336718, 11.049700464, 11.090699247, 11.130086151, 11.168892563, 11.207605519, 11.247034156, 11.288067063, 11.327803575, 11.367341485, 11.405707197, 11.449320379, 11.489666557, 11.532128202, 11.573106372, 11.6130937, 11.656442836, 11.698949247, 11.738080526, 11.776481304, 11.81639912, 11.857269107, 11.899526503, 11.943497852, 11.985577006, 12.031009116, 12.076177133, 12.120860373, 12.165167843, 12.206572758, 12.251727446, 12.294394861, 12.33567683, 12.380802852, 12.420385568, 12.463337965, 12.508546474, 12.552369172, 12.596903923, 12.64190704, 12.685898756, 12.728717067, 12.770503197, 12.812961281, 12.857954526, 12.900435339, 12.946698689, 12.990528925, 13.035474722, 13.076479134, 13.120001498, 13.129291003, 13.166804176, 13.214732289, 13.257259047, 13.300120899, 13.346581536, 13.389411081, 13.431753643, 13.479022657, 13.522919358, 13.567301091, 13.611633486, 13.654955578, 13.700371539, 13.748485101, 13.794761316, 13.837445714, 13.883674373, 13.931823517, 13.979775264, 14.026028006, 14.068044696, 14.114379656, 14.157125707, 14.202818274, 14.253493894, 14.299955341, 14.342601009, 14.387253866, 14.437065298, 14.48426294, 14.535417093, 14.584451141, 14.633012911, 14.683969647, 14.729901888, 14.778521038, 14.825301348, 14.872281866, 14.919650535, 14.964202056, 15.015388536, 15.061473183, 15.109978299, 15.162076589, 15.207977559, 15.254847024, 15.306420235, 15.354703521, 15.403805688, 15.45452657, 15.503807076, 15.55395911, 15.60077864, 15.65117561, 15.698094951, 15.747333657, 15.789388212, 15.840168304, 15.892783305, 15.941581708, 15.987731409, 16.032250885, 16.084870703, 16.128949973, 16.180954568, 16.225403552, 16.27918709, 16.333171583, 16.379103747, 16.424273663, 16.47200581, 16.524443695, 16.57294203, 16.61893648, 16.666279146, 16.718970442, 16.768022838, 16.821661281, 16.873037859, 16.920961917, 16.972359901, 17.022553878, 17.069130372, 17.121323801, 17.175086044, 17.224240886, 17.275576121, 17.325636757, 17.379311066, 17.425406462, 17.476268892, 17.524224389, 17.570928519, 17.623968294, 17.673100885, 17.735475369, 17.78648834, 17.836768743, 17.895679392, 17.951777598, 18.002663724, 18.050458173, 18.101985601, 18.155806605, 18.210564194, 18.26108134, 18.311715875, 18.367538411, 18.417966355, 18.473257745, 18.523795652, 18.580403548, 18.641774827, 18.692901115, 18.741177582, 18.796262462, 18.843708323, 18.900377316, 18.952654955, 19.008196936, 19.059718504, 19.122322895, 19.179454519, 19.234001031, 19.298921026, 19.350365439, 19.408375965, 19.466766158, 19.521940104, 19.584523307, 19.643518093, 19.699371327, 19.751746404, 19.807248852, 19.861385732, 19.919336425, 19.964625857, 20.021566625, 20.082580667, 20.147304452, 20.198719785, 20.25463039, 20.318721352, 20.387048411, 20.436274627, 20.502425483, 20.555513586, 20.611285269, 20.664885752, 20.720924399, 20.782465444, 20.836368847, 20.886097231, 20.946164748, 21.012435199, 21.061313386, 21.125194834, 21.184505601, 21.2526885, 21.308315856, 21.377800146, 21.441556162, 21.49773483, 21.560168803, 21.620036136, 21.676517118, 21.73768738, 21.799022031, 21.855883578, 21.907625016, 21.965223719, 22.03003566, 22.087747099, 22.144148411, 22.199816977, 22.258942125, 22.311589622, 22.37880356, 22.43149822, 22.488480501, 22.5560014, 22.626635855, 22.691870717, 22.751040183, 22.809056696, 22.877029657, 22.948884475, 22.996738283, 23.061693537, 23.121182578, 23.188859441, 23.265200517, 23.325813327, 23.390584041, 23.454188879, 23.520306235, 23.569458652, 23.629235055, 23.687301112, 23.735821938, 23.751209156, 23.805083681, 23.873991355, 23.946291476, 24.011013453, 24.071211737, 24.136030259, 24.193533708, 24.247043543, 24.317916094, 24.399933772, 24.475720584, 24.541753875, 24.617121843, 24.677084832, 24.746204466, 24.811074628, 24.882933062, 24.932799523, 24.9999446, 25.06692317, 25.132236244, 25.214356774, 25.274836467, 25.328806137, 25.388712242, 25.446382589, 25.543938289, 25.622247082, 25.696728923, 25.762632945, 25.814579855, 25.901158009, 25.986216869, 26.068179941, 26.13950064, 26.199231532, 26.25940674, 26.329825266, 26.40741818, 26.479498323, 26.567216891, 26.640856721, 26.707558594, 26.778486161, 26.840121213, 26.938788293, 27.008949806, 27.068263185, 27.148098514, 27.216085759, 27.275838226, 27.339299482, 27.40412306, 27.461528178, 27.535828248, 27.601984676, 27.688922761, 27.734290921, 27.800452411, 27.877709499, 27.984265425, 28.037263663, 28.113821418, 28.17659324, 28.265240422, 28.322455181, 28.421412092, 28.496773782, 28.573469022, 28.66708372, 28.730393547, 28.820229358, 28.880702905, 28.937323379, 29.0129735, 29.091727321, 29.150947972, 29.232407726, 29.317418694, 29.397422841, 29.475959645, 29.548809522, 29.602744795, 29.662559457, 29.738393099, 29.813686476, 29.890528322, 29.960826028, 30.036489766, 30.127508908, 30.221089042, 30.326222711, 30.4312754, 30.481502771, 30.553316856, 30.626831952, 30.679407996, 30.761744989, 30.873191181, 30.941610863, 31.043958544, 31.117211014, 31.194543852, 31.27264059, 31.326284112, 31.393054991, 31.474399505, 31.548640457, 31.62055429, 31.713766659, 31.790015963, 31.864970275, 31.943787716, 32.013027647, 32.082004603, 32.172656065, 32.236935787, 32.331670505, 32.38689445, 32.472647589, 32.527415867, 32.571175348, 32.623539798, 32.724366924, 32.808395994, 32.943335333, 33.036537919, 33.138722223, 33.234695947, 33.376142128, 33.475178065, 33.542500899, 33.617535227, 33.713382832, 33.805022864, 33.852138516, 33.949673954, 34.08727226, 34.15206706, 34.230577019, 34.324676089, 34.450086268, 34.542624543, 34.661693727, 34.704420309, 34.776526094, 34.867141622, 34.918434223, 35.036851472, 35.106893738, 35.205392236, 35.306328384, 35.39064962, 35.497487722, 35.581798905, 35.705251468, 35.768072277, 35.816987147, 35.882582127, 35.963577159, 36.086917595, 36.197663775, 36.287173786, 36.367969766, 36.49583745, 36.588924984, 36.708882785, 36.776223405, 36.856368345, 36.966322878, 37.013421774, 37.123437984, 37.200615883, 37.322401878, 37.405612585, 37.51548204, 37.680763231, 37.787490689, 37.874224758, 37.971573045, 38.027378982, 38.092702755, 38.171529377, 38.257456401, 38.293416601, 38.377716667, 38.454602588, 38.49786473, 38.594090799, 38.678686688, 38.744916819, 38.897789808, 39.042198317, 39.159105956, 39.203140667, 39.344081954, 39.451577432, 39.559252852, 39.615118976, 39.697713457, 39.865352439, 39.928894723, 39.961899338, 40.032429754, 40.124718314, 40.244781454, 40.357176818, 40.444321896, 40.519619418, 40.569466592, 40.651894292, 40.755092928, 41.002247576, 41.1237225, 41.209821951, 41.28446626, 41.331922788, 41.373546316, 41.464425185, 41.687163857, 41.81291491, 41.898025621, 41.921146752, 42.095364382, 42.18654113, 42.433314098, 42.603134744, 42.816127388, 42.940028346, 43.158734236, 43.188863885, 43.332898793, 43.447438733, 43.537000753, 43.568575732, 43.742660177, 43.857188127, 43.875025716, 43.946281275, 44.048399145, 44.152941363, 44.236576091, 44.303144586, 44.480316122, 44.559917156, 44.703988463, 44.79398793, 44.931778421, 45.015029062, 45.215586777, 45.260966668, 45.437088807, 45.497420054, 45.549476122, 45.591530916, 45.699767495, 45.771613363, 45.840251636, 45.96468841, 46.123086025, 46.286149339, 46.310877762, 46.355604313, 46.449315881, 46.587356908, 46.680996919, 46.738661737, 46.829714851, 46.940102732, 47.033280514, 47.10112526, 47.160480507, 47.245722598, 47.450569272, 47.487882139, 47.498798053, 47.69435473, 47.817997451, 47.863719194, 47.951326334, 48.151659967, 48.281375044, 48.401229452, 48.710408317, 48.766256927, 48.887501988, 48.96643506, 49.039796998, 49.28902341, 49.431882573, 49.474275807, 49.48343802, 49.49926844, 49.684161369, 49.718410024, 49.888151571, 50.004911515, 50.111569239, 50.349143357, 50.392764952, 50.527973502, 50.551497006, 50.612023374, 50.678599284, 50.680105259, 50.773608071, 50.998386953, 51.051960335, 51.075112178, 51.160680186, 51.297643482, 51.464863223, 51.597712248, 51.631321181, 51.82144497, 51.88745397, 52.063125792, 52.09622365, 52.293769355, 52.330576047, 52.473793829, 52.485810909, 52.536092517, 52.573066687, 52.618268756, 52.673426782, 52.704436463, 52.909786321, 53.082462484, 53.285493357, 53.307505053, 53.311451692, 53.380818928, 53.408503812, 53.484401825, 53.504780051, 53.584312313, 53.859344723, 53.935241806, 54.020528083 ), "1000" = c(1.8831e-05, 1.9142e-05, 1.9501e-05, 1.9818e-05, 1.984e-05, 1.989e-05, 2.002e-05, 2.0128e-05, 2.0695e-05, 2.0749e-05, 2.0791e-05, 2.1032e-05, 2.1252e-05, 2.1517e-05, 2.1607e-05, 2.2275e-05, 2.255e-05, 2.2938e-05, 2.3004e-05, 2.3188e-05, 2.3553e-05, 2.3672e-05, 2.3967e-05, 2.4204e-05, 2.4366e-05, 2.4602e-05, 2.4758e-05, 2.4956e-05, 2.506e-05, 2.5428e-05, 2.5607e-05, 2.5775e-05, 2.6001e-05, 2.6275e-05, 2.6546e-05, 2.6823e-05, 2.6963e-05, 2.7428e-05, 2.7757e-05, 2.7868e-05, 2.7913e-05, 2.812e-05, 2.8587e-05, 2.861e-05, 2.9445e-05, 3.0006e-05, 3.0374e-05, 3.0438e-05, 3.0765e-05, 3.1069e-05, 3.1672e-05, 3.2053e-05, 3.3189e-05, 3.335e-05, 3.3738e-05, 3.3764e-05, 3.433e-05, 3.4492e-05, 3.4954e-05, 3.5349e-05, 3.5812e-05, 3.6456e-05, 3.6747e-05, 3.7421e-05, 3.7733e-05, 3.8301e-05, 3.8516e-05, 3.8866e-05, 3.9533e-05, 3.9715e-05, 4.1151e-05, 4.1309e-05, 4.1679e-05, 4.2395e-05, 4.3754e-05, 4.4305e-05, 4.4629e-05, 4.5262e-05, 4.5881e-05, 4.6338e-05, 4.7329e-05, 4.7559e-05, 4.8243e-05, 4.8524e-05, 4.9008e-05, 4.9198e-05, 4.9426e-05, 5.0106e-05, 5.0154e-05, 5.0922e-05, 5.1278e-05, 5.1687e-05, 5.2189e-05, 5.2752e-05, 5.3973e-05, 5.4566e-05, 5.5089e-05, 5.5328e-05, 5.6563e-05, 5.7362e-05, 5.8426e-05, 5.8924e-05, 5.963e-05, 5.9902e-05, 6.1248e-05, 6.2351e-05, 6.2799e-05, 6.4531e-05, 6.489e-05, 6.5372e-05, 6.606e-05, 6.6745e-05, 6.7731e-05, 6.826e-05, 6.9252e-05, 6.9701e-05, 7.0865e-05, 7.1508e-05, 7.2541e-05, 7.3932e-05, 7.4465e-05, 7.54e-05, 7.572e-05, 7.6541e-05, 7.7678e-05, 7.8778e-05, 7.9052e-05, 7.9984e-05, 8.088e-05, 8.1908e-05, 8.3424e-05, 8.5262e-05, 8.5938e-05, 8.6851e-05, 8.7787e-05, 8.8534e-05, 8.9194e-05, 9.0233e-05, 9.1437e-05, 9.2168e-05, 9.2632e-05, 9.4028e-05, 9.5333e-05, 9.6002e-05, 9.6639e-05, 9.9184e-05, 9.9853e-05, 0.000101483, 0.000102473, 0.000103331, 0.000105185, 0.000106685, 0.000109144, 0.000111409, 0.000111834, 0.000113906, 0.000114641, 0.000116536, 0.000117921, 0.000119041, 0.000119614, 0.000120629, 0.000122626, 0.000124721, 0.000125783, 0.00012769, 0.000128977, 0.000130377, 0.00013174, 0.000132896, 0.000134183, 0.000136036, 0.000137511, 0.000140106, 0.000142088, 0.000144223, 0.000146098, 0.000147427, 0.000148375, 0.000149752, 0.000151733, 0.000154652, 0.000156811, 0.000158378, 0.000159743, 0.000161676, 0.000164777, 0.000166027, 0.000167649, 0.000170659, 0.00017247, 0.000173772, 0.000176016, 0.000177024, 0.000179362, 0.000182079, 0.000183315, 0.000185916, 0.000187875, 0.000190079, 0.000193504, 0.000195946, 0.000198063, 0.000200456, 0.000202556, 0.000205594, 0.000207543, 0.000210429, 0.00021438, 0.000219016, 0.000221449, 0.000224224, 0.00022742, 0.000229111, 0.000231316, 0.000233457, 0.000235678, 0.000237937, 0.000241682, 0.000244393, 0.000247127, 0.000250042, 0.00025319, 0.000257905, 0.000261873, 0.000265739, 0.000268935, 0.000273918, 0.000275916, 0.000279777, 0.000283646, 0.000287528, 0.000291418, 0.00029479, 0.000299933, 0.000302859, 0.000305932, 0.000309156, 0.000312037, 0.000316222, 0.000319999, 0.000323641, 0.000326283, 0.000330831, 0.000335766, 0.000340369, 0.000344423, 0.000347875, 0.000351407, 0.000355255, 0.000360127, 0.000364714, 0.00036694, 0.000370827, 0.000375966, 0.000380953, 0.00038506, 0.000389836, 0.000394696, 0.00039932, 0.000404635, 0.000408629, 0.000412333, 0.000417637, 0.000423393, 0.000428976, 0.000434426, 0.000439901, 0.000444721, 0.000449745, 0.000455535, 0.000459099, 0.00046408, 0.000470056, 0.000473278, 0.000477708, 0.000483448, 0.0004886, 0.000493002, 0.000499561, 0.000505128, 0.000511285, 0.000516145, 0.000520792, 0.000528501, 0.000533625, 0.000539173, 0.000545329, 0.000551721, 0.000559162, 0.000564951, 0.000568665, 0.00057613, 0.000582756, 0.000588679, 0.000594392, 0.000599947, 0.000607402, 0.000614383, 0.000621601, 0.000631243, 0.00063795, 0.000646368, 0.000654538, 0.000661427, 0.000668156, 0.000672878, 0.0006776, 0.000685749, 0.000692521, 0.000699704, 0.000708502, 0.00071609, 0.000726536, 0.000738112, 0.000746894, 0.00075553, 0.000764042, 0.000772826, 0.000778907, 0.000788746, 0.000797974, 0.000807398, 0.000817177, 0.000826255, 0.000835449, 0.000845968, 0.000855347, 0.000866616, 0.000879401, 0.000889529, 0.00089911, 0.000909027, 0.000919485, 0.000926885, 0.000938671, 0.000949347, 0.000957969, 0.000967435, 0.000978015, 0.000988909, 0.000992033, 0.001003493, 0.001016336, 0.001026553, 0.001038261, 0.001051702, 0.00106524, 0.001076915, 0.001092405, 0.001107826, 0.00112223, 0.001137722, 0.001148658, 0.001162477, 0.001172969, 0.001188305, 0.001203701, 0.00121687, 0.001226662, 0.001241338, 0.001254894, 0.001268025, 0.001282884, 0.001297077, 0.001313568, 0.001330555, 0.001344908, 0.001357774, 0.001372637, 0.001387591, 0.001404824, 0.001420479, 0.001437448, 0.001453514, 0.001470401, 0.00148432, 0.001504585, 0.001521643, 0.001539319, 0.001556735, 0.001577152, 0.001598571, 0.001616988, 0.001634755, 0.001654204, 0.001673988, 0.001698089, 0.001719109, 0.001737325, 0.001757723, 0.001777745, 0.001801074, 0.001821901, 0.001842811, 0.001867895, 0.001887495, 0.00190771, 0.001931679, 0.001951296, 0.001975133, 0.001999261, 0.002022076, 0.002048604, 0.002071568, 0.002097553, 0.002120675, 0.002142932, 0.002170979, 0.002193384, 0.002217586, 0.002241877, 0.00226668, 0.002291301, 0.002318756, 0.002345017, 0.002373803, 0.002404089, 0.002429513, 0.0024558, 0.002484006, 0.002511594, 0.00253958, 0.002568832, 0.002602107, 0.002628354, 0.002661155, 0.002691263, 0.002725158, 0.002761141, 0.002792718, 0.002823887, 0.002858624, 0.002897944, 0.002932138, 0.002964582, 0.002995815, 0.003027581, 0.003058516, 0.003092977, 0.00312467, 0.003157857, 0.003191624, 0.003228286, 0.003263682, 0.003302119, 0.003336411, 0.003375771, 0.003418443, 0.003454369, 0.003492942, 0.003532497, 0.003572721, 0.003615988, 0.003658587, 0.003701982, 0.003741535, 0.003783262, 0.003825894, 0.003868944, 0.003913608, 0.003965671, 0.004013516, 0.004059136, 0.004110817, 0.004161111, 0.004206606, 0.004260255, 0.00430716, 0.004353003, 0.004408605, 0.00445696, 0.004505008, 0.004561379, 0.004616125, 0.004670491, 0.004722347, 0.00477513, 0.004827696, 0.00488731, 0.004941642, 0.004999087, 0.005057162, 0.005121535, 0.005178845, 0.005229103, 0.00528881, 0.005351526, 0.005414943, 0.005477281, 0.005536567, 0.005596472, 0.00566041, 0.005719861, 0.005792105, 0.005857393, 0.005922047, 0.005991064, 0.006060255, 0.006135529, 0.006203784, 0.006269676, 0.006341454, 0.006415918, 0.006488169, 0.006563139, 0.006636057, 0.006712959, 0.006787729, 0.006874638, 0.006954628, 0.007034086, 0.007122534, 0.007206399, 0.007280899, 0.007367742, 0.007445252, 0.007534555, 0.00762118, 0.007706134, 0.007792467, 0.007886938, 0.007980935, 0.008070705, 0.008155491, 0.008245538, 0.008343997, 0.008438387, 0.00853453, 0.008632708, 0.008737292, 0.008836311, 0.008932541, 0.009033401, 0.009142858, 0.009252902, 0.00935777, 0.009458801, 0.009572018, 0.009679469, 0.009787962, 0.009872206, 0.009893676, 0.010007352, 0.010122074, 0.010241251, 0.01036192, 0.010481401, 0.010603249, 0.010724845, 0.010841424, 0.010963673, 0.011096024, 0.011217766, 0.011352485, 0.011488823, 0.011625145, 0.011759818, 0.011898241, 0.01203948, 0.012178188, 0.012326735, 0.012479584, 0.01262155, 0.012763071, 0.012910439, 0.013067569, 0.013218536, 0.013377016, 0.01353656, 0.013693711, 0.013859333, 0.014016357, 0.014182133, 0.014351333, 0.01450924, 0.014672225, 0.014841737, 0.015013117, 0.015186573, 0.015358727, 0.015539616, 0.015717922, 0.015900128, 0.016091696, 0.016281045, 0.016480062, 0.016673505, 0.0168659, 0.017060086, 0.017254799, 0.017458814, 0.017646362, 0.017849777, 0.018059918, 0.018260021, 0.018470204, 0.018684829, 0.018896851, 0.019116701, 0.019343012, 0.019572058, 0.019789199, 0.020020568, 0.020253758, 0.020497761, 0.020735199, 0.020978864, 0.021205526, 0.021450934, 0.021706857, 0.021971348, 0.022221221, 0.022489461, 0.022749158, 0.023016282, 0.023283544, 0.023571905, 0.023839772, 0.024120188, 0.024406722, 0.024675413, 0.024966611, 0.025257132, 0.025551942, 0.025843156, 0.026155755, 0.026467078, 0.026775527, 0.027098007, 0.027421433, 0.027732527, 0.028074661, 0.028393065, 0.028728419, 0.029079931, 0.029424072, 0.029766285, 0.030114922, 0.030474926, 0.030833824, 0.031183639, 0.031562322, 0.031917815, 0.032271253, 0.032646235, 0.033028529, 0.033403773, 0.03380155, 0.034220253, 0.034615694, 0.03501507, 0.035404703, 0.035814454, 0.036228474, 0.036662526, 0.037082535, 0.037500522, 0.037925681, 0.038364523, 0.0388085, 0.039268765, 0.039715888, 0.040153152, 0.04062285, 0.041098779, 0.041559959, 0.042045771, 0.042546463, 0.043040514, 0.043532782, 0.044035527, 0.044551965, 0.045050116, 0.045587582, 0.046124441, 0.046673303, 0.047222311, 0.047778042, 0.048337713, 0.048917929, 0.049493394, 0.050073782, 0.05065817, 0.051244813, 0.051859501, 0.052456569, 0.053078514, 0.053706162, 0.054347497, 0.054969816, 0.055634717, 0.056309726, 0.056971701, 0.057639983, 0.058296249, 0.058968779, 0.059643094, 0.060341648, 0.061051603, 0.061766701, 0.062497118, 0.06323322, 0.063998163, 0.064768316, 0.065550574, 0.066321168, 0.067100079, 0.067910935, 0.068716914, 0.069530004, 0.070348212, 0.07117516, 0.072000484, 0.07285043, 0.073704265, 0.074551032, 0.075418101, 0.076307865, 0.077202923, 0.078095091, 0.079016835, 0.07998026, 0.080897274, 0.081833592, 0.082819843, 0.083794119, 0.084780507, 0.085779284, 0.086790461, 0.08780895, 0.088852945, 0.089873877, 0.090938873, 0.092020621, 0.093138692, 0.09425505, 0.095368387, 0.096487628, 0.097652789, 0.098785939, 0.099950163, 0.100901441, 0.101137481, 0.102349245, 0.103555948, 0.104781472, 0.106042275, 0.107329692, 0.108606793, 0.109886572, 0.111218699, 0.112512009, 0.113868176, 0.115221805, 0.116572641, 0.117954235, 0.119360882, 0.120805975, 0.122219298, 0.123707126, 0.125195441, 0.126695203, 0.128204094, 0.129742534, 0.131270745, 0.132840577, 0.134465507, 0.136088821, 0.137725215, 0.139351935, 0.141036667, 0.142711743, 0.144447093, 0.146164335, 0.147916855, 0.149686634, 0.151488183, 0.153332836, 0.155173166, 0.157020275, 0.158904769, 0.160820542, 0.162773242, 0.164713805, 0.166667584, 0.168700283, 0.170719035, 0.172774246, 0.174850698, 0.176982315, 0.179116289, 0.181252729, 0.183472267, 0.185675665, 0.187918043, 0.1902228, 0.192527271, 0.194859387, 0.197192606, 0.199620119, 0.202088932, 0.204540141, 0.2070694, 0.209569562, 0.212142651, 0.214745761, 0.217326347, 0.219998753, 0.222693178, 0.225410345, 0.228162505, 0.230982099, 0.233836495, 0.23669527, 0.239609791, 0.242555136, 0.24551827, 0.248564922, 0.251598282, 0.254718267, 0.257872649, 0.261051257, 0.264241438, 0.267461931, 0.270782302, 0.274145104, 0.277499684, 0.280941577, 0.284435378, 0.287956372, 0.291500312, 0.295126846, 0.298824974, 0.302519523, 0.306319398, 0.310100197, 0.313956537, 0.31789319, 0.318731663, 0.321826499, 0.325852808, 0.32995603, 0.334105016, 0.33834902, 0.342568574, 0.346889548, 0.351256979, 0.355650587, 0.360139307, 0.364717612, 0.369347188, 0.374038842, 0.378787035, 0.383602337, 0.388449325, 0.393447984, 0.398479601, 0.403559852, 0.408735618, 0.413952236, 0.419330541, 0.424699893, 0.43019176, 0.435751796, 0.436883562, 0.441345601, 0.447028115, 0.45282325, 0.458716948, 0.464722408, 0.470768486, 0.476865681, 0.48308393, 0.489411666, 0.495854893, 0.502407023, 0.509000476, 0.515702593, 0.522487383, 0.529422003, 0.536437217, 0.543536646, 0.55074706, 0.558053418, 0.565556492, 0.57308375, 0.580756646, 0.588575781, 0.596585307, 0.604650253, 0.612764635, 0.621006734, 0.629430251, 0.63795406, 0.646579683, 0.655417893, 0.664378938, 0.673551021, 0.682841359, 0.692254168, 0.696282608, 0.701794209, 0.711445434, 0.721210193, 0.731188987, 0.741376654, 0.751817116, 0.762421053, 0.773114687, 0.784061013, 0.795130969, 0.806488029, 0.817928589, 0.82958244, 0.841522499, 0.85352701, 0.865821494, 0.878428845, 0.891239808, 0.904248945, 0.917498537, 0.930919608, 0.944719735, 0.958724266, 0.973038783, 0.987622989, 0.993637177, 1.002297896, 1.017373358, 1.032772741, 1.048447606, 1.064422093, 1.080710692, 1.097502878, 1.114365096, 1.131641103, 1.149287043, 1.167325463, 1.185917776, 1.204847027, 1.223968012, 1.243615421, 1.263696718, 1.284154559, 1.305122204, 1.326626572, 1.344070649, 1.383839078, 1.405911746, 1.428047918, 1.45024018, 1.472109506, 1.494367297, 1.516382815, 1.538507228, 1.560497563, 1.582667983, 1.604648622, 1.626736448, 1.648938561, 1.671232193, 1.693445935, 1.715730761, 1.737893232, 1.760075171, 1.773090818, 1.782200007, 1.804348156, 1.826386877, 1.84853163, 1.870597324, 1.892718846, 1.914871648, 1.936779005, 1.958909151, 1.981004128, 2.003197837, 2.025464654, 2.04755, 2.069700182, 2.091718373, 2.113888201, 2.136060398, 2.158289624, 2.180264191, 2.202414254, 2.224715916, 2.247021345, 2.269176049, 2.291387516, 2.313476111, 2.326170573, 2.335429921, 2.357633495, 2.379940342, 2.402192813, 2.42439467, 2.446633232, 2.468877569, 2.491060592, 2.513314823, 2.535630828, 2.557749792, 2.580162936, 2.602435893, 2.624704815, 2.646972352, 2.669225722, 2.691639318, 2.714125337, 2.736523733, 2.758779515, 2.781210104, 2.803541992, 2.825991542, 2.848390192, 2.870893882, 2.89320733, 2.915455918, 2.937845091, 2.960346084, 2.982679852, 3.005146649, 3.02774239, 3.050376772, 3.072941576, 3.095418238, 3.11321039, 3.117867616, 3.140406779, 3.162938027, 3.18562352, 3.208289242, 3.230859931, 3.253624376, 3.276398362, 3.299011984, 3.321948803, 3.344713921, 3.3676211, 3.390499039, 3.413612734, 3.436630201, 3.459511265, 3.48223841, 3.504908259, 3.528112984, 3.550958409, 3.573780646, 3.596638328, 3.619695026, 3.64256239, 3.665633321, 3.683343545, 3.688536772, 3.711710091, 3.734617698, 3.757598595, 3.780931714, 3.804213312, 3.827652854, 3.850988818, 3.8741239, 3.89718276, 3.920286634, 3.94340705, 3.96671481, 3.989896523, 4.013379229, 4.036672778, 4.060051041, 4.08303672, 4.10640057, 4.129916476, 4.15328391, 4.176743757, 4.200091387, 4.223996806, 4.247754929, 4.271171647, 4.294870338, 4.31839101, 4.341864425, 4.365810642, 4.389813131, 4.413505721, 4.437363576, 4.461160072, 4.485244755, 4.509465226, 4.533544868, 4.557521075, 4.58143756, 4.605331702, 4.629649597, 4.654338849, 4.67856908, 4.70255081, 4.727261444, 4.751578732, 4.775787232, 4.800085036, 4.824469706, 4.848994082, 4.873263151, 4.8977181, 4.921976094, 4.946515242, 4.971465689, 4.996271438, 5.020856011, 5.0453246, 5.069943696, 5.094500117, 5.119505243, 5.144680646, 5.169359087, 5.194003475, 5.219107787, 5.243822841, 5.269076907, 5.294390922, 5.319732421, 5.344801075, 5.369903605, 5.395309396, 5.420751242, 5.446184675, 5.471371425, 5.496730322, 5.522403766, 5.54783593, 5.573171939, 5.598851893, 5.624625043, 5.650378491, 5.676160128, 5.70193199, 5.727979434, 5.753988551, 5.779702337, 5.806023759, 5.832503437, 5.858193893, 5.884700562, 5.911013967, 5.937288068, 5.962911845, 5.989544556, 6.016038968, 6.021765405, 6.042805886, 6.069234376, 6.096545452, 6.123852764, 6.150387925, 6.177645232, 6.2037812, 6.230156743, 6.256649381, 6.282750935, 6.310588855, 6.337615521, 6.364788367, 6.392144377, 6.420203983, 6.447116437, 6.474764521, 6.502364754, 6.529769238, 6.557052052, 6.584991279, 6.612458475, 6.641386247, 6.668930084, 6.697800322, 6.726509995, 6.754995941, 6.78236368, 6.81095288, 6.83950134, 6.868194685, 6.896105638, 6.924874595, 6.953415695, 6.981442754, 7.009990791, 7.039180124, 7.067832482, 7.095821835, 7.124633947, 7.15370117, 7.1821442, 7.210691259, 7.239253077, 7.268739477, 7.298970966, 7.328093601, 7.357994507, 7.387132966, 7.417568761, 7.447799146, 7.477969791, 7.506752168, 7.537082903, 7.566409369, 7.595804973, 7.626173505, 7.656846318, 7.68689076, 7.716452796, 7.746099372, 7.77776348, 7.807903097, 7.838637291, 7.869475446, 7.898007097, 7.92821631, 7.959625664, 7.990043053, 8.020759328, 8.05230695, 8.082776387, 8.113834765, 8.14555263, 8.176218372, 8.208642221, 8.238427411, 8.26994779, 8.301681934, 8.332287351, 8.363891556, 8.395981186, 8.428496048, 8.459894708, 8.49111943, 8.523945296, 8.55721011, 8.589619734, 8.622282831, 8.65560952, 8.688868298, 8.721887673, 8.754682965, 8.786957854, 8.819588891, 8.852277166, 8.884767417, 8.918327862, 8.951848485, 8.986729974, 9.020028922, 9.054197551, 9.087858035, 9.121601111, 9.156251012, 9.189536396, 9.221878206, 9.255244412, 9.288354318, 9.322815121, 9.357896545, 9.392101157, 9.427771911, 9.460937578, 9.495234357, 9.528826316, 9.563500448, 9.59595505, 9.630535381, 9.666271632, 9.700189242, 9.735576007, 9.770534437, 9.807182428, 9.841594744, 9.876326976, 9.91230452, 9.946693093, 9.982556069, 10.016478678, 10.049248392, 10.083488076, 10.120434286, 10.156617455, 10.191231776, 10.227669692, 10.261932306, 10.299243926, 10.336041444, 10.371497603, 10.407478623, 10.443792893, 10.481012545, 10.518198094, 10.555726248, 10.592950408, 10.630847645, 10.667084599, 10.704363788, 10.741465101, 10.780027854, 10.817483581, 10.856015358, 10.891600093, 10.92869582, 10.966812815, 11.004168609, 11.04336318, 11.080330401, 11.117357754, 11.155394926, 11.195138652, 11.231398745, 11.268142915, 11.305026688, 11.341543142, 11.380313808, 11.419718955, 11.459786995, 11.50033222, 11.536696798, 11.575432834, 11.614170071, 11.652981088, 11.693134444, 11.733089121, 11.77359691, 11.812959144, 11.850637831, 11.889562859, 11.929322324, 11.967571689, 12.008827485, 12.047957621, 12.088055734, 12.127124644, 12.166144201, 12.208062367, 12.24706399, 12.287613053, 12.325297741, 12.36359824, 12.403306211, 12.441049272, 12.479638651, 12.52369663, 12.562895259, 12.604811586, 12.646891343, 12.685372543, 12.694183872, 12.726526437, 12.765540985, 12.804047067, 12.845086988, 12.886512108, 12.92831334, 12.97413392, 13.016569002, 13.058837558, 13.101586108, 13.143724826, 13.181878851, 13.22570256, 13.267672894, 13.310237277, 13.354195143, 13.397693393, 13.440979897, 13.484366577, 13.530128598, 13.57341327, 13.611674474, 13.653824313, 13.698783583, 13.74047497, 13.785807849, 13.829057291, 13.870731713, 13.912606294, 13.954542175, 13.997548482, 14.040949724, 14.084558518, 14.129733131, 14.174162924, 14.219230172, 14.261752239, 14.308388386, 14.352873902, 14.395960984, 14.440837194, 14.485350136, 14.531649666, 14.576011129, 14.622350059, 14.669013838, 14.708765729, 14.751921189, 14.795611794, 14.838199706, 14.886728044, 14.93109873, 14.977750113, 15.023322421, 15.06886313, 15.115933439, 15.158866464, 15.203266694, 15.250714664, 15.298237878, 15.345906951, 15.395587413, 15.444056879, 15.486395821, 15.532539748, 15.576879824, 15.621783792, 15.672698406, 15.717593684, 15.762149729, 15.809596243, 15.859370598, 15.909364924, 15.961375554, 16.008070824, 16.05394639, 16.100260324, 16.144621574, 16.194003304, 16.241985535, 16.287939274, 16.334207179, 16.382593015, 16.432362851, 16.481542894, 16.528434225, 16.582259021, 16.627020912, 16.680404374, 16.725547532, 16.775800901, 16.822178737, 16.864473323, 16.909612064, 16.954185203, 17.002200096, 17.051927144, 17.10193172, 17.157367535, 17.206684221, 17.258661628, 17.304405373, 17.352511131, 17.397075433, 17.454371981, 17.496695656, 17.552031316, 17.600399453, 17.65432924, 17.703313804, 17.752919931, 17.798583922, 17.843800373, 17.898277992, 17.947852932, 17.998242634, 18.045790778, 18.092802917, 18.140853076, 18.199572732, 18.253502547, 18.309656398, 18.358886443, 18.415068449, 18.464751709, 18.518029333, 18.570531179, 18.62187785, 18.666691487, 18.715465416, 18.764028918, 18.82051235, 18.876644652, 18.925186741, 18.973339741, 19.026380699, 19.076011142, 19.125579551, 19.183127591, 19.244029212, 19.294022443, 19.347156877, 19.396727184, 19.445968916, 19.496414085, 19.541852539, 19.592602197, 19.644559356, 19.698066736, 19.752424665, 19.807691036, 19.857758586, 19.916726404, 19.965574953, 20.018483409, 20.066149161, 20.124708796, 20.183695448, 20.231089928, 20.280293444, 20.338143311, 20.398798893, 20.457772518, 20.507573396, 20.559734743, 20.615718072, 20.674441509, 20.725215281, 20.783642318, 20.839945679, 20.891877506, 20.94442334, 21.019720982, 21.07876198, 21.123918647, 21.170105093, 21.212029057, 21.260800123, 21.31763232, 21.380429751, 21.441556798, 21.502431956, 21.572200868, 21.62365481, 21.680448912, 21.739553323, 21.783557937, 21.832141772, 21.897005295, 21.949836253, 22.010772533, 22.068266279, 22.128408257, 22.190515511, 22.25255695, 22.300474346, 22.359662529, 22.421617503, 22.473638276, 22.536997916, 22.545415883, 22.58918761, 22.638187697, 22.698457257, 22.763820349, 22.817376495, 22.879515426, 22.947892536, 22.99799628, 23.054069494, 23.11505506, 23.167447037, 23.236528349, 23.291146449, 23.369116477, 23.421573008, 23.48878331, 23.558270001, 23.628399599, 23.683992459, 23.734091184, 23.805924283, 23.847554292, 23.908566924, 23.961814435, 24.016743473, 24.089719449, 24.16022511, 24.220052191, 24.270765975, 24.337532482, 24.389976359, 24.454080976, 24.512254581, 24.572558729, 24.654944574, 24.695677753, 24.749540759, 24.814204302, 24.858737767, 24.931233955, 24.992179039, 25.060447301, 25.092992469, 25.154777062, 25.218725824, 25.293797482, 25.34357924, 25.429152612, 25.494202565, 25.540830175, 25.59809365, 25.664819399, 25.733851887, 25.786902342, 25.866363677, 25.923075397, 25.978994686, 26.054298241, 26.123382853, 26.190039929, 26.267816716, 26.332069734, 26.388126427, 26.475857331, 26.558140374, 26.626492777, 26.690365055, 26.752955816, 26.831423161, 26.906452556, 26.997905555, 27.072086566, 27.146476931, 27.21099222, 27.272204686, 27.350488857, 27.408512933, 27.463030087, 27.518802224, 27.601366792, 27.649959267, 27.704055943, 27.791772698, 27.876490665, 27.949639781, 28.009888243, 28.093863429, 28.140187601, 28.203912993, 28.302100835, 28.3655676, 28.447006244, 28.514784632, 28.6049529, 28.670819875, 28.737618424, 28.803050868, 28.87911912, 28.939529575, 29.016809383, 29.103513291, 29.181198248, 29.266550497, 29.356275841, 29.429731814, 29.492536822, 29.565058072, 29.632386315, 29.704904732, 29.78034884, 29.850361071, 29.943931226, 29.994528565, 30.101369155, 30.176326077, 30.2787371, 30.33613008, 30.420846687, 30.507811518, 30.614494856, 30.671369558, 30.748988114, 30.822563604, 30.896796931, 30.97548012, 30.998035328, 31.045200578, 31.105519869, 31.186833119, 31.247985659, 31.326722259, 31.403664689, 31.471977457, 31.519508927, 31.588296573, 31.670240239, 31.794897452, 31.860682101, 31.929100395, 31.993388537, 32.082887201, 32.148651088, 32.270805055, 32.312923209, 32.378650647, 32.466763002, 32.555345388, 32.600763047, 32.695147983, 32.826931126, 32.908446833, 32.980622789, 33.018418806, 33.091115085, 33.207859333, 33.25051713, 33.318266474, 33.369126816, 33.460685698, 33.513588683, 33.576806132, 33.654352287, 33.738226828, 33.797625398, 33.850966556, 33.966606511, 34.046071698, 34.199562718, 34.231912672, 34.301489215, 34.39047182, 34.475633542, 34.533846546, 34.566296088, 34.700325648, 34.761165595, 34.887411478, 34.926356476, 35.017190867, 35.115052424, 35.183205026, 35.242440239, 35.322072345, 35.356361151, 35.433978736, 35.488493334, 35.553823113, 35.670885448, 35.717978937, 35.816382766, 35.855958609, 35.916447393, 36.012703652, 36.056839413, 36.180130673, 36.255417912, 36.285070573, 36.37349818, 36.459180469, 36.591145993, 36.676566967, 36.781880863, 36.868041904, 36.890602929, 36.962764205, 37.05491354, 37.220399543, 37.322887558, 37.37650548, 37.47200531, 37.565898358, 37.744283404, 37.841628463, 37.94794763, 38.026369713, 38.149533609, 38.279448449, 38.357674014, 38.470426126, 38.530587654, 38.596442164, 38.647046362, 38.70437958, 38.786333193, 38.956533933, 39.026417972, 39.242454732, 39.320147952, 39.378449597, 39.445039913, 39.472177553, 39.55301151, 39.646585409, 39.734841165, 39.889621083, 39.933069446, 40.050579339, 40.178527136, 40.240936243, 40.325372096, 40.484943889, 40.592794474, 40.687148401, 40.720749425, 40.79969198, 40.929677338, 40.950532522, 41.104924058, 41.146859656, 41.252021409, 41.280141669, 41.333841313, 41.481031674, 41.533859543, 41.591232294, 41.665856534, 41.717116687, 41.721367056, 41.90600096, 42.000494836, 42.104114953, 42.16057281, 42.264203912, 42.409380514, 42.600897125, 42.679597246, 42.705197902, 42.783365402, 42.816655515, 42.929218243, 43.009425395, 43.07093373, 43.259050541, 43.291113523, 43.416344158, 43.505744313, 43.570326205, 43.679930558, 43.898057405, 44.002086306, 44.089833968, 44.146438582, 44.193472054, 44.393909584, 44.570327604, 44.629770954, 44.666507049, 44.765437873, 44.804370014, 45.009913481, 45.186232314, 45.311265244, 45.508858924, 45.58845445, 45.624818966, 45.69282507, 45.745497609, 45.861473033, 45.966155619, 46.090869802, 46.101902651, 46.317067637, 46.463401265, 46.547772946, 46.548442085, 46.632923257, 46.692206239, 46.695471465, 46.761312925, 47.052056927, 47.205664456, 47.330914993, 47.776049076, 47.778531342, 47.851009041, 47.87258814, 48.024027734, 48.129251112, 48.204660235, 48.23214584, 48.687249608, 48.792678621, 48.937994876, 49.062211337, 49.118003431, 49.27004682, 49.312498646, 49.375249109, 49.416792448, 49.508937595, 49.523261652, 49.5899737, 49.814258192, 49.896687927, 49.934163258, 50.099350611, 50.102919909, 50.413135224, 50.43944627, 50.562703481 ), "1400" = c(1.9557e-05, 1.9601e-05, 1.9625e-05, 1.9929e-05, 1.9955e-05, 2.0042e-05, 2.006e-05, 2.0257e-05, 2.1044e-05, 2.1085e-05, 2.1311e-05, 2.1606e-05, 2.1724e-05, 2.1838e-05, 2.2111e-05, 2.2419e-05, 2.2495e-05, 2.2612e-05, 2.2719e-05, 2.2833e-05, 2.3089e-05, 2.3244e-05, 2.3659e-05, 2.4371e-05, 2.4395e-05, 2.4433e-05, 2.4716e-05, 2.4745e-05, 2.5356e-05, 2.5966e-05, 2.6005e-05, 2.6134e-05, 2.6703e-05, 2.708e-05, 2.7145e-05, 2.7279e-05, 2.7283e-05, 2.8251e-05, 2.841e-05, 2.9157e-05, 2.9187e-05, 2.9535e-05, 3.047e-05, 3.0866e-05, 3.1362e-05, 3.1685e-05, 3.1987e-05, 3.2242e-05, 3.2465e-05, 3.2842e-05, 3.3493e-05, 3.3862e-05, 3.3923e-05, 3.4949e-05, 3.5281e-05, 3.576e-05, 3.5915e-05, 3.6158e-05, 3.6568e-05, 3.6839e-05, 3.7119e-05, 3.7647e-05, 3.8419e-05, 3.9212e-05, 3.9983e-05, 4.0495e-05, 4.1125e-05, 4.1378e-05, 4.1661e-05, 4.1737e-05, 4.1981e-05, 4.2461e-05, 4.2893e-05, 4.3133e-05, 4.4181e-05, 4.4583e-05, 4.5543e-05, 4.587e-05, 4.599e-05, 4.6231e-05, 4.6458e-05, 4.7177e-05, 4.7727e-05, 4.7886e-05, 4.8726e-05, 4.9618e-05, 5.041e-05, 5.077e-05, 5.2288e-05, 5.2772e-05, 5.3548e-05, 5.4146e-05, 5.4311e-05, 5.4732e-05, 5.4842e-05, 5.5679e-05, 5.5927e-05, 5.6439e-05, 5.687e-05, 5.7435e-05, 5.8812e-05, 5.9758e-05, 6.0292e-05, 6.1324e-05, 6.2087e-05, 6.2915e-05, 6.4371e-05, 6.5017e-05, 6.6313e-05, 6.7112e-05, 6.7938e-05, 6.8685e-05, 6.9392e-05, 6.9998e-05, 7.0587e-05, 7.2148e-05, 7.2743e-05, 7.3587e-05, 7.3818e-05, 7.4572e-05, 7.6178e-05, 7.7476e-05, 7.7757e-05, 7.8547e-05, 8.0024e-05, 8.0702e-05, 8.1934e-05, 8.2579e-05, 8.3466e-05, 8.4076e-05, 8.5469e-05, 8.6683e-05, 8.7617e-05, 8.8398e-05, 8.9228e-05, 8.9771e-05, 9.0812e-05, 9.1902e-05, 9.2882e-05, 9.4565e-05, 9.5605e-05, 9.6031e-05, 9.8194e-05, 9.9315e-05, 0.000100213, 0.000100975, 0.000102078, 0.000103376, 0.00010586, 0.0001062, 0.00010784, 0.00010892, 0.000109354, 0.000112153, 0.000114079, 0.000115041, 0.000116503, 0.000118004, 0.000119533, 0.000120685, 0.000122652, 0.000123493, 0.000125554, 0.000126894, 0.000127969, 0.000129365, 0.000131223, 0.00013321, 0.000134443, 0.000135532, 0.000137165, 0.000138554, 0.00014024, 0.000141623, 0.000143389, 0.000145038, 0.00014725, 0.000148859, 0.000150055, 0.000152129, 0.000153294, 0.000154962, 0.000156253, 0.000158049, 0.000159876, 0.000162387, 0.000165482, 0.000166971, 0.000168011, 0.000170428, 0.000172522, 0.000174213, 0.000176774, 0.000180178, 0.000181671, 0.000183707, 0.000185607, 0.000188375, 0.00019003, 0.000194522, 0.000195828, 0.000199953, 0.000202452, 0.000204246, 0.000206417, 0.000209427, 0.0002121, 0.000214602, 0.000216642, 0.00021891, 0.000221794, 0.000224474, 0.000226374, 0.000228446, 0.000230724, 0.000233799, 0.000235531, 0.000237626, 0.000240728, 0.000242749, 0.000244096, 0.0002467, 0.000248703, 0.000251638, 0.000254492, 0.000257057, 0.000258687, 0.000261876, 0.000264932, 0.000267357, 0.000270939, 0.000275707, 0.000279746, 0.00028242, 0.000284697, 0.000288236, 0.000292896, 0.000295844, 0.000298731, 0.000300956, 0.000305146, 0.000309508, 0.000312106, 0.00031683, 0.000321729, 0.000324717, 0.000328472, 0.000331666, 0.000334458, 0.000338883, 0.000341967, 0.000346886, 0.000352725, 0.000357213, 0.000361518, 0.000364486, 0.000370484, 0.000376278, 0.000380732, 0.000385111, 0.000389379, 0.000394179, 0.000399642, 0.000403693, 0.000407652, 0.000412439, 0.000419271, 0.000424349, 0.000428005, 0.000434295, 0.000438989, 0.000443843, 0.000449389, 0.000455214, 0.000460679, 0.000466644, 0.000472731, 0.000477975, 0.000482114, 0.00048518, 0.000490528, 0.000496096, 0.000500686, 0.000507698, 0.000514557, 0.00052048, 0.000526646, 0.000534217, 0.000538039, 0.000543445, 0.000549774, 0.000556369, 0.000564253, 0.000570288, 0.000576017, 0.000581693, 0.00058947, 0.00059829, 0.000604755, 0.000614711, 0.000620847, 0.000625014, 0.000631248, 0.000638484, 0.000647157, 0.000654985, 0.000662842, 0.000670113, 0.000675472, 0.000684512, 0.000692168, 0.000699811, 0.000707461, 0.000715373, 0.000722661, 0.000734186, 0.00074225, 0.000752589, 0.000758674, 0.000768136, 0.000776424, 0.00078547, 0.00079446, 0.000804174, 0.000812214, 0.00082138, 0.000830745, 0.000839456, 0.000849544, 0.000860428, 0.000870718, 0.00088152, 0.000893621, 0.000903423, 0.00091238, 0.000925255, 0.000937035, 0.000947013, 0.000957079, 0.000969447, 0.000978208, 0.000980085, 0.000991836, 0.001004085, 0.001018679, 0.001029151, 0.001043152, 0.001055715, 0.001068996, 0.001078719, 0.001092298, 0.001104814, 0.001119417, 0.001130732, 0.001141218, 0.001153837, 0.001167904, 0.001182688, 0.001200456, 0.001215957, 0.001228867, 0.00124244, 0.001259623, 0.001273253, 0.001288586, 0.001307358, 0.001321937, 0.001336386, 0.001351942, 0.001369839, 0.001385874, 0.001401235, 0.001416045, 0.001433032, 0.00144952, 0.001466444, 0.001486053, 0.001503982, 0.001522727, 0.001541739, 0.001559081, 0.001578047, 0.001596441, 0.001614798, 0.001630265, 0.001653219, 0.0016719, 0.001689752, 0.001712831, 0.00173261, 0.001749922, 0.001768849, 0.001788587, 0.001807618, 0.001828062, 0.001848814, 0.00186584, 0.001888492, 0.001918593, 0.001941275, 0.001965903, 0.00198733, 0.002007108, 0.002030074, 0.002053358, 0.002076604, 0.002103523, 0.002130251, 0.002155788, 0.002178897, 0.002205229, 0.002230042, 0.002257287, 0.002285922, 0.002313924, 0.002343839, 0.002368653, 0.002394848, 0.002419802, 0.002453267, 0.002483225, 0.002508459, 0.002536248, 0.002561742, 0.002592595, 0.002623472, 0.002654859, 0.002683004, 0.002716109, 0.002746949, 0.002774998, 0.002804684, 0.002838779, 0.002874351, 0.002910434, 0.002940372, 0.002974277, 0.003010553, 0.003050948, 0.003086573, 0.003125085, 0.003157816, 0.003194046, 0.003232077, 0.003263791, 0.003302824, 0.003337126, 0.003375039, 0.003410213, 0.003450267, 0.003492988, 0.003533796, 0.003571347, 0.00361361, 0.003655543, 0.003699853, 0.003739652, 0.003779751, 0.003822727, 0.003863705, 0.003913137, 0.003955758, 0.004001968, 0.004044548, 0.004091201, 0.004139522, 0.004187619, 0.004233574, 0.004280428, 0.004322545, 0.004378182, 0.004429462, 0.004480681, 0.004532145, 0.004584918, 0.004637844, 0.004690066, 0.004746317, 0.004802738, 0.004852106, 0.004908287, 0.004968449, 0.005024628, 0.005084318, 0.005146878, 0.005210677, 0.005273441, 0.005333148, 0.005394902, 0.005459906, 0.005520311, 0.005579774, 0.005641954, 0.005706832, 0.00577238, 0.005834312, 0.005902485, 0.005968862, 0.0060369, 0.0061138, 0.006186009, 0.006254117, 0.006333239, 0.00640549, 0.006482765, 0.006560922, 0.006644949, 0.006722578, 0.006797858, 0.006871935, 0.006951907, 0.007023561, 0.007106232, 0.007186456, 0.007264733, 0.00735579, 0.007439022, 0.007519836, 0.007607464, 0.007694593, 0.007782785, 0.00786916, 0.007959373, 0.00805087, 0.008143756, 0.00823737, 0.00833466, 0.008439538, 0.008538559, 0.00864399, 0.008750809, 0.008852931, 0.008963641, 0.009066083, 0.009162719, 0.009273034, 0.009377397, 0.009486681, 0.009599999, 0.009714458, 0.009816843, 0.009907784, 0.009927709, 0.010035715, 0.010150855, 0.010269228, 0.010391223, 0.010506832, 0.010630338, 0.010751478, 0.010873165, 0.010997625, 0.011128655, 0.011258405, 0.011386759, 0.011517397, 0.011654793, 0.011794429, 0.011931445, 0.012071038, 0.012207362, 0.012347995, 0.012494234, 0.012649439, 0.012788618, 0.012933547, 0.013078183, 0.013246245, 0.013404049, 0.013560675, 0.013724574, 0.013889011, 0.014055387, 0.014222291, 0.014379636, 0.01455, 0.014710012, 0.014881961, 0.015053958, 0.015226723, 0.015405334, 0.015590425, 0.015767063, 0.015951342, 0.016136543, 0.016314456, 0.016503396, 0.016689336, 0.016888426, 0.017099743, 0.017286571, 0.017486986, 0.017683444, 0.017889572, 0.018088607, 0.018305716, 0.018525876, 0.018740443, 0.018964886, 0.019189766, 0.019412312, 0.019643218, 0.019879451, 0.020114311, 0.0203453, 0.020589621, 0.02082256, 0.021063936, 0.021300216, 0.021547513, 0.02180482, 0.022050384, 0.022297139, 0.022567489, 0.022813711, 0.023078821, 0.023350439, 0.023617028, 0.023900061, 0.02417602, 0.024455067, 0.0247462, 0.025039303, 0.025348163, 0.025637247, 0.025936391, 0.026241111, 0.026546469, 0.02684471, 0.027162462, 0.027484937, 0.027808041, 0.028136588, 0.028455341, 0.028790073, 0.029123789, 0.029475088, 0.029813726, 0.030159971, 0.030527102, 0.030874864, 0.031227721, 0.031586913, 0.031957736, 0.032329096, 0.032720133, 0.033099701, 0.033476326, 0.03386464, 0.034248205, 0.034639483, 0.035057258, 0.03545921, 0.035863928, 0.036295067, 0.036721147, 0.037142062, 0.037576998, 0.038012293, 0.038448243, 0.038899462, 0.039359219, 0.039809974, 0.040262606, 0.040741054, 0.041212774, 0.041690477, 0.042178779, 0.042680297, 0.043195303, 0.043682423, 0.044199546, 0.044714167, 0.045231155, 0.045755741, 0.046295281, 0.046837374, 0.047381292, 0.047922926, 0.048467159, 0.04903878, 0.049627283, 0.0502102, 0.050798438, 0.051399406, 0.052001552, 0.052618398, 0.053239398, 0.053866395, 0.054483365, 0.055116062, 0.055771517, 0.056436735, 0.057105354, 0.057786069, 0.058468412, 0.059167178, 0.059851067, 0.060549971, 0.061274538, 0.061990045, 0.062730573, 0.063470839, 0.064219338, 0.06498654, 0.065749979, 0.066519619, 0.067305165, 0.068096954, 0.06891395, 0.069708536, 0.070505665, 0.071319241, 0.072162339, 0.073024865, 0.073885269, 0.074737337, 0.07563517, 0.076516944, 0.077418042, 0.078325576, 0.079234849, 0.080180006, 0.081124847, 0.082073589, 0.083048382, 0.084042716, 0.085067235, 0.086076347, 0.087109409, 0.088140916, 0.0891933, 0.090235756, 0.091292953, 0.092374706, 0.093465365, 0.094567083, 0.095681907, 0.096809007, 0.097942489, 0.099072308, 0.10029988, 0.101255485, 0.101505427, 0.102713332, 0.103922698, 0.105182569, 0.106439688, 0.10771328, 0.109005999, 0.11032077, 0.111639575, 0.11297243, 0.114310675, 0.11569249, 0.11705603, 0.118490002, 0.119895866, 0.12135149, 0.122825132, 0.124289847, 0.125762078, 0.127280547, 0.128822104, 0.130364789, 0.131907171, 0.133476832, 0.135093577, 0.136749031, 0.138374213, 0.140010093, 0.141665908, 0.143339537, 0.145041514, 0.146782593, 0.14852736, 0.150305668, 0.152093342, 0.153898626, 0.155751041, 0.157646134, 0.159560227, 0.161519814, 0.163489461, 0.165467719, 0.167472244, 0.169463415, 0.171541062, 0.173634356, 0.175744214, 0.17784306, 0.179978569, 0.182184542, 0.184379828, 0.186653988, 0.188929394, 0.19121866, 0.193562295, 0.195893499, 0.198272992, 0.200692338, 0.203126283, 0.205581658, 0.208089745, 0.210676288, 0.21328748, 0.215908496, 0.218547441, 0.221196538, 0.223872012, 0.226620084, 0.229390607, 0.232199419, 0.235052623, 0.237897171, 0.240853717, 0.243834408, 0.24680919, 0.249849058, 0.252920831, 0.256008741, 0.259154912, 0.262325247, 0.265568106, 0.268830401, 0.27216281, 0.275501727, 0.278905485, 0.282386265, 0.28581591, 0.289377276, 0.292923268, 0.296574941, 0.300300053, 0.304100342, 0.30790601, 0.311712065, 0.315603497, 0.319528103, 0.320377937, 0.323504665, 0.327554713, 0.331662893, 0.335846275, 0.340091743, 0.344405611, 0.348697837, 0.35306978, 0.357561025, 0.362095857, 0.366636915, 0.371251927, 0.37596912, 0.380716551, 0.385526774, 0.390478314, 0.39549135, 0.400586075, 0.405681307, 0.410863975, 0.416145536, 0.421437226, 0.426877126, 0.432265756, 0.437806164, 0.438978108, 0.443466667, 0.449238548, 0.455070023, 0.461002859, 0.467003844, 0.473026121, 0.479222357, 0.485566167, 0.491928437, 0.498408743, 0.504983153, 0.511685146, 0.518382375, 0.525181218, 0.53214871, 0.539209454, 0.546301132, 0.553529914, 0.560890753, 0.568354416, 0.575945912, 0.58365622, 0.591468391, 0.599477336, 0.607599377, 0.615820732, 0.624218049, 0.632663353, 0.641268509, 0.64992217, 0.658794824, 0.6678033, 0.676993841, 0.686331142, 0.695815806, 0.699923255, 0.705458428, 0.715222588, 0.725199804, 0.735359521, 0.745724047, 0.756176628, 0.766868512, 0.777693014, 0.788733898, 0.799919373, 0.811257965, 0.822908287, 0.834665519, 0.846662414, 0.858995446, 0.871505097, 0.884236407, 0.897058733, 0.91014572, 0.923488343, 0.937071926, 0.95093981, 0.965115281, 0.979460192, 0.994154618, 1.00026155, 1.009207995, 1.024366062, 1.039831033, 1.055517978, 1.071695064, 1.088352245, 1.105110137, 1.122224043, 1.139617399, 1.157374167, 1.175637434, 1.194226724, 1.213243712, 1.232604118, 1.252384045, 1.272724701, 1.293443883, 1.314748915, 1.336396107, 1.353798141, 1.393638995, 1.415929908, 1.438464448, 1.461034321, 1.483354823, 1.50551998, 1.527941618, 1.550020506, 1.572475171, 1.594934385, 1.617219714, 1.639548815, 1.661932716, 1.684015365, 1.706393622, 1.728680392, 1.751047476, 1.773249438, 1.786361301, 1.795504179, 1.817890506, 1.840253578, 1.862623338, 1.884909908, 1.907102564, 1.929428066, 1.951991186, 1.974465086, 1.996832042, 2.019287073, 2.041516779, 2.063863715, 2.086207553, 2.108657496, 2.130994022, 2.153315191, 2.175607016, 2.198041478, 2.220549746, 2.242788571, 2.26516972, 2.287299587, 2.309725988, 2.332157271, 2.345103122, 2.354551075, 2.37701133, 2.399401657, 2.421769415, 2.444178797, 2.466565659, 2.488894511, 2.511171545, 2.533719597, 2.556142569, 2.578551591, 2.600900907, 2.62327121, 2.645558439, 2.66831711, 2.690619328, 2.71308115, 2.735698359, 2.758171514, 2.780766253, 2.803369848, 2.825784526, 2.848376415, 2.871118814, 2.893709853, 2.916312831, 2.938985498, 2.961532574, 2.984063769, 3.007084765, 3.029819122, 3.05242974, 3.075065342, 3.097786239, 3.120290678, 3.138595326, 3.143138807, 3.165753352, 3.188303087, 3.211117964, 3.233946875, 3.256693017, 3.279476065, 3.302219065, 3.325076308, 3.348031573, 3.371023197, 3.393853706, 3.416629654, 3.43935658, 3.461963312, 3.48464817, 3.507600205, 3.530247976, 3.553243547, 3.576311715, 3.599366772, 3.622050514, 3.644821641, 3.667910881, 3.691090515, 3.709192935, 3.714203426, 3.737225722, 3.760089618, 3.783195889, 3.806151918, 3.829701503, 3.853052996, 3.875989394, 3.899086651, 3.922245962, 3.945285274, 3.968822263, 3.992161372, 4.015503732, 4.038958159, 4.062369924, 4.085294831, 4.108853405, 4.131933677, 4.155126151, 4.178815259, 4.202170367, 4.225806498, 4.249240514, 4.272659753, 4.295975589, 4.319120688, 4.34299789, 4.36636751, 4.390012879, 4.413420188, 4.437250575, 4.46100466, 4.484519299, 4.507947343, 4.531598058, 4.555535266, 4.579071294, 4.603076404, 4.626996338, 4.650868516, 4.674578279, 4.698443937, 4.722529387, 4.746595483, 4.770731486, 4.795174471, 4.819377821, 4.843151148, 4.867003296, 4.891154197, 4.915232147, 4.939400353, 4.963530931, 4.988021516, 5.012532819, 5.037044045, 5.061417823, 5.086344713, 5.110344002, 5.134820423, 5.159243266, 5.183732782, 5.208167514, 5.233020451, 5.257622551, 5.282321875, 5.307442883, 5.332176481, 5.356667318, 5.381561495, 5.406026596, 5.431092582, 5.455551068, 5.480755814, 5.505342677, 5.53033027, 5.555473671, 5.58020766, 5.605328796, 5.629677427, 5.654798694, 5.680152262, 5.70503731, 5.72998503, 5.7553273, 5.780395547, 5.805842275, 5.830729555, 5.855432595, 5.881516504, 5.90682925, 5.932589366, 5.957933664, 5.983568848, 6.008660684, 6.01369119, 6.034179043, 6.059871101, 6.085338134, 6.111235371, 6.13676503, 6.162626659, 6.188559255, 6.214220653, 6.239969623, 6.265655381, 6.291941068, 6.317879488, 6.344081815, 6.370280524, 6.396431332, 6.422679801, 6.448775838, 6.474601213, 6.500591937, 6.52708401, 6.553706743, 6.581246439, 6.607044297, 6.633551752, 6.659931823, 6.686663243, 6.713563833, 6.740568024, 6.766979809, 6.793661248, 6.820047929, 6.847084815, 6.873875951, 6.900916072, 6.9278946, 6.955439384, 6.982079631, 7.00893743, 7.036629894, 7.063436241, 7.090757243, 7.118159677, 7.145149518, 7.172546611, 7.199133025, 7.226137416, 7.253748899, 7.28066249, 7.307010725, 7.334955527, 7.362939006, 7.391100528, 7.41923321, 7.446797739, 7.474194501, 7.501337543, 7.529851429, 7.558395207, 7.586110388, 7.613972257, 7.642842644, 7.671579463, 7.7007358, 7.730473535, 7.759163455, 7.787658514, 7.816631701, 7.845221146, 7.874694048, 7.903333605, 7.931523082, 7.959998189, 7.988725627, 8.018115527, 8.047276419, 8.076474759, 8.105611668, 8.134499257, 8.163621593, 8.193563075, 8.222706938, 8.251210999, 8.280681378, 8.310227298, 8.339234082, 8.369460499, 8.398618924, 8.429747731, 8.459202266, 8.489648093, 8.520178161, 8.549956661, 8.580769044, 8.610630722, 8.641811188, 8.672023077, 8.701513402, 8.732364581, 8.764570164, 8.794801983, 8.825242383, 8.855579836, 8.88593896, 8.916458, 8.947141439, 8.97714099, 9.007531957, 9.038003424, 9.067751705, 9.098099079, 9.129150905, 9.159420953, 9.190520009, 9.22152027, 9.253642546, 9.28536682, 9.31678295, 9.347545514, 9.379531688, 9.411739382, 9.443229572, 9.473858987, 9.50708456, 9.539930882, 9.572888582, 9.604947669, 9.636768791, 9.669754048, 9.703692742, 9.735954215, 9.767598098, 9.799818398, 9.833339329, 9.865322259, 9.897244987, 9.929565793, 9.96263004, 9.99614191, 10.029423723, 10.061496404, 10.096368643, 10.129285302, 10.162407322, 10.196669142, 10.23015354, 10.263455248, 10.296873533, 10.331723228, 10.365737652, 10.398727153, 10.430592965, 10.465739684, 10.499886518, 10.5321491, 10.566349961, 10.600786636, 10.634535064, 10.667872464, 10.702385596, 10.736899479, 10.770501338, 10.804498042, 10.837408584, 10.869951332, 10.903533681, 10.936984931, 10.970744427, 11.003876846, 11.037739278, 11.070744779, 11.105535989, 11.141013069, 11.174567243, 11.207635996, 11.241241912, 11.275584966, 11.313721189, 11.348555874, 11.384298219, 11.418391208, 11.455344413, 11.490273534, 11.525401172, 11.560860492, 11.598069995, 11.635842157, 11.672348124, 11.709282926, 11.744394311, 11.779500305, 11.813783506, 11.847416003, 11.881482305, 11.91802442, 11.954398107, 11.990304612, 12.025341941, 12.062864302, 12.098314823, 12.137065368, 12.144080477, 12.171712535, 12.209689254, 12.247231269, 12.286496231, 12.320219878, 12.3549833, 12.391423273, 12.42813351, 12.46619794, 12.505127214, 12.542206183, 12.580501859, 12.621896682, 12.660755711, 12.698353826, 12.734886617, 12.774949035, 12.813491821, 12.85305132, 12.891474742, 12.930349454, 12.96765662, 13.004177392, 13.043219809, 13.080463743, 13.115670887, 13.152252192, 13.189413715, 13.233257507, 13.275458095, 13.314033418, 13.354720995, 13.394788099, 13.435832168, 13.478091542, 13.51721069, 13.555007043, 13.593909583, 13.633749595, 13.670609897, 13.708208597, 13.747615287, 13.788082682, 13.826151881, 13.863777676, 13.903548252, 13.938007739, 13.979227175, 14.019175241, 14.059401571, 14.101189731, 14.139567334, 14.183184046, 14.225310526, 14.266969155, 14.30768243, 14.348715649, 14.385657037, 14.423667384, 14.468381412, 14.504384227, 14.543107384, 14.582956718, 14.625876955, 14.663871271, 14.701288241, 14.744714608, 14.782306498, 14.823090854, 14.865584123, 14.90765267, 14.956032811, 14.995987686, 15.036447523, 15.077237903, 15.11872368, 15.15846607, 15.198468379, 15.239060853, 15.279264547, 15.323296986, 15.369676308, 15.409992044, 15.45101432, 15.49525383, 15.536879963, 15.58128018, 15.624105197, 15.664015155, 15.704989668, 15.750717728, 15.794980123, 15.843806669, 15.889077914, 15.930491587, 15.965719794, 16.006807194, 16.044612202, 16.085479522, 16.124280106, 16.163047626, 16.207151024, 16.251519402, 16.29573528, 16.337733325, 16.377904406, 16.420161829, 16.464119138, 16.509040972, 16.554276831, 16.588300722, 16.626627306, 16.668050989, 16.709773839, 16.748497735, 16.792322636, 16.830464613, 16.872421627, 16.91194236, 16.956655816, 17.000694098, 17.043050476, 17.082726985, 17.128539006, 17.174802834, 17.217439299, 17.261790481, 17.30679014, 17.349595891, 17.396218969, 17.437284917, 17.479042616, 17.51786286, 17.565512675, 17.612361664, 17.652306298, 17.696367194, 17.742567186, 17.796929383, 17.84050704, 17.879916745, 17.930596281, 17.974834859, 18.023546789, 18.062622227, 18.109707625, 18.158150143, 18.202170988, 18.255216235, 18.301217556, 18.344620355, 18.392987629, 18.442799352, 18.488035879, 18.539895773, 18.59228136, 18.641380028, 18.679036504, 18.722044537, 18.773120266, 18.818881312, 18.862535604, 18.906485207, 18.955018415, 18.998822255, 19.046437547, 19.092151946, 19.12964049, 19.177795994, 19.231511481, 19.273757432, 19.323876185, 19.375560923, 19.416849495, 19.446307171, 19.503348284, 19.549005217, 19.604543787, 19.647013786, 19.696427838, 19.734966535, 19.78097635, 19.824296597, 19.878802975, 19.928621596, 19.971260334, 20.022190161, 20.073094047, 20.124960571, 20.172635364, 20.222312984, 20.270958181, 20.312024481, 20.365015758, 20.427090044, 20.473703607, 20.515249168, 20.564696515, 20.614959446, 20.667044815, 20.681257654, 20.719347681, 20.776657764, 20.82620978, 20.885768934, 20.957814167, 21.018579301, 21.068308628, 21.11549699, 21.154744293, 21.207091806, 21.268854521, 21.324743588, 21.384390871, 21.44059625, 21.495914379, 21.538548784, 21.580694965, 21.622789161, 21.685927581, 21.732243053, 21.779867761, 21.838766132, 21.883938076, 21.929197269, 21.981940588, 22.03309007, 22.077548095, 22.130603323, 22.193208918, 22.24506311, 22.30418011, 22.365744186, 22.414007633, 22.470805793, 22.516511425, 22.570139557, 22.619967981, 22.671430524, 22.729383393, 22.791316107, 22.83306684, 22.889561274, 22.934715728, 22.978575088, 23.034771834, 23.088027372, 23.139198523, 23.186955089, 23.245435732, 23.296440737, 23.345197054, 23.394852522, 23.446039779, 23.501613925, 23.554599917, 23.61134638, 23.671664028, 23.743174295, 23.790787563, 23.849950095, 23.896432486, 23.939921082, 24.001680689, 24.030130502, 24.083803236, 24.123704073, 24.161995627, 24.213365715, 24.257040707, 24.30481365, 24.350418776, 24.392430971, 24.448896262, 24.502045212, 24.569909581, 24.608883276, 24.662411175, 24.704228261, 24.759181939, 24.802349416, 24.854108896, 24.892790956, 24.94282338, 25.027031351, 25.084693296, 25.130546146, 25.177756255, 25.253899956, 25.314612368, 25.387317465, 25.437248984, 25.485181644, 25.538943948, 25.584773691, 25.626985639, 25.692420443, 25.735012425, 25.780218571, 25.825892137, 25.896376421, 25.960326753, 26.004551508, 26.042243756, 26.100057753, 26.160301535, 26.215330788, 26.280559801, 26.308079421, 26.344841663, 26.390459988, 26.44947313, 26.520386866, 26.581978548, 26.620257114, 26.684970662, 26.712828385, 26.750231366, 26.819310444, 26.843492792, 26.876337118, 26.934328619, 26.999245942, 27.051379673, 27.114767464, 27.159227408, 27.2219473, 27.285635656, 27.323865602, 27.361623534, 27.430302937, 27.496971347, 27.567818744, 27.646721851, 27.734282655, 27.785641343, 27.86506394, 27.901761874, 27.97790915, 28.025542601, 28.082084824, 28.123988108, 28.189764201, 28.230136671, 28.275177373, 28.319527116, 28.384325614, 28.427420154, 28.495134184, 28.525313242, 28.607314746, 28.658748243, 28.699078971, 28.762344325, 28.822369002, 28.877885884, 28.896814614, 28.972039797, 29.023542786, 29.114303556, 29.175061912, 29.219473823, 29.272580375, 29.321260793, 29.378384734, 29.457956179, 29.537965447, 29.589877151, 29.686331105, 29.767352551, 29.833514032, 29.926747154, 29.993946064, 30.027962402, 30.090903986, 30.220045864, 30.270068908, 30.322087813, 30.373282942, 30.447759785, 30.499284655, 30.5222983, 30.580558184, 30.606605066, 30.629144683, 30.677999858, 30.762917982, 30.814702698, 30.905052401, 30.92580219, 31.00721972, 31.072389624, 31.203176724, 31.247013112, 31.285970415, 31.359586133, 31.416620031, 31.476244708, 31.548780655, 31.582602169, 31.62705909, 31.691524754, 31.746602792, 31.794163396, 31.827324028, 31.915208466, 31.969111809, 32.007857837, 32.047950771, 32.090151229, 32.130534268, 32.184262429, 32.229464681, 32.313650151, 32.34933069, 32.370706656, 32.419351548, 32.471737516, 32.514156137, 32.617641224, 32.69117151, 32.762280079, 32.850302649, 32.893861942, 33.017440115, 33.078530893, 33.113845267, 33.203980397, 33.230265606, 33.284780446, 33.352211395, 33.384701885, 33.466736377, 33.612706147, 33.696734426, 33.710193141, 33.803945565, 33.840470559, 33.909107039, 33.972815431, 34.122736792, 34.178420854, 34.283759864, 34.377837902, 34.430271562, 34.483913762, 34.545395999, 34.639271025, 34.691177686, 34.791209335, 34.866262859, 34.931677727, 35.020166197, 35.073025481, 35.179643203, 35.222288439, 35.31312208, 35.425258923, 35.449960631, 35.499491171, 35.516105026, 35.532973033, 35.569992184, 35.597828633, 35.790737615, 35.905389813, 35.958035108, 36.052691139, 36.111967815, 36.175239844, 36.206822674, 36.344621937, 36.397322601, 36.465226023, 36.591330558, 36.746498603, 36.789894411, 36.79410234, 36.915716594, 36.959222283, 37.040435602, 37.138384876, 37.153737189, 37.205095449, 37.23235986, 37.320857544, 37.380472389, 37.40338375, 37.431159451, 37.442680672, 37.451605439, 37.501508472, 37.551489034, 37.568619649, 37.613774606, 37.702834164, 37.782673476, 37.877107447, 38.011416295, 38.108680931, 38.182994424, 38.226432693, 38.285319348, 38.355185207, 38.460388418, 38.554045822, 38.749648961, 38.785236648, 38.916024443, 39.120586267, 39.187118426, 39.20587648, 39.389512046, 39.429515082, 39.544600096, 39.568374944, 39.593452873, 39.723959041, 39.735758904, 39.883765243, 40.04750588, 40.260945495, 40.27876909, 40.362889356, 40.419115362, 40.483215324, 40.622415666, 40.654353622, 40.677498121, 40.840584042, 40.891379468, 41.059325758, 41.16831433, 41.212693742, 41.216573687, 41.383086251, 41.3928515, 41.446492336, 41.604237595, 41.606580646, 41.661792192 ), "1600" = c(1.5429e-05, 1.5429e-05, 1.5502e-05, 1.5676e-05, 1.5683e-05, 1.5711e-05, 1.5755e-05, 1.5941e-05, 1.6414e-05, 1.665e-05, 1.6774e-05, 1.6819e-05, 1.6889e-05, 1.7286e-05, 1.7391e-05, 1.7442e-05, 1.7472e-05, 1.77e-05, 1.7862e-05, 1.8308e-05, 1.8919e-05, 1.9114e-05, 1.9695e-05, 1.9749e-05, 2.0273e-05, 2.0302e-05, 2.0833e-05, 2.0961e-05, 2.1482e-05, 2.222e-05, 2.2246e-05, 2.272e-05, 2.2904e-05, 2.2957e-05, 2.3586e-05, 2.5046e-05, 2.5222e-05, 2.5395e-05, 2.5538e-05, 2.5665e-05, 2.6015e-05, 2.6388e-05, 2.7088e-05, 2.7603e-05, 2.802e-05, 2.8439e-05, 2.8468e-05, 2.8858e-05, 2.8881e-05, 2.9768e-05, 2.9863e-05, 3.0138e-05, 3.0389e-05, 3.0928e-05, 3.0953e-05, 3.0998e-05, 3.1756e-05, 3.2203e-05, 3.3321e-05, 3.3536e-05, 3.4646e-05, 3.5085e-05, 3.5139e-05, 3.5549e-05, 3.6116e-05, 3.6789e-05, 3.7246e-05, 3.7557e-05, 3.812e-05, 3.8288e-05, 3.8813e-05, 4.026e-05, 4.091e-05, 4.1086e-05, 4.1594e-05, 4.2132e-05, 4.2621e-05, 4.2878e-05, 4.35e-05, 4.3999e-05, 4.4135e-05, 4.4561e-05, 4.5127e-05, 4.5708e-05, 4.6021e-05, 4.65e-05, 4.7372e-05, 4.7701e-05, 4.8316e-05, 4.8954e-05, 4.9428e-05, 4.9802e-05, 5.0364e-05, 5.0848e-05, 5.1389e-05, 5.2806e-05, 5.3264e-05, 5.404e-05, 5.4984e-05, 5.5791e-05, 5.6093e-05, 5.6598e-05, 5.834e-05, 5.8741e-05, 5.9739e-05, 6.0615e-05, 6.0778e-05, 6.1008e-05, 6.1565e-05, 6.2533e-05, 6.2893e-05, 6.3532e-05, 6.401e-05, 6.4981e-05, 6.6291e-05, 6.7857e-05, 6.8277e-05, 6.8991e-05, 6.9518e-05, 7.1455e-05, 7.2671e-05, 7.3423e-05, 7.4514e-05, 7.5137e-05, 7.6229e-05, 7.7579e-05, 7.837e-05, 7.8967e-05, 8.0357e-05, 8.1973e-05, 8.2867e-05, 8.4336e-05, 8.5646e-05, 8.7194e-05, 8.8245e-05, 8.9166e-05, 9.0646e-05, 9.1774e-05, 9.2835e-05, 9.4343e-05, 9.5314e-05, 9.6482e-05, 9.7113e-05, 9.8441e-05, 9.9077e-05, 0.000100277, 0.000101397, 0.000103426, 0.00010544, 0.000106332, 0.000107546, 0.000109439, 0.000110119, 0.000112006, 0.000113459, 0.000114421, 0.000115262, 0.000116363, 0.000118349, 0.000120467, 0.000121316, 0.000122815, 0.00012392, 0.000126855, 0.000128914, 0.0001304, 0.000132091, 0.000133006, 0.00013478, 0.000135987, 0.000137777, 0.000139442, 0.000140694, 0.000142958, 0.00014442, 0.00014533, 0.000147008, 0.000148673, 0.00015085, 0.000153591, 0.000155925, 0.000157814, 0.00015873, 0.000160471, 0.000161474, 0.000163344, 0.000165458, 0.000167785, 0.000170045, 0.000172111, 0.000173982, 0.000175741, 0.000178115, 0.000180787, 0.000182875, 0.000184637, 0.000187237, 0.00018918, 0.000192298, 0.000195396, 0.00019726, 0.000200825, 0.000202917, 0.000204773, 0.000206044, 0.000207829, 0.000210567, 0.00021284, 0.000214591, 0.000216996, 0.000219819, 0.00022304, 0.000226093, 0.000228112, 0.000231362, 0.000235295, 0.000238009, 0.000240085, 0.000242728, 0.000245528, 0.000247448, 0.000250373, 0.000253172, 0.000255632, 0.000259746, 0.000262787, 0.000266097, 0.000268316, 0.000271554, 0.000274737, 0.000278844, 0.000281461, 0.00028401, 0.000286507, 0.000290678, 0.000294297, 0.000297514, 0.000300982, 0.00030483, 0.000310753, 0.000314905, 0.000317275, 0.000320542, 0.00032489, 0.000328711, 0.000332668, 0.000336881, 0.000340415, 0.00034426, 0.000347488, 0.00035232, 0.000356722, 0.000362091, 0.000366847, 0.000370819, 0.000375442, 0.000380031, 0.000383863, 0.000388287, 0.000392681, 0.000396285, 0.00040128, 0.000406373, 0.000411834, 0.00041859, 0.00042315, 0.000428721, 0.000432611, 0.000437113, 0.000442339, 0.000446627, 0.000451114, 0.000455989, 0.00046149, 0.000466454, 0.000471996, 0.000478517, 0.000483835, 0.000489808, 0.000494674, 0.000502333, 0.000509458, 0.000514011, 0.000521089, 0.000526352, 0.000532403, 0.000537597, 0.000543229, 0.000548652, 0.000554624, 0.000559728, 0.000566757, 0.000573237, 0.000579888, 0.00058489, 0.000593027, 0.000601964, 0.000608525, 0.000614732, 0.000622215, 0.000629067, 0.000636441, 0.000643431, 0.000650764, 0.000658451, 0.000668782, 0.000677106, 0.000684099, 0.000691977, 0.000700064, 0.00070754, 0.000717052, 0.000727087, 0.000733895, 0.000743611, 0.000751248, 0.000760583, 0.000767425, 0.000775764, 0.000783763, 0.000794093, 0.00080283, 0.000813, 0.000820202, 0.000831188, 0.000837282, 0.000847292, 0.000855275, 0.000865128, 0.000874738, 0.000885952, 0.000896486, 0.000908242, 0.000920581, 0.000931772, 0.000942032, 0.000953125, 0.000965111, 0.000977077, 0.000985375, 0.000994929, 0.000997963, 0.001008955, 0.001022849, 0.001033936, 0.001045234, 0.001057371, 0.001071207, 0.001085629, 0.001094893, 0.001106005, 0.001120353, 0.001132616, 0.001145793, 0.001156872, 0.001170388, 0.001182704, 0.001195934, 0.001208907, 0.001222069, 0.001237532, 0.001252475, 0.001267303, 0.001279582, 0.001293584, 0.001308188, 0.001320279, 0.001334946, 0.00135138, 0.001367365, 0.001382517, 0.001396851, 0.00141322, 0.001431087, 0.001446578, 0.001463723, 0.001480189, 0.001493637, 0.001513629, 0.001529922, 0.001551964, 0.001568307, 0.001586021, 0.00160327, 0.001624866, 0.001641832, 0.001659574, 0.001681092, 0.001701537, 0.001718758, 0.001738425, 0.001757453, 0.001777873, 0.00180048, 0.001824612, 0.001846783, 0.001863458, 0.001884942, 0.00190526, 0.001925835, 0.001946874, 0.001971254, 0.001996102, 0.00201698, 0.002037683, 0.002060103, 0.002082758, 0.002106409, 0.002129007, 0.002154989, 0.002181851, 0.002207108, 0.002231596, 0.002256836, 0.002282343, 0.002309303, 0.002334112, 0.002358345, 0.002387156, 0.002410807, 0.002445481, 0.002476899, 0.002507092, 0.002534101, 0.002562057, 0.002592023, 0.002626494, 0.002658379, 0.002688962, 0.002720578, 0.002750578, 0.002786117, 0.002817885, 0.002853243, 0.002891893, 0.00292367, 0.00295806, 0.002993221, 0.003031546, 0.003065154, 0.003097967, 0.003134769, 0.003171656, 0.003209061, 0.003249423, 0.003285864, 0.003322365, 0.003360666, 0.003400079, 0.003437071, 0.003473894, 0.003515581, 0.003559024, 0.00360032, 0.003649522, 0.003698003, 0.003741713, 0.003781833, 0.003827065, 0.003873217, 0.003916216, 0.003960069, 0.004001991, 0.004051017, 0.004094639, 0.004146773, 0.004192485, 0.004237869, 0.004288254, 0.004334161, 0.004386776, 0.00443606, 0.004491919, 0.004542123, 0.004596868, 0.004648514, 0.004704818, 0.004756557, 0.004812243, 0.004867444, 0.004926127, 0.004977904, 0.005042279, 0.005101005, 0.005168282, 0.005227751, 0.005288878, 0.005347916, 0.005411128, 0.005475387, 0.005537296, 0.00560163, 0.005665474, 0.005731182, 0.005799887, 0.005871427, 0.005941132, 0.006009724, 0.006076033, 0.006148237, 0.006218893, 0.006292189, 0.006359582, 0.006439367, 0.006510455, 0.006584907, 0.006662414, 0.006741152, 0.006818895, 0.00689376, 0.006971988, 0.007052107, 0.007136479, 0.007215388, 0.007296005, 0.007384794, 0.007464833, 0.007552816, 0.007643337, 0.007730512, 0.007823017, 0.007915192, 0.008008941, 0.008103251, 0.008198545, 0.00829169, 0.008387876, 0.008482239, 0.008579054, 0.008673823, 0.008770975, 0.008870707, 0.008970726, 0.009071687, 0.009173407, 0.009286794, 0.009395629, 0.009511466, 0.009617749, 0.009724064, 0.009840628, 0.009930635, 0.009953314, 0.010056113, 0.010174415, 0.010297218, 0.010414827, 0.010536746, 0.010658477, 0.010779294, 0.010904682, 0.011033844, 0.011165349, 0.011294265, 0.011428849, 0.011567471, 0.011703105, 0.011831625, 0.011961905, 0.012097813, 0.012246705, 0.012386111, 0.012535143, 0.012675752, 0.012823601, 0.012964074, 0.013109329, 0.013267414, 0.013417575, 0.013573353, 0.013723856, 0.013883887, 0.014044804, 0.014214641, 0.014373087, 0.014549717, 0.014719474, 0.014891004, 0.015065456, 0.015230503, 0.015410477, 0.01558535, 0.01576399, 0.015940998, 0.016131492, 0.016314916, 0.0164995, 0.01669181, 0.016886333, 0.017087569, 0.017289212, 0.017495236, 0.017695021, 0.017903128, 0.018123719, 0.018334283, 0.018543303, 0.018763286, 0.018974197, 0.01919034, 0.019419827, 0.019648392, 0.019868826, 0.0200986, 0.020326864, 0.020557739, 0.020800127, 0.021045922, 0.021294759, 0.021544889, 0.021797034, 0.022050806, 0.022318409, 0.022581664, 0.022838818, 0.023113601, 0.023382366, 0.023654476, 0.023943223, 0.024222676, 0.024504254, 0.024786238, 0.025072508, 0.025358893, 0.02564041, 0.025951102, 0.026253172, 0.026554094, 0.026870869, 0.027189375, 0.027500485, 0.027815363, 0.028147987, 0.028473854, 0.028811833, 0.029151045, 0.029484778, 0.029840035, 0.030182473, 0.030533674, 0.030903302, 0.031260466, 0.031623893, 0.031985371, 0.032351336, 0.032721524, 0.033089718, 0.033469262, 0.033866059, 0.034265423, 0.034659535, 0.035069018, 0.03548302, 0.035901449, 0.036299412, 0.036721638, 0.037147432, 0.037603547, 0.038036559, 0.038474564, 0.03893835, 0.039390503, 0.03985716, 0.040330201, 0.040808614, 0.041262245, 0.041744501, 0.042240743, 0.042737184, 0.043217702, 0.043720182, 0.044229595, 0.044751914, 0.045273508, 0.045808981, 0.04632464, 0.04684647, 0.047406408, 0.047951898, 0.048507716, 0.049067145, 0.049650962, 0.050251409, 0.050819259, 0.051411028, 0.052019155, 0.052621082, 0.053259754, 0.053892309, 0.054529077, 0.055152761, 0.055778699, 0.056427688, 0.05708661, 0.05775989, 0.05844234, 0.05914142, 0.059815449, 0.060542863, 0.061255231, 0.061978805, 0.062713398, 0.063427199, 0.064209904, 0.0649629, 0.065734681, 0.066501624, 0.06728921, 0.068061513, 0.068863178, 0.069677794, 0.070498, 0.071347865, 0.07218547, 0.073036561, 0.073887898, 0.074748795, 0.075646941, 0.076541067, 0.077463257, 0.078371762, 0.079294904, 0.080228659, 0.081174575, 0.082136122, 0.083112567, 0.084080915, 0.085056381, 0.086073347, 0.087087481, 0.088084922, 0.089127502, 0.090161475, 0.091218411, 0.092288735, 0.09340744, 0.094543748, 0.095669537, 0.096791278, 0.09795662, 0.099127195, 0.100324926, 0.101269506, 0.101512671, 0.102694862, 0.103907066, 0.105130157, 0.106343017, 0.107637831, 0.108917362, 0.110199767, 0.111497711, 0.112820924, 0.114166762, 0.115513864, 0.116889578, 0.118285102, 0.119715286, 0.121146989, 0.122557836, 0.123999963, 0.125490773, 0.127002164, 0.128559446, 0.130117799, 0.131666819, 0.133245883, 0.134843891, 0.136434495, 0.138071105, 0.139695146, 0.141377841, 0.143025099, 0.144712048, 0.146484536, 0.148265951, 0.150054487, 0.151863707, 0.153678822, 0.155546528, 0.157445894, 0.159378584, 0.16127648, 0.163233911, 0.165220328, 0.167205386, 0.169207173, 0.171241583, 0.173306295, 0.175410707, 0.177544072, 0.179671827, 0.181875594, 0.184126187, 0.186359403, 0.188623434, 0.190900709, 0.193216497, 0.195565062, 0.197960046, 0.200381666, 0.202850093, 0.205293192, 0.207810895, 0.210362019, 0.212956329, 0.215518686, 0.21816936, 0.2208806, 0.223603901, 0.226385057, 0.229143349, 0.231985751, 0.23482168, 0.237687093, 0.240638413, 0.243595793, 0.24661656, 0.249649324, 0.25271809, 0.255777426, 0.258916117, 0.262152814, 0.265407384, 0.268695049, 0.272022597, 0.275403282, 0.278797462, 0.282287125, 0.285795577, 0.289310268, 0.292934226, 0.296581763, 0.300287972, 0.304025139, 0.307837455, 0.311699543, 0.315601897, 0.31955116, 0.320436997, 0.323612939, 0.327697997, 0.331861897, 0.336009706, 0.340237773, 0.344577254, 0.348944171, 0.353366288, 0.357856636, 0.362355215, 0.366907623, 0.371539207, 0.376264112, 0.381048939, 0.385865788, 0.390800155, 0.395791822, 0.400878989, 0.406037887, 0.411262358, 0.416630108, 0.421979023, 0.427393993, 0.432926261, 0.438545755, 0.43974163, 0.444262503, 0.450077806, 0.45591108, 0.461838344, 0.467916429, 0.473967582, 0.480154108, 0.48641231, 0.492832985, 0.499267884, 0.505787923, 0.512445466, 0.519210777, 0.526033606, 0.533041678, 0.540132802, 0.547313913, 0.554534185, 0.56195817, 0.569539305, 0.577144126, 0.584818106, 0.592708947, 0.600656244, 0.608779217, 0.617033414, 0.625326132, 0.63386066, 0.642506026, 0.651271439, 0.660308695, 0.669343907, 0.678496284, 0.687811049, 0.697395995, 0.701433696, 0.707008968, 0.71688292, 0.726837425, 0.736949456, 0.747299233, 0.757839371, 0.768590847, 0.779304812, 0.790358829, 0.801545576, 0.813004891, 0.824652184, 0.83643861, 0.848561517, 0.860839569, 0.873237031, 0.885940878, 0.898807215, 0.912086718, 0.925448942, 0.93898047, 0.952988749, 0.967195111, 0.981772759, 0.996488979, 1.002659336, 1.011533585, 1.026872347, 1.042371669, 1.058205367, 1.074458722, 1.09104704, 1.107968177, 1.125166609, 1.142753445, 1.160645538, 1.178867673, 1.197612278, 1.216757517, 1.236216802, 1.25615546, 1.276430999, 1.297232504, 1.318443414, 1.34024465, 1.357931643, 1.398277137, 1.420627753, 1.442855232, 1.465339526, 1.487806492, 1.51027426, 1.532863565, 1.55518873, 1.57760317, 1.599794104, 1.622303248, 1.644646639, 1.667104133, 1.68940649, 1.711715774, 1.734081696, 1.756341451, 1.778712715, 1.791714751, 1.80093287, 1.823375273, 1.845778989, 1.86808116, 1.890502199, 1.913046114, 1.935507021, 1.9579107, 1.980191557, 2.002701846, 2.025318947, 2.047779854, 2.070306402, 2.092856202, 2.115372469, 2.137899054, 2.160152398, 2.182625092, 2.205053356, 2.227576069, 2.25009301, 2.272490638, 2.294855657, 2.31745729, 2.339687688, 2.352784426, 2.362338915, 2.384734743, 2.407454626, 2.429879675, 2.452345596, 2.474819495, 2.497560322, 2.520294619, 2.542873033, 2.565461007, 2.587916722, 2.610303005, 2.633030433, 2.655569141, 2.67815637, 2.700894697, 2.723508491, 2.746047139, 2.768836256, 2.791491986, 2.81414865, 2.836817195, 2.859535279, 2.882248664, 2.90494815, 2.927642139, 2.950500234, 2.973199561, 2.996005575, 3.01852218, 3.04143652, 3.064254766, 3.08696452, 3.109719517, 3.132284047, 3.150233208, 3.154904707, 3.177518944, 3.200070439, 3.223085186, 3.245889815, 3.268581446, 3.291363895, 3.314064341, 3.336920648, 3.359671254, 3.382824332, 3.405831244, 3.428880893, 3.451801983, 3.474295141, 3.497069478, 3.520121086, 3.543040798, 3.565812537, 3.588648035, 3.611885231, 3.635308733, 3.658352415, 3.681446271, 3.704592291, 3.72275618, 3.727782289, 3.751175736, 3.774372326, 3.79747392, 3.820661543, 3.84375931, 3.866915856, 3.890087249, 3.912815769, 3.93613948, 3.959403241, 3.982547884, 4.005537176, 4.029456016, 4.05290932, 4.076234494, 4.09950343, 4.122970868, 4.14622911, 4.169698177, 4.193558474, 4.217114459, 4.240544631, 4.264273449, 4.287878802, 4.311355283, 4.33495505, 4.358201356, 4.381357732, 4.404865589, 4.428253439, 4.451816733, 4.475485654, 4.498923768, 4.522709624, 4.546249185, 4.570363145, 4.593556634, 4.617323282, 4.641174163, 4.664844263, 4.68876457, 4.712317907, 4.73638299, 4.760072388, 4.784009097, 4.808013055, 4.832176243, 4.856159607, 4.879796281, 4.903847617, 4.927568606, 4.951370553, 4.975219739, 4.999425165, 5.02399793, 5.048271294, 5.072384001, 5.096851306, 5.121451596, 5.145068096, 5.169443984, 5.193592183, 5.217926387, 5.242406766, 5.267069849, 5.291370622, 5.3158874, 5.340285422, 5.364716514, 5.388935226, 5.413726713, 5.438723293, 5.463177482, 5.488151501, 5.513147549, 5.537689171, 5.562553809, 5.587369563, 5.611533421, 5.63634903, 5.660998501, 5.685690339, 5.710540349, 5.735240309, 5.760223278, 5.785379224, 5.81058182, 5.835242701, 5.860362919, 5.885938784, 5.911236382, 5.936892029, 5.962403731, 5.987832739, 6.012867366, 6.018207803, 6.038310414, 6.063555767, 6.088389549, 6.114251595, 6.139325991, 6.16505587, 6.19019936, 6.215035092, 6.240783547, 6.266751503, 6.292138139, 6.317962412, 6.343385909, 6.369749669, 6.395414942, 6.421238347, 6.447090618, 6.47375521, 6.499618794, 6.526007761, 6.552150251, 6.578060103, 6.60442248, 6.630879073, 6.656959637, 6.683034283, 6.709817901, 6.736579057, 6.762808405, 6.789650034, 6.816670682, 6.843444285, 6.870190848, 6.896653312, 6.922976714, 6.949410856, 6.975781186, 7.003134607, 7.029728354, 7.057342421, 7.084363633, 7.11062707, 7.137326882, 7.164559278, 7.191554273, 7.219005114, 7.245949975, 7.273036124, 7.299211891, 7.326472888, 7.353682459, 7.380198468, 7.407413287, 7.43503963, 7.462437045, 7.490824057, 7.518079384, 7.54522333, 7.573040329, 7.60051581, 7.627887504, 7.655744416, 7.683796803, 7.712069548, 7.740210449, 7.767995289, 7.79690927, 7.824213804, 7.851626407, 7.879881152, 7.908902077, 7.937769976, 7.966033022, 7.995271463, 8.0239938, 8.05159895, 8.081220385, 8.109303744, 8.138303267, 8.166646227, 8.195605657, 8.223856372, 8.253152374, 8.281561297, 8.310207454, 8.338788755, 8.367529671, 8.396683903, 8.425367224, 8.455255906, 8.484687715, 8.513571646, 8.542277191, 8.570569374, 8.599927875, 8.628936065, 8.657432311, 8.686885247, 8.716439257, 8.74657098, 8.77660767, 8.806689051, 8.836692891, 8.867154939, 8.894903293, 8.923066222, 8.953073646, 8.982715133, 9.01281534, 9.043260037, 9.074307116, 9.104462266, 9.134647217, 9.164655895, 9.194556846, 9.224431715, 9.255679884, 9.286348335, 9.316669342, 9.34801196, 9.377393309, 9.407564688, 9.438020907, 9.469406126, 9.501202486, 9.531037046, 9.562006923, 9.594707878, 9.624065648, 9.654667582, 9.6853032, 9.71519593, 9.745725499, 9.776807272, 9.80799562, 9.839917857, 9.871575762, 9.90374516, 9.934506229, 9.966715946, 9.999690644, 10.03175538, 10.064654045, 10.098590464, 10.129886474, 10.161656434, 10.193586504, 10.225453899, 10.257336906, 10.289431808, 10.32146145, 10.353853677, 10.385004416, 10.415340945, 10.447176691, 10.480413392, 10.513314592, 10.545860204, 10.578817059, 10.614763707, 10.645337414, 10.679973375, 10.712078659, 10.74468375, 10.776557157, 10.809167151, 10.843028001, 10.875888854, 10.907981212, 10.941427913, 10.974833425, 11.009198465, 11.042054854, 11.075696601, 11.108373206, 11.142076256, 11.177074479, 11.211640714, 11.245463319, 11.279385295, 11.31326608, 11.346739309, 11.380947317, 11.414235863, 11.447709762, 11.480948589, 11.515708904, 11.550479024, 11.584566456, 11.617981749, 11.65263368, 11.688025544, 11.721377891, 11.756258209, 11.790452322, 11.82394084, 11.859973549, 11.895459077, 11.930500015, 11.965009393, 11.971103554, 11.998278917, 12.035505633, 12.068894099, 12.106530595, 12.141621862, 12.174936423, 12.209782363, 12.244506078, 12.28142006, 12.317875797, 12.35078942, 12.386191379, 12.423800109, 12.461231787, 12.495682102, 12.534300463, 12.572178564, 12.610720193, 12.64481116, 12.681109192, 12.718231955, 12.753885483, 12.790180515, 12.827538488, 12.86407267, 12.901970935, 12.936523075, 12.971271903, 13.009024878, 13.04438126, 13.077419398, 13.114134972, 13.152412424, 13.189959603, 13.228409301, 13.268225079, 13.30440195, 13.338069146, 13.376742958, 13.414638707, 13.454468083, 13.494275836, 13.532079747, 13.569685351, 13.605382032, 13.643473958, 13.681424671, 13.719625017, 13.757164701, 13.79405773, 13.832919425, 13.870850099, 13.910856725, 13.948840593, 13.988370002, 14.026642593, 14.065658833, 14.099737238, 14.138177058, 14.176493667, 14.214922385, 14.251774564, 14.291584165, 14.330689447, 14.369386466, 14.412705725, 14.451034136, 14.489017769, 14.532634475, 14.570140818, 14.608799094, 14.645874725, 14.689380956, 14.730929552, 14.770403977, 14.807128265, 14.847827397, 14.88521805, 14.92364729, 14.961915961, 14.999697934, 15.036439638, 15.073776177, 15.110787482, 15.149795889, 15.194035627, 15.231205969, 15.273125529, 15.315532862, 15.356905307, 15.390934509, 15.43005507, 15.472395089, 15.514743319, 15.554932584, 15.594404232, 15.638060689, 15.672821312, 15.71311781, 15.750127997, 15.793500171, 15.841602912, 15.881364823, 15.924793596, 15.963267235, 16.000779479, 16.037777265, 16.077594446, 16.121969555, 16.165579533, 16.206087043, 16.244573797, 16.284087685, 16.327880821, 16.373187627, 16.409850952, 16.456786558, 16.498130944, 16.538940416, 16.580340108, 16.624824799, 16.670961077, 16.714110619, 16.755887196, 16.801665587, 16.848314295, 16.893805033, 16.939904473, 16.991652362, 17.039402926, 17.090611701, 17.133538273, 17.179692671, 17.216093297, 17.256501136, 17.29833338, 17.343507434, 17.385523175, 17.427808601, 17.473739931, 17.512458695, 17.55376207, 17.600292196, 17.640882113, 17.685526778, 17.730845234, 17.768556358, 17.810075665, 17.851405085, 17.892590298, 17.930533199, 17.974883739, 18.020051824, 18.066170861, 18.102111727, 18.147958696, 18.194983874, 18.240637892, 18.287260083, 18.323742784, 18.364275985, 18.401410317, 18.441368786, 18.491787677, 18.538702514, 18.590128474, 18.635309184, 18.680841185, 18.727965868, 18.772300879, 18.818803283, 18.864352329, 18.904939217, 18.95016447, 18.994401079, 19.046271059, 19.082408549, 19.131460414, 19.178004314, 19.218801982, 19.261740542, 19.301760184, 19.341236214, 19.388253209, 19.431356623, 19.472752027, 19.513076562, 19.551692396, 19.599232743, 19.638316153, 19.680382254, 19.729324554, 19.78311108, 19.844413854, 19.879252815, 19.919825462, 19.975068247, 20.025687891, 20.072518325, 20.110886998, 20.128081014, 20.169125058, 20.215976179, 20.263503132, 20.310612101, 20.345020355, 20.402118367, 20.460427196, 20.502555645, 20.551178063, 20.605504985, 20.652122001, 20.704488477, 20.754369038, 20.788472809, 20.827010383, 20.854642463, 20.903418966, 20.948287524, 21.006649087, 21.065962278, 21.110384924, 21.151994732, 21.213153618, 21.276295001, 21.328537984, 21.375643435, 21.429377049, 21.489267378, 21.538877529, 21.592730365, 21.641462657, 21.697726047, 21.741103077, 21.800450378, 21.855036304, 21.903819857, 21.955076884, 22.002407767, 22.045681067, 22.088619216, 22.133688958, 22.17279244, 22.22759466, 22.277606606, 22.349116865, 22.395332239, 22.454928026, 22.492114507, 22.5335903, 22.585986824, 22.643244159, 22.690518404, 22.765071433, 22.828359884, 22.867793703, 22.929819393, 22.978341318, 23.042315839, 23.104946734, 23.159874091, 23.205425075, 23.237584505, 23.29192309, 23.332039984, 23.38655006, 23.423923791, 23.480983059, 23.511270892, 23.564663701, 23.606431337, 23.665713367, 23.713914371, 23.750440349, 23.83692907, 23.875839203, 23.927170148, 23.979727538, 24.04744189, 24.11800154, 24.170320245, 24.212957101, 24.259692575, 24.331170263, 24.383081649, 24.454871211, 24.505407441, 24.564187953, 24.606364392, 24.667614039, 24.727986567, 24.785641141, 24.843561178, 24.893510814, 24.947860468, 25.003659619, 25.07199456, 25.136088418, 25.214366002, 25.247313836, 25.32245746, 25.364520735, 25.424114178, 25.479364044, 25.522802065, 25.575517863, 25.631853221, 25.689985402, 25.752332422, 25.802260334, 25.833019136, 25.866032057, 25.918868343, 25.958726527, 26.023962077, 26.055960592, 26.104636351, 26.142758848, 26.221864542, 26.267510941, 26.30606783, 26.338651575, 26.420018431, 26.467902508, 26.522116456, 26.55598812, 26.60118913, 26.674762784, 26.722190345, 26.761777447, 26.84437887, 26.892265327, 26.94118676, 26.98608192, 27.040424992, 27.0997155, 27.158187351, 27.238544127, 27.319151355, 27.380372826, 27.453694496, 27.527193999, 27.569440412, 27.636989289, 27.662847899, 27.712015067, 27.761327817, 27.836586881, 27.913129959, 27.981212181, 28.049944503, 28.137567088, 28.175747425, 28.270791609, 28.292786868, 28.346059669, 28.43816374, 28.509443421, 28.558549598, 28.621104419, 28.680815907, 28.773272175, 28.828602833, 28.900834703, 28.923200479, 28.994028217, 29.058703991, 29.119930943, 29.199810948, 29.243220861, 29.276462308, 29.314352725, 29.357288842, 29.397896218, 29.485177302, 29.531216534, 29.57464366, 29.660637701, 29.696946413, 29.75420616, 29.786526243, 29.855013669, 29.920288875, 29.989002565, 30.035939576, 30.105316534, 30.153648879, 30.234207363, 30.268747816, 30.384515317, 30.430541947, 30.506694486, 30.575730853, 30.630199164, 30.682712078, 30.72026582, 30.776704323, 30.814868589, 30.869474797, 30.944085274, 30.964573291, 31.009524066, 31.054147689, 31.081272822, 31.132684141, 31.212187568, 31.280157847, 31.369542877, 31.428073902, 31.461385688, 31.4946169, 31.543433571, 31.591121796, 31.6584126, 31.689342907, 31.735535054, 31.848386582, 31.897110002, 31.950285711, 31.992722355, 32.089818042, 32.151777874, 32.249571823, 32.297425024, 32.398991692, 32.469577166, 32.566622575, 32.630667244, 32.738736606, 32.780642994, 32.843150707, 32.897517289, 32.954468423, 33.006420947, 33.068993482, 33.139020076, 33.190405733, 33.235932381, 33.253707904, 33.324041461, 33.416805241, 33.540840672, 33.583914453, 33.666985197, 33.705743271, 33.80090168, 33.856271559, 33.915238873, 33.969648157, 34.000572567, 34.101838382, 34.207119684, 34.360237318, 34.434008667, 34.494776717, 34.513529009, 34.566050281, 34.658779631, 34.753837492, 34.801640701, 34.872282315, 34.964060761, 35.078031269, 35.120185776, 35.203808161, 35.291778556, 35.450368538, 35.52288054, 35.597986107, 35.690497, 35.730722665, 35.794333741, 35.838063034, 36.059208058, 36.129263774, 36.169818263, 36.240156283, 36.308225576, 36.337594598, 36.393600753, 36.45822071, 36.549820233, 36.562347847, 36.608831358, 36.705273047, 36.764182818, 36.842432099, 37.010863194, 37.101026885, 37.280058217, 37.30146787, 37.368160152, 37.442581065, 37.45807429, 37.494084094, 37.628309004, 37.831186753, 37.9813575, 38.039334241, 38.092772981, 38.302386917, 38.343143608, 38.478730355, 38.544825363, 38.570504001, 38.609939266, 38.731521011, 38.778094647, 38.834390457, 38.969807286, 39.217661473, 39.218565094, 39.290387909, 39.298300934, 39.308237003, 39.320686929, 39.354856367, 39.53870889, 39.571738646, 39.676400236, 39.75364742, 39.807568455, 39.827533501, 39.84619277, 39.98243036, 40.022169738, 40.137975383, 40.21487771, 40.219443896, 40.23214859, 40.315357471, 40.350356397, 40.432050237, 40.48518292, 40.748858137, 40.801278542, 40.833267647, 41.044011231, 41.109762981, 41.112099824, 41.146532736), "2400" = c(1.9153e-05, 1.9492e-05, 1.9722e-05, 2.0133e-05, 2.0616e-05, 2.1255e-05, 2.1271e-05, 2.1503e-05, 2.2242e-05, 2.2762e-05, 2.3285e-05, 2.4045e-05, 2.4393e-05, 2.4616e-05, 2.4878e-05, 2.5373e-05, 2.5784e-05, 2.5974e-05, 2.6069e-05, 2.6155e-05, 2.6289e-05, 2.6564e-05, 2.712e-05, 2.726e-05, 2.7466e-05, 2.759e-05, 2.7727e-05, 2.8275e-05, 2.8312e-05, 2.8625e-05, 2.8854e-05, 2.9597e-05, 3.0016e-05, 3.0173e-05, 3.0553e-05, 3.0956e-05, 3.1233e-05, 3.1432e-05, 3.2004e-05, 3.2614e-05, 3.2711e-05, 3.2871e-05, 3.4163e-05, 3.496e-05, 3.5163e-05, 3.5343e-05, 3.5898e-05, 3.6221e-05, 3.6644e-05, 3.7308e-05, 3.7632e-05, 3.8202e-05, 3.9174e-05, 3.9567e-05, 4.0097e-05, 4.0732e-05, 4.1156e-05, 4.1518e-05, 4.1676e-05, 4.182e-05, 4.218e-05, 4.2446e-05, 4.3502e-05, 4.3754e-05, 4.4179e-05, 4.4409e-05, 4.4773e-05, 4.4986e-05, 4.6416e-05, 4.6693e-05, 4.7664e-05, 4.8021e-05, 4.8412e-05, 4.9876e-05, 5.003e-05, 5.0835e-05, 5.1256e-05, 5.1492e-05, 5.2274e-05, 5.3425e-05, 5.4139e-05, 5.49e-05, 5.5465e-05, 5.598e-05, 5.7155e-05, 5.7506e-05, 5.8728e-05, 5.9033e-05, 5.9739e-05, 6.0075e-05, 6.041e-05, 6.114e-05, 6.2552e-05, 6.3085e-05, 6.3215e-05, 6.4046e-05, 6.4341e-05, 6.4674e-05, 6.5373e-05, 6.6745e-05, 6.728e-05, 6.7435e-05, 6.8311e-05, 6.8581e-05, 6.9132e-05, 6.9311e-05, 7.0258e-05, 7.1203e-05, 7.1958e-05, 7.2506e-05, 7.312e-05, 7.3499e-05, 7.4586e-05, 7.4897e-05, 7.5293e-05, 7.578e-05, 7.6852e-05, 7.71e-05, 7.7396e-05, 7.7832e-05, 7.8762e-05, 7.9235e-05, 7.9697e-05, 8.016e-05, 8.1243e-05, 8.2304e-05, 8.3192e-05, 8.4095e-05, 8.4602e-05, 8.5914e-05, 8.7528e-05, 8.8851e-05, 8.9921e-05, 9.0659e-05, 9.1322e-05, 9.1947e-05, 9.3708e-05, 9.4398e-05, 9.5692e-05, 9.6786e-05, 9.7833e-05, 9.9894e-05, 0.000100947, 0.000101344, 0.000102409, 0.000103426, 0.000104458, 0.000105045, 0.000107457, 0.000108787, 0.000109871, 0.000111403, 0.00011225, 0.000113849, 0.000115285, 0.000117037, 0.000118909, 0.000120592, 0.000122355, 0.000124865, 0.000125892, 0.000126447, 0.000128146, 0.000129765, 0.000130586, 0.000131929, 0.000133892, 0.000135507, 0.000137285, 0.00013882, 0.000140808, 0.000142258, 0.000143392, 0.000146107, 0.000147297, 0.00014845, 0.000149237, 0.00015119, 0.00015239, 0.000154087, 0.000156415, 0.000158396, 0.000159915, 0.000162057, 0.000165078, 0.000168089, 0.000170266, 0.000172299, 0.000174267, 0.000176141, 0.00017794, 0.000180112, 0.000182032, 0.000184665, 0.000186377, 0.000188278, 0.000190267, 0.000191473, 0.000193227, 0.000195082, 0.000196336, 0.000197967, 0.000200679, 0.000203023, 0.00020533, 0.000207138, 0.0002103, 0.000213078, 0.000214908, 0.000216858, 0.000218814, 0.00022039, 0.000222266, 0.000224067, 0.00022778, 0.000230371, 0.000232872, 0.000235019, 0.000237498, 0.000242325, 0.0002478, 0.000251056, 0.000253986, 0.000255367, 0.000257478, 0.00025986, 0.000262703, 0.000266565, 0.000271263, 0.00027502, 0.000277441, 0.000280389, 0.000283326, 0.000285581, 0.000290157, 0.000293012, 0.00029682, 0.000300095, 0.000302782, 0.000307121, 0.000311122, 0.000313893, 0.000318602, 0.000323209, 0.000325126, 0.00032861, 0.000331161, 0.000333796, 0.000336815, 0.000341932, 0.000345581, 0.000349392, 0.00035564, 0.000361531, 0.000366277, 0.000369529, 0.000373339, 0.000378272, 0.000382412, 0.000387271, 0.000390537, 0.000395817, 0.000400601, 0.000404521, 0.000409952, 0.000414135, 0.000419169, 0.00042465, 0.000428981, 0.000432551, 0.000437116, 0.000441972, 0.00044743, 0.000452246, 0.000457114, 0.000463828, 0.000468802, 0.000474012, 0.000479012, 0.000482649, 0.000487169, 0.000492929, 0.000498259, 0.000503745, 0.000509763, 0.000513576, 0.000518694, 0.000524898, 0.00053374, 0.000540728, 0.000547471, 0.000552903, 0.000558219, 0.00056694, 0.000573611, 0.000581725, 0.000588822, 0.000595552, 0.000601719, 0.000608019, 0.000613146, 0.000619941, 0.000629632, 0.000637084, 0.000643112, 0.000649759, 0.000656482, 0.000663163, 0.000671553, 0.00067943, 0.000686192, 0.000694356, 0.000703456, 0.000712528, 0.000721253, 0.000730114, 0.000738225, 0.00074729, 0.000757841, 0.000765947, 0.000773796, 0.000782988, 0.000794662, 0.000805332, 0.000814862, 0.000826721, 0.000835808, 0.000845238, 0.000854215, 0.000863486, 0.000872939, 0.000884606, 0.00089401, 0.000900543, 0.000913095, 0.000923649, 0.000936204, 0.0009463, 0.000957887, 0.000970848, 0.000979369, 0.000981168, 0.000991246, 0.001002185, 0.001011767, 0.001024025, 0.00103687, 0.001048088, 0.001063923, 0.001076834, 0.001088496, 0.001101524, 0.001112938, 0.001127152, 0.001142777, 0.001155587, 0.001171065, 0.001186109, 0.001199367, 0.001214884, 0.001227338, 0.001247847, 0.001262596, 0.00127828, 0.001293359, 0.001309843, 0.001322773, 0.00133929, 0.001354437, 0.001369085, 0.001384321, 0.001403076, 0.001417176, 0.0014344, 0.001451698, 0.001468393, 0.00148381, 0.001503589, 0.001519888, 0.001536722, 0.001553903, 0.001574655, 0.001594193, 0.001612789, 0.001629309, 0.001647077, 0.001666395, 0.001683459, 0.001705521, 0.001727294, 0.001748351, 0.001767089, 0.001786798, 0.001807303, 0.001826541, 0.001848261, 0.001870537, 0.001891286, 0.001910911, 0.001931361, 0.001955136, 0.001978998, 0.00199966, 0.00202569, 0.002047329, 0.00206937, 0.002094927, 0.002119931, 0.002144034, 0.002170549, 0.002193687, 0.002219459, 0.002241756, 0.002268696, 0.002297271, 0.002325325, 0.002348473, 0.002378283, 0.002405831, 0.002433776, 0.00246389, 0.002494876, 0.002521592, 0.002551777, 0.002580125, 0.002611893, 0.002644627, 0.002672017, 0.002704129, 0.002731378, 0.002765283, 0.002795026, 0.002824441, 0.002859184, 0.002890874, 0.002922257, 0.002955474, 0.002988574, 0.003027056, 0.003065257, 0.003105392, 0.003134643, 0.003169331, 0.003211305, 0.003245485, 0.003285037, 0.003321736, 0.003357099, 0.00339218, 0.003434201, 0.00347816, 0.003519709, 0.003562599, 0.00360059, 0.003641282, 0.003678794, 0.003724275, 0.003772538, 0.003810009, 0.003851523, 0.003895599, 0.003942072, 0.003986513, 0.00403523, 0.004083008, 0.004129935, 0.004176546, 0.004222643, 0.004275023, 0.004328916, 0.004382876, 0.004429201, 0.004485914, 0.00453693, 0.004589279, 0.0046401, 0.004693341, 0.004746714, 0.004803795, 0.004859776, 0.004923945, 0.004981061, 0.005039741, 0.005097638, 0.005160248, 0.00522229, 0.005277232, 0.005338483, 0.005400067, 0.0054634, 0.00552893, 0.005592599, 0.005659052, 0.005724859, 0.005788473, 0.005849801, 0.005918045, 0.005988118, 0.006055939, 0.006125635, 0.006193725, 0.006263315, 0.006339387, 0.00641222, 0.006479834, 0.006554937, 0.00663772, 0.006713929, 0.006788967, 0.006868985, 0.006952025, 0.007031115, 0.007112721, 0.007196273, 0.007282047, 0.007368182, 0.007456393, 0.007546719, 0.007633792, 0.007721986, 0.007807099, 0.007895626, 0.007985061, 0.008072466, 0.0081646, 0.008264197, 0.008360445, 0.008455306, 0.008543432, 0.008642079, 0.008737845, 0.0088393, 0.008940402, 0.009043367, 0.009144582, 0.009251194, 0.009357175, 0.009465266, 0.00957095, 0.009695366, 0.009806292, 0.009902308, 0.00992577, 0.010037538, 0.010158331, 0.010288325, 0.010406513, 0.010534424, 0.010661354, 0.010787162, 0.010910739, 0.011037053, 0.011167272, 0.011297004, 0.011434929, 0.011568578, 0.01170442, 0.011843383, 0.01198444, 0.012119753, 0.012261404, 0.012395913, 0.012551178, 0.012700056, 0.012848033, 0.012997318, 0.013146973, 0.013301658, 0.013461008, 0.013621841, 0.013777838, 0.01394194, 0.014113125, 0.014283692, 0.014445424, 0.014616024, 0.014789371, 0.014956366, 0.015134647, 0.015317981, 0.015491969, 0.015672617, 0.015857459, 0.016039319, 0.016225556, 0.01641352, 0.016596208, 0.016784688, 0.016972102, 0.017169735, 0.0173703, 0.017565036, 0.017771729, 0.01798368, 0.018182486, 0.018396953, 0.01861033, 0.018820867, 0.019029455, 0.019252175, 0.019475727, 0.019710381, 0.019937807, 0.02017058, 0.020414278, 0.020650266, 0.020889231, 0.021132142, 0.021371346, 0.021621174, 0.021869709, 0.022127233, 0.022386793, 0.022649859, 0.022905091, 0.023175456, 0.023438976, 0.023730174, 0.023996692, 0.024278546, 0.024561535, 0.024841194, 0.025134377, 0.025421826, 0.02571303, 0.026025286, 0.02632111, 0.026624597, 0.026934016, 0.027257675, 0.027576471, 0.027905865, 0.028227766, 0.02856755, 0.028894636, 0.029230826, 0.029573877, 0.029932435, 0.030291879, 0.0306357, 0.030993172, 0.031363867, 0.031730714, 0.032091554, 0.032472061, 0.032863473, 0.033241617, 0.03361345, 0.033997616, 0.034377245, 0.03477369, 0.035190776, 0.035605593, 0.036028216, 0.036450911, 0.036869428, 0.037282793, 0.037710328, 0.038133047, 0.038584131, 0.039033076, 0.039491126, 0.039949996, 0.040420422, 0.040878901, 0.041356349, 0.041845059, 0.042329189, 0.042816689, 0.043324664, 0.043819921, 0.0443279, 0.044851862, 0.045363607, 0.045895917, 0.04642139, 0.046962564, 0.047509965, 0.048098252, 0.048665128, 0.049232345, 0.049803657, 0.050390462, 0.050997381, 0.051585541, 0.052197707, 0.052808617, 0.053428572, 0.054060748, 0.054683726, 0.055324423, 0.055963631, 0.056642426, 0.057304287, 0.057997397, 0.058675559, 0.059388612, 0.060069427, 0.06076574, 0.061481034, 0.062192604, 0.062932705, 0.063676885, 0.064421131, 0.065190379, 0.065945866, 0.066732799, 0.067521079, 0.068305556, 0.069123327, 0.069923922, 0.070731114, 0.071581466, 0.07242485, 0.073295023, 0.074152419, 0.075055782, 0.075924499, 0.076834385, 0.077754906, 0.078662861, 0.079619888, 0.080596569, 0.081535211, 0.082508667, 0.083492704, 0.084462608, 0.085464914, 0.086473817, 0.087505933, 0.088547406, 0.089607528, 0.090669667, 0.091730786, 0.092805416, 0.093887623, 0.095015392, 0.096151222, 0.097274742, 0.098437138, 0.099603361, 0.100787651, 0.101749405, 0.101989427, 0.103179732, 0.104400774, 0.105665811, 0.106926862, 0.108210046, 0.10948751, 0.110793641, 0.112121204, 0.113457973, 0.114791346, 0.116132093, 0.117527714, 0.118941477, 0.120373764, 0.121799666, 0.123263359, 0.124732174, 0.126196211, 0.127696465, 0.129227298, 0.130777256, 0.132341779, 0.133944752, 0.135543525, 0.13716952, 0.138837114, 0.140534725, 0.142231041, 0.143945956, 0.145629695, 0.14736549, 0.149093119, 0.150892051, 0.152706299, 0.154535645, 0.156384737, 0.15823181, 0.160135302, 0.162104394, 0.164030433, 0.166014872, 0.167982987, 0.169950458, 0.171929672, 0.173992989, 0.176119038, 0.178246679, 0.180415451, 0.182611953, 0.184832862, 0.187069864, 0.189347965, 0.191643429, 0.194008765, 0.196367694, 0.198793521, 0.201206059, 0.203672428, 0.206181315, 0.208697848, 0.211258479, 0.213848654, 0.216445723, 0.219050253, 0.221743323, 0.224469637, 0.2272582, 0.230003321, 0.232844487, 0.235733013, 0.238611761, 0.241559776, 0.244521555, 0.247553311, 0.250638543, 0.253747546, 0.256869431, 0.26005347, 0.263238367, 0.266512181, 0.26980857, 0.273158513, 0.276567888, 0.279988631, 0.283503677, 0.287046086, 0.290600906, 0.294188883, 0.297839786, 0.301555879, 0.305335102, 0.309150856, 0.313007809, 0.316974041, 0.321002288, 0.321873529, 0.325040444, 0.329157292, 0.333307622, 0.337495445, 0.341771121, 0.346101248, 0.350460295, 0.354860951, 0.359400789, 0.363968212, 0.368608024, 0.373263973, 0.378002481, 0.382774555, 0.387693282, 0.392660537, 0.39767015, 0.402847624, 0.408018867, 0.413306734, 0.418651707, 0.424056519, 0.429539219, 0.435106702, 0.440750939, 0.441964974, 0.446486985, 0.452276991, 0.45812695, 0.464083164, 0.47014266, 0.476299878, 0.48254511, 0.488870073, 0.49527568, 0.501675951, 0.50821581, 0.514893522, 0.521681615, 0.528657754, 0.53565239, 0.542753602, 0.550104791, 0.557498608, 0.564944818, 0.572436326, 0.580040991, 0.587808355, 0.595729133, 0.603790937, 0.612046233, 0.62026104, 0.628657454, 0.637183631, 0.645900855, 0.654776078, 0.663842914, 0.672945603, 0.682125377, 0.691648177, 0.701226181, 0.705406565, 0.71101807, 0.720914188, 0.730891645, 0.741203406, 0.751520378, 0.762119895, 0.77280117, 0.783801911, 0.794992041, 0.806330198, 0.817756583, 0.829502947, 0.841352834, 0.853515953, 0.865866672, 0.878369375, 0.891148135, 0.904137931, 0.917417749, 0.930864078, 0.94476682, 0.958743063, 0.97308741, 0.987608917, 1.002365052, 1.008656581, 1.017446795, 1.032844594, 1.048552003, 1.064571925, 1.080895191, 1.097554972, 1.114406673, 1.131716608, 1.149521516, 1.167497854, 1.185986605, 1.204590036, 1.223804912, 1.243395506, 1.263401571, 1.284003332, 1.305072413, 1.326514523, 1.348509845, 1.366264043, 1.406722985, 1.429296459, 1.451858535, 1.474421144, 1.497129095, 1.519548638, 1.542244637, 1.564811693, 1.587390549, 1.610065995, 1.63275151, 1.655410587, 1.678109991, 1.700716645, 1.723288489, 1.745882557, 1.768364467, 1.790911864, 1.804231305, 1.813572108, 1.83619941, 1.858731141, 1.881366134, 1.904037308, 1.926763844, 1.949339424, 1.972217712, 1.994924062, 2.017531268, 2.040161468, 2.062846614, 2.085343567, 2.107812286, 2.130512936, 2.15305853, 2.175735157, 2.198326425, 2.220909954, 2.243521858, 2.266199902, 2.288763352, 2.311120579, 2.333632545, 2.356340251, 2.369358524, 2.379032954, 2.401654222, 2.424097374, 2.446931906, 2.46949432, 2.49229464, 2.515080228, 2.537707175, 2.560477374, 2.583114877, 2.605946346, 2.628709401, 2.651437851, 2.674244649, 2.696964037, 2.719564726, 2.742292786, 2.765194658, 2.787844427, 2.810622826, 2.833368533, 2.856151378, 2.878948576, 2.901603093, 2.924221071, 2.946973201, 2.969696127, 2.992224415, 3.014953747, 3.03797864, 3.060887882, 3.083923609, 3.106886005, 3.129886355, 3.152699307, 3.170578953, 3.175307637, 3.198216192, 3.221310086, 3.244169594, 3.266976765, 3.28978795, 3.312637209, 3.335654432, 3.358843421, 3.381597504, 3.404748246, 3.427844106, 3.4510632, 3.47399451, 3.496466441, 3.519258944, 3.542385786, 3.565513794, 3.588593931, 3.611638345, 3.634693735, 3.657871615, 3.681041625, 3.704042473, 3.727074556, 3.745038724, 3.75007812, 3.773187687, 3.795839563, 3.818796692, 3.841939517, 3.865048445, 3.88772525, 3.910859125, 3.933861602, 3.957093, 3.980541756, 4.00384177, 4.027145409, 4.050493364, 4.073872028, 4.097136203, 4.120336907, 4.143584459, 4.16677025, 4.190182492, 4.213735271, 4.236929005, 4.26024754, 4.28352139, 4.30689809, 4.330434826, 4.354422537, 4.377893612, 4.401179406, 4.424187745, 4.447341224, 4.471013337, 4.494451203, 4.517926901, 4.541565516, 4.564966006, 4.588316874, 4.611568942, 4.635635993, 4.659190705, 4.682654867, 4.706065242, 4.729277352, 4.753503578, 4.777203746, 4.800657149, 4.82398422, 4.847876923, 4.871316632, 4.895379257, 4.919073638, 4.943060744, 4.966620075, 4.99024534, 5.013760494, 5.037515828, 5.061139579, 5.084899562, 5.108385873, 5.13225388, 5.15611545, 5.180303785, 5.204475917, 5.228595871, 5.252287604, 5.276608875, 5.300831332, 5.324762525, 5.348252326, 5.372262503, 5.396610059, 5.420665917, 5.444813358, 5.468942514, 5.493406507, 5.516907707, 5.540955403, 5.565242131, 5.589643676, 5.613790351, 5.637752691, 5.662335726, 5.686745924, 5.71090422, 5.734933215, 5.759491365, 5.783628859, 5.808138592, 5.832487055, 5.856485434, 5.880370416, 5.904821664, 5.928953375, 5.953497626, 5.978251925, 6.002605664, 6.007657388, 6.027388084, 6.051922416, 6.077243594, 6.102628182, 6.127054703, 6.151896547, 6.17576339, 6.200853456, 6.225557253, 6.25021917, 6.274871443, 6.299729207, 6.323931267, 6.348962329, 6.373485379, 6.399010777, 6.424053851, 6.449416496, 6.474046053, 6.49914466, 6.524256107, 6.549602487, 6.574868617, 6.599894826, 6.62495081, 6.65083129, 6.675360399, 6.701256469, 6.726109352, 6.751545358, 6.777337937, 6.802819056, 6.828194474, 6.853345548, 6.877870158, 6.903467215, 6.928840474, 6.95413259, 6.980353972, 7.00581522, 7.030875906, 7.055656315, 7.081184886, 7.106438236, 7.13215598, 7.157305896, 7.182663102, 7.2083025, 7.234195328, 7.260670409, 7.287094747, 7.31309352, 7.338257132, 7.364269738, 7.390756197, 7.41682421, 7.443115068, 7.468566648, 7.495126082, 7.521338627, 7.54771955, 7.575065728, 7.601183593, 7.627634901, 7.653277688, 7.680908162, 7.706589399, 7.733746919, 7.759531395, 7.786135962, 7.811864251, 7.838383338, 7.865059194, 7.89083847, 7.918120264, 7.944856436, 7.971591303, 7.998737784, 8.025487378, 8.05228014, 8.078739599, 8.10614549, 8.132931985, 8.159622195, 8.185419678, 8.212126303, 8.238603872, 8.265175225, 8.291779316, 8.318075455, 8.345517013, 8.371463809, 8.399460221, 8.427345818, 8.453861992, 8.481493487, 8.507979386, 8.534935824, 8.562952007, 8.589803748, 8.617140311, 8.644119863, 8.672263833, 8.701595318, 8.729020982, 8.756069525, 8.783878402, 8.810489521, 8.837738658, 8.865887043, 8.894559761, 8.921430688, 8.949479449, 8.977692156, 9.006254859, 9.033933094, 9.061343366, 9.089244737, 9.117395375, 9.145215174, 9.173079308, 9.20140614, 9.229037861, 9.257139653, 9.285511487, 9.314554872, 9.343774831, 9.37108454, 9.397714828, 9.426414841, 9.454691162, 9.483656861, 9.513534937, 9.542283357, 9.571199997, 9.60002887, 9.628453641, 9.657220803, 9.686991921, 9.715782066, 9.74497249, 9.77321937, 9.803215998, 9.832271805, 9.860581283, 9.890113213, 9.917657911, 9.94673729, 9.977511966, 10.008074806, 10.037633152, 10.066604078, 10.095700628, 10.125403252, 10.154038903, 10.182790305, 10.212379868, 10.243061027, 10.273232265, 10.303182401, 10.332598323, 10.361749233, 10.391092594, 10.421823943, 10.450531089, 10.478921583, 10.509524886, 10.539126734, 10.569859478, 10.600164672, 10.6311694, 10.661360426, 10.693766339, 10.723881528, 10.753788664, 10.783010522, 10.812149633, 10.840952583, 10.871934822, 10.903924378, 10.934780107, 10.964355359, 10.994396615, 11.025717935, 11.056962736, 11.089530065, 11.119471748, 11.147708572, 11.177563181, 11.20759057, 11.239682694, 11.272678442, 11.303274729, 11.335242132, 11.366269883, 11.399480494, 11.429612219, 11.458482885, 11.488407237, 11.518325134, 11.52512206, 11.549899194, 11.57956235, 11.612249311, 11.644243795, 11.676724137, 11.710888662, 11.74191256, 11.774970802, 11.80541002, 11.837546668, 11.868604971, 11.899445624, 11.929589758, 11.96321781, 11.993032807, 12.024066916, 12.052984803, 12.085125778, 12.116481152, 12.146499526, 12.180899962, 12.213352099, 12.246426427, 12.281534613, 12.314202049, 12.347676978, 12.380985985, 12.416810229, 12.451102395, 12.483108241, 12.514396985, 12.547528039, 12.580161412, 12.61497225, 12.646978531, 12.677812983, 12.711021119, 12.74531074, 12.779762838, 12.814479864, 12.847368331, 12.881768069, 12.916285276, 12.947537908, 12.980487032, 13.011971425, 13.045148545, 13.080877891, 13.115617113, 13.150068266, 13.183345093, 13.213714147, 13.249106295, 13.279503076, 13.31506332, 13.346709795, 13.379462044, 13.415134486, 13.446360408, 13.47939584, 13.51384999, 13.549416402, 13.581638646, 13.616855601, 13.649134936, 13.681900493, 13.716356389, 13.74889091, 13.783028047, 13.819177624, 13.855491404, 13.892446257, 13.925508286, 13.959205497, 13.992171296, 14.025107766, 14.059934924, 14.093107134, 14.129321647, 14.162389382, 14.198062065, 14.234535691, 14.26719793, 14.302195359, 14.339332745, 14.373596653, 14.404218983, 14.43737897, 14.471398826, 14.507400124, 14.544312526, 14.576661101, 14.60905063, 14.640698961, 14.672863159, 14.709212187, 14.745470059, 14.781401676, 14.816912133, 14.84849429, 14.886581873, 14.924228153, 14.963740796, 14.995053621, 15.033135433, 15.067357853, 15.106256051, 15.141555235, 15.180113292, 15.210978686, 15.250337466, 15.28629051, 15.32178351, 15.357069813, 15.392616183, 15.425189542, 15.46117701, 15.490871853, 15.526865657, 15.561279944, 15.597760099, 15.632510979, 15.669414188, 15.706286588, 15.742585848, 15.782935574, 15.81671502, 15.854802125, 15.892984133, 15.931401662, 15.97202766, 16.003221466, 16.035391573, 16.076814201, 16.115426375, 16.154394011, 16.195768373, 16.232138708, 16.264639251, 16.313935604, 16.349794744, 16.389940581, 16.425132326, 16.462586271, 16.500528071, 16.535491967, 16.575394353, 16.609234748, 16.64962958, 16.693754846, 16.728961154, 16.764921143, 16.805416168, 16.84432766, 16.878758866, 16.913721319, 16.949134657, 16.988508505, 17.022197093, 17.061674505, 17.100265273, 17.139215007, 17.187168687, 17.22276253, 17.255249223, 17.289824822, 17.323769245, 17.364305797, 17.395482564, 17.428706097, 17.467536294, 17.503011444, 17.543017806, 17.568914538, 17.60688778, 17.645684903, 17.68140793, 17.727869603, 17.759431061, 17.792620945, 17.830920787, 17.869083124, 17.912768171, 17.964994109, 18.008171611, 18.043888596, 18.080896076, 18.123165615, 18.158301699, 18.192573376, 18.238444392, 18.279229834, 18.315597721, 18.35141685, 18.390166409, 18.438004791, 18.4823666, 18.525537521, 18.57256227, 18.613102742, 18.620828306, 18.654930676, 18.700423767, 18.742318311, 18.784476519, 18.821001284, 18.8681769, 18.910005592, 18.95745331, 18.989328181, 19.030615599, 19.064956848, 19.099134871, 19.132087527, 19.170240584, 19.200086434, 19.234533748, 19.267237744, 19.310652731, 19.350235088, 19.391656399, 19.435880374, 19.471660046, 19.508789936, 19.541360178, 19.592700814, 19.637995658, 19.683299181, 19.729549218, 19.761688166, 19.805248115, 19.85138005, 19.896704582, 19.92985764, 19.979067687, 20.024630269, 20.088255826, 20.130895533, 20.167553821, 20.20700895, 20.244735266, 20.275473973, 20.31015769, 20.353132648, 20.392663556, 20.440629313, 20.479473597, 20.51706807, 20.563908411, 20.590692162, 20.64965377, 20.704603435, 20.73733303, 20.780604039, 20.827684524, 20.868062176, 20.903415915, 20.936481457, 20.980736087, 21.010777197, 21.051857981, 21.093913066, 21.134793118, 21.18046786, 21.218070894, 21.265669413, 21.301981133, 21.344077241, 21.384869432, 21.429725494, 21.478047622, 21.519662534, 21.552490648, 21.582494777, 21.629294081, 21.673382025, 21.717180995, 21.775055105, 21.820476317, 21.878224849, 21.912958048, 21.96599438, 22.00234045, 22.037122397, 22.080628074, 22.124194935, 22.148372152, 22.196475029, 22.253673084, 22.301945583, 22.344504783, 22.400259581, 22.460879302, 22.503668475, 22.541288106, 22.57794609, 22.612970538, 22.661270264, 22.707505194, 22.758304251, 22.791100658, 22.852641031, 22.902908302, 22.939364323, 22.978060352, 23.018785377, 23.06248874, 23.111828385, 23.140127749, 23.171181253, 23.216241877, 23.288243536, 23.329025821, 23.354886756, 23.38627557, 23.424526296, 23.476009931, 23.520280985, 23.563230238, 23.586951711, 23.647798112, 23.686948492, 23.744669079, 23.781861524, 23.830822227, 23.866316751, 23.924133292, 23.975925233, 24.043604116, 24.095449349, 24.145992963, 24.180905177, 24.219765822, 24.249157577, 24.311605994, 24.34659419, 24.414415004, 24.452611599, 24.499535902, 24.536805401, 24.574944709, 24.624740812, 24.67768102, 24.722688075, 24.749055641, 24.802397755, 24.825749614, 24.856984186, 24.918764566, 24.980799726, 25.032143823, 25.054768976, 25.121250138, 25.166932852, 25.20244711, 25.279938861, 25.340021577, 25.420263553, 25.455630754, 25.492221479, 25.556389497, 25.608558624, 25.710206645, 25.751262298, 25.779238373, 25.828401798, 25.884944162, 25.924760029, 25.975359814, 26.009812559, 26.057963176, 26.120674194, 26.166581051, 26.206979856, 26.237896427, 26.270873956, 26.317384439, 26.366821362, 26.401364571, 26.446531678, 26.472995256, 26.498724433, 26.538291933, 26.581249779, 26.670932006, 26.700605711, 26.740688141, 26.793842907, 26.847833186, 26.905758644, 26.976578855, 27.035272635, 27.058859035, 27.111184703, 27.175663376, 27.232340591, 27.252715225, 27.314961788, 27.377518573, 27.454153218, 27.500959041, 27.519081871, 27.541555213, 27.567545512, 27.603237371, 27.658583199, 27.739732079, 27.811795326, 27.874854756, 27.930350646, 28.006557183, 28.105173525, 28.15034836, 28.193946595, 28.245966119, 28.292641094, 28.391663714, 28.440112376, 28.470293885, 28.499448199, 28.537668045, 28.595007472, 28.647764805, 28.6804083, 28.760091685, 28.80113382, 28.848771992, 28.886966288, 28.921503084, 28.968439079, 29.037542019, 29.059104622, 29.105256569, 29.170655724, 29.202450873, 29.249442786, 29.307647275, 29.408890453, 29.450444775, 29.496263345, 29.560889446, 29.564188309, 29.597443986, 29.60911376, 29.65686478, 29.705978868, 29.753793147, 29.788358272, 29.815073512, 29.836571601, 29.96737139, 30.0371142, 30.098446917, 30.117046309, 30.14094959, 30.174653995, 30.210417321, 30.241236502, 30.268993011, 30.306137509, 30.347789147, 30.368419126, 30.423165987, 30.534418476, 30.661301471, 30.716163701, 30.757285663, 30.763670566, 30.807206226, 30.850853407, 30.913580523, 30.980710517, 30.986785963, 31.043018816, 31.073526037, 31.259199138, 31.271292789, 31.330225052, 31.369661742, 31.42770653, 31.439397224, 31.541205829, 31.605715125, 31.682726075, 31.744113338, 31.839163575, 31.851321687, 31.907977003, 31.926927295, 31.977022226, 32.017193337, 32.099266726, 32.19644351, 32.253781196, 32.334006157, 32.384486348, 32.425345589, 32.505221661, 32.558528458, 32.603293048, 32.717461009, 32.71986227, 32.773478712, 32.801767866, 32.840196432, 32.842298686, 32.882915886, 32.909588819, 32.990004538, 33.102076421, 33.123914907, 33.134235011, 33.241262606, 33.351906295, 33.354758596, 33.413087189, 33.508692188, 33.539405125, 33.622069075, 33.687238449, 33.705881021, 33.814972433, 33.827191502, 33.910165747, 33.969176229, 33.971348443, 33.980933286, 34.297435343, 34.304800913, 34.312806565, 34.40857215, 34.451230164, 34.469225993, 34.628984252, 34.67606235, 34.729629297, 34.807616684, 34.822525063, 34.943056889, 34.950988975, 34.977555473), "10000" = c(1.8303e-05, 1.8337e-05, 1.894e-05, 2.006e-05, 2.0616e-05, 2.0635e-05, 2.0852e-05, 2.1219e-05, 2.2046e-05, 2.2137e-05, 2.2459e-05, 2.3079e-05, 2.3206e-05, 2.3207e-05, 2.3458e-05, 2.4331e-05, 2.4671e-05, 2.4737e-05, 2.4841e-05, 2.4851e-05, 2.5248e-05, 2.559e-05, 2.6783e-05, 2.6981e-05, 2.7196e-05, 2.7217e-05, 2.7853e-05, 2.7939e-05, 2.8256e-05, 2.8594e-05, 2.8677e-05, 2.8921e-05, 2.9374e-05, 2.9864e-05, 3.0041e-05, 3.0427e-05, 3.0438e-05, 3.069e-05, 3.1086e-05, 3.1241e-05, 3.1362e-05, 3.2071e-05, 3.2199e-05, 3.2411e-05, 3.2713e-05, 3.3599e-05, 3.4563e-05, 3.4651e-05, 3.507e-05, 3.5413e-05, 3.5815e-05, 3.6255e-05, 3.6643e-05, 3.6914e-05, 3.7204e-05, 3.7626e-05, 3.8373e-05, 3.8895e-05, 3.9556e-05, 3.9806e-05, 4.0083e-05, 4.022e-05, 4.1022e-05, 4.1427e-05, 4.1532e-05, 4.1639e-05, 4.1881e-05, 4.2106e-05, 4.2798e-05, 4.3362e-05, 4.4096e-05, 4.4397e-05, 4.5423e-05, 4.6303e-05, 4.6457e-05, 4.7375e-05, 4.7792e-05, 4.8351e-05, 4.8484e-05, 4.9128e-05, 4.9464e-05, 4.9885e-05, 5.0444e-05, 5.0921e-05, 5.1537e-05, 5.2147e-05, 5.2342e-05, 5.268e-05, 5.435e-05, 5.5125e-05, 5.5664e-05, 5.619e-05, 5.6855e-05, 5.7606e-05, 5.7824e-05, 5.9023e-05, 5.9372e-05, 5.9823e-05, 6.1617e-05, 6.2088e-05, 6.2324e-05, 6.2992e-05, 6.4238e-05, 6.5364e-05, 6.595e-05, 6.7344e-05, 6.871e-05, 6.9962e-05, 7.1203e-05, 7.1568e-05, 7.2722e-05, 7.3334e-05, 7.4072e-05, 7.4274e-05, 7.5619e-05, 7.73e-05, 7.8073e-05, 7.9197e-05, 8.0321e-05, 8.1256e-05, 8.2273e-05, 8.3252e-05, 8.4102e-05, 8.4628e-05, 8.5627e-05, 8.6755e-05, 8.7922e-05, 8.8881e-05, 8.9398e-05, 9.0467e-05, 9.1582e-05, 9.2734e-05, 9.4129e-05, 9.4725e-05, 9.5919e-05, 9.6808e-05, 9.7935e-05, 9.8878e-05, 0.000100629, 0.000101553, 0.0001027, 0.000103647, 0.000104208, 0.000105681, 0.000106755, 0.000107978, 0.000109177, 0.000109529, 0.000110914, 0.000111654, 0.000112635, 0.000114614, 0.000115485, 0.000117063, 0.000117673, 0.000119663, 0.000120846, 0.000122086, 0.000123385, 0.000125197, 0.000127083, 0.000128892, 0.000129552, 0.000131101, 0.000132734, 0.000133679, 0.000134561, 0.000135668, 0.000136856, 0.000137904, 0.000139449, 0.000140808, 0.000142062, 0.000143744, 0.000146475, 0.000149122, 0.000150445, 0.000151626, 0.00015258, 0.0001543, 0.000156797, 0.00015816, 0.000159377, 0.000161352, 0.000163214, 0.000165382, 0.000167032, 0.000168444, 0.000170228, 0.000170885, 0.00017249, 0.000175019, 0.0001768, 0.000179204, 0.000181401, 0.000184447, 0.000186961, 0.000188475, 0.000192126, 0.0001947, 0.000196625, 0.000197349, 0.000199277, 0.000200644, 0.00020297, 0.000207029, 0.000209945, 0.000212778, 0.000216641, 0.000218665, 0.000221947, 0.000224406, 0.000227463, 0.000230166, 0.000233049, 0.00023543, 0.000237867, 0.000240343, 0.000243235, 0.000247099, 0.000249734, 0.000251748, 0.000254475, 0.000257815, 0.000260877, 0.000262627, 0.000265926, 0.000268325, 0.000271849, 0.000275015, 0.00027803, 0.000281784, 0.000284617, 0.000288816, 0.000292692, 0.000295697, 0.00030057, 0.000302901, 0.000305838, 0.000311928, 0.000314299, 0.000317995, 0.000321843, 0.000324221, 0.000328063, 0.000332214, 0.000336191, 0.000340004, 0.00034376, 0.000348093, 0.000351061, 0.00035552, 0.000358922, 0.000362787, 0.000365847, 0.000369318, 0.000373959, 0.000378577, 0.00038177, 0.000386923, 0.000390738, 0.000395972, 0.000400395, 0.000406534, 0.000410696, 0.000418226, 0.000421179, 0.000424931, 0.000429044, 0.000434506, 0.000439545, 0.000444752, 0.000450245, 0.000454932, 0.000461596, 0.000467865, 0.000473512, 0.00047838, 0.00048301, 0.000488663, 0.000495128, 0.00049813, 0.000504403, 0.000508209, 0.00051488, 0.000522719, 0.000527574, 0.000533717, 0.000539028, 0.000544701, 0.00055261, 0.000558443, 0.000565986, 0.000571836, 0.000578784, 0.000586281, 0.000592469, 0.000599687, 0.000607181, 0.000615439, 0.000622763, 0.000630093, 0.000637304, 0.00064283, 0.000650441, 0.000660192, 0.000667997, 0.00067643, 0.000683077, 0.000693374, 0.000700816, 0.000709372, 0.000718097, 0.000724689, 0.000733432, 0.000742239, 0.00075197, 0.000759468, 0.000765666, 0.000774407, 0.000781968, 0.000791578, 0.00080313, 0.000811609, 0.000819368, 0.000829237, 0.000838324, 0.000849078, 0.000857443, 0.000865899, 0.000878023, 0.000886335, 0.000895565, 0.000906751, 0.000914945, 0.000928686, 0.00094037, 0.000951412, 0.000964488, 0.000975594, 0.00098316, 0.000985722, 0.000995229, 0.00100546, 0.001019708, 0.001035424, 0.001047896, 0.001059609, 0.00107532, 0.001087238, 0.001100763, 0.001111466, 0.001123084, 0.001133234, 0.001146442, 0.001159714, 0.0011733, 0.001184856, 0.001198339, 0.001211505, 0.001223125, 0.001236809, 0.001250145, 0.001265034, 0.001279095, 0.001294276, 0.001310794, 0.001324679, 0.001341616, 0.001357083, 0.001371886, 0.001385935, 0.001405009, 0.001419618, 0.001436754, 0.001455604, 0.001469692, 0.001489019, 0.001505829, 0.001523371, 0.001538548, 0.001555506, 0.00157146, 0.001592123, 0.001613119, 0.00163493, 0.001653, 0.001670373, 0.001689551, 0.001709102, 0.001732361, 0.001749755, 0.001766473, 0.001788218, 0.00180887, 0.001827117, 0.001853045, 0.001878118, 0.001900972, 0.001923752, 0.001947088, 0.001967865, 0.00199222, 0.00202023, 0.002045108, 0.002069757, 0.002093948, 0.002123402, 0.002146392, 0.002171351, 0.002197049, 0.002223444, 0.00225232, 0.002278578, 0.002302504, 0.002332455, 0.002361303, 0.002387365, 0.002414722, 0.002442247, 0.002467148, 0.002498257, 0.002526241, 0.002555715, 0.002585744, 0.002616531, 0.002643926, 0.002676576, 0.002708119, 0.00274177, 0.002775112, 0.002807657, 0.00284083, 0.002875997, 0.00290971, 0.002948077, 0.00297711, 0.003013059, 0.003050783, 0.003079547, 0.003115012, 0.003155865, 0.00319473, 0.003235155, 0.003272745, 0.00330964, 0.003345972, 0.003383841, 0.003423997, 0.003466717, 0.003509565, 0.003549721, 0.00358986, 0.003629772, 0.003674482, 0.003715063, 0.00375912, 0.003801217, 0.003845623, 0.003889473, 0.003931397, 0.003975703, 0.004014808, 0.004061808, 0.004106342, 0.004155496, 0.004202565, 0.004249485, 0.00430316, 0.00435166, 0.00440204, 0.004452725, 0.004504291, 0.004557279, 0.004608226, 0.004663661, 0.004724908, 0.004779036, 0.00483951, 0.004897672, 0.004958088, 0.005017107, 0.005072923, 0.005140537, 0.005195673, 0.005254143, 0.005317468, 0.005380794, 0.00544004, 0.005500631, 0.005560039, 0.005622974, 0.005686338, 0.00575437, 0.005825528, 0.005892081, 0.005958765, 0.00602396, 0.006089164, 0.006153105, 0.00622362, 0.006296984, 0.006370089, 0.006447801, 0.006529518, 0.006601043, 0.006684437, 0.00675836, 0.006833763, 0.006906313, 0.00698174, 0.007064847, 0.007144694, 0.00722458, 0.007305581, 0.00739159, 0.007479288, 0.007566585, 0.007649844, 0.007743732, 0.00783446, 0.007924979, 0.008019715, 0.008116429, 0.008206473, 0.008299385, 0.008400517, 0.00849683, 0.008591642, 0.008691608, 0.008790099, 0.008884169, 0.008992629, 0.009099502, 0.009212583, 0.009323444, 0.009432267, 0.00954452, 0.009647141, 0.009759267, 0.009872874, 0.009962008, 0.009988935, 0.010107149, 0.010227451, 0.010346999, 0.010460743, 0.010589978, 0.010721123, 0.010842559, 0.010973587, 0.011093196, 0.011220607, 0.011349833, 0.011482198, 0.011618728, 0.011760268, 0.011894125, 0.012035434, 0.01216777, 0.012311373, 0.01244833, 0.012596481, 0.012743697, 0.012893134, 0.013042469, 0.013200693, 0.013350211, 0.013513501, 0.013671186, 0.013823053, 0.013981148, 0.014135799, 0.014295219, 0.014470707, 0.014655186, 0.014826807, 0.015000175, 0.015169337, 0.015358402, 0.015542025, 0.015725115, 0.015903633, 0.016093072, 0.016281343, 0.016471517, 0.016654948, 0.016853411, 0.017045255, 0.017240435, 0.017449389, 0.017651692, 0.017853311, 0.018061509, 0.018276135, 0.018486391, 0.01869823, 0.018917399, 0.019145744, 0.019361558, 0.019588588, 0.019816836, 0.020041585, 0.020276514, 0.020505947, 0.020740168, 0.02098758, 0.021234446, 0.02147612, 0.021720615, 0.021977276, 0.022238081, 0.022476181, 0.022736306, 0.022994964, 0.023266106, 0.023533131, 0.023809474, 0.024081361, 0.024353867, 0.024637699, 0.024934712, 0.0252245, 0.025524914, 0.025836714, 0.026142091, 0.026447123, 0.026750176, 0.02706789, 0.027387659, 0.027718696, 0.028056738, 0.028403328, 0.028721211, 0.029064416, 0.02941367, 0.029757436, 0.030100206, 0.030438572, 0.030805344, 0.031153244, 0.031525959, 0.03189161, 0.032274692, 0.032656355, 0.033046355, 0.033440945, 0.033839004, 0.034222682, 0.034624061, 0.0350272, 0.035411024, 0.035810638, 0.036241157, 0.036660359, 0.037098227, 0.037553035, 0.037994774, 0.038428172, 0.038879033, 0.039345252, 0.039821756, 0.040291915, 0.040776216, 0.04125389, 0.04172787, 0.042217641, 0.042710923, 0.043208739, 0.043711809, 0.044205977, 0.04472478, 0.045245554, 0.045789234, 0.046321444, 0.046868041, 0.04741429, 0.04796682, 0.048536391, 0.049100994, 0.049679611, 0.050259973, 0.050830882, 0.051420732, 0.052041096, 0.052646271, 0.053251713, 0.053879845, 0.054497601, 0.055116373, 0.055765229, 0.056396684, 0.057036011, 0.057725294, 0.058388749, 0.059055309, 0.059748304, 0.060449164, 0.061167789, 0.06187649, 0.062598397, 0.063315042, 0.064061793, 0.064822259, 0.065594175, 0.066379303, 0.067169361, 0.067953824, 0.068754357, 0.069578965, 0.070388333, 0.071220865, 0.072055246, 0.072904181, 0.073742715, 0.074611715, 0.075500504, 0.076383249, 0.077293905, 0.078233887, 0.079154619, 0.080093874, 0.081043131, 0.081979083, 0.082939424, 0.083923849, 0.084939913, 0.085943175, 0.086962595, 0.088036229, 0.089067081, 0.090133954, 0.091208835, 0.092305686, 0.093390285, 0.094494277, 0.095630236, 0.096728254, 0.09785513, 0.099029353, 0.100206907, 0.101367521, 0.102328764, 0.102567519, 0.10378848, 0.105027238, 0.106290471, 0.107560951, 0.108831766, 0.110140564, 0.1114678, 0.112831253, 0.114167799, 0.115537274, 0.116894236, 0.118318666, 0.119690395, 0.121103962, 0.12255848, 0.124025249, 0.125508813, 0.127035163, 0.128572902, 0.130116712, 0.13172241, 0.133328622, 0.134923124, 0.13656252, 0.138198147, 0.139861722, 0.141554265, 0.143234433, 0.144922427, 0.146660419, 0.148401788, 0.150210941, 0.152021289, 0.153877672, 0.155745557, 0.157618774, 0.159507837, 0.161430965, 0.163402505, 0.165373663, 0.167399546, 0.169423541, 0.171465637, 0.173549199, 0.175632734, 0.177763532, 0.179926806, 0.182103437, 0.184302627, 0.186514311, 0.188784394, 0.191048309, 0.193357328, 0.195750567, 0.198161758, 0.200552749, 0.203012698, 0.205521324, 0.20800816, 0.210541592, 0.213100523, 0.215664225, 0.218275339, 0.220988424, 0.223669276, 0.226381463, 0.229172556, 0.231970987, 0.234828187, 0.237706274, 0.240582231, 0.243515722, 0.246514407, 0.249568276, 0.252651362, 0.255730806, 0.258877221, 0.262065591, 0.265269007, 0.268590454, 0.271908245, 0.275254382, 0.278687504, 0.282178812, 0.285747475, 0.28933672, 0.292921995, 0.29653879, 0.300286449, 0.30402311, 0.307802849, 0.311615832, 0.31552446, 0.319460304, 0.323456232, 0.324340318, 0.327507947, 0.331639584, 0.335798271, 0.340020591, 0.344326378, 0.348644686, 0.353042791, 0.357459906, 0.361988291, 0.366567543, 0.371294854, 0.376039538, 0.380822903, 0.385691754, 0.39065588, 0.395667367, 0.400760174, 0.405875199, 0.411046145, 0.416336947, 0.421710479, 0.427098513, 0.432595518, 0.43818315, 0.443880243, 0.445053144, 0.449642204, 0.45547946, 0.461390333, 0.467402279, 0.473490051, 0.479681682, 0.485898947, 0.492341087, 0.498806176, 0.505358117, 0.511993411, 0.518719565, 0.525601427, 0.532493648, 0.539574925, 0.546778092, 0.554011859, 0.561491672, 0.569037613, 0.576623889, 0.584343536, 0.592248384, 0.60024186, 0.608317201, 0.616556355, 0.624868626, 0.633422524, 0.64206286, 0.650936878, 0.659767589, 0.668872925, 0.678048343, 0.687433898, 0.696973015, 0.706628097, 0.710805793, 0.716455386, 0.726444395, 0.736603759, 0.746998242, 0.75758901, 0.768228239, 0.778995815, 0.790035958, 0.801332371, 0.812833166, 0.824610306, 0.836555835, 0.848582617, 0.860984076, 0.873476091, 0.886192609, 0.899281882, 0.912461412, 0.925910859, 0.939570655, 0.953460509, 0.967627299, 0.98208528, 0.996735354, 1.011766493, 1.017933861, 1.027064942, 1.042560556, 1.058533469, 1.074679299, 1.091284957, 1.108362585, 1.125521343, 1.143075597, 1.160996397, 1.179426602, 1.19806272, 1.217117641, 1.236643246, 1.256368155, 1.276915347, 1.29774021, 1.318950573, 1.340601299, 1.3628091, 1.380842179, 1.421959289, 1.444921251, 1.467922219, 1.490830777, 1.513717444, 1.536694072, 1.559677451, 1.582669639, 1.605599495, 1.62856648, 1.651452862, 1.67430227, 1.697029733, 1.720021935, 1.74281902, 1.76571911, 1.788652261, 1.811488163, 1.825065429, 1.834648835, 1.857659492, 1.880653428, 1.903585198, 1.926414674, 1.949449993, 1.972348345, 1.995288193, 2.01816068, 2.041002155, 2.063937811, 2.086752238, 2.10973726, 2.132746733, 2.155581877, 2.17864277, 2.201265812, 2.224105532, 2.247062412, 2.269866085, 2.292746725, 2.315711798, 2.33866809, 2.361534671, 2.384598276, 2.397952089, 2.407505662, 2.430397015, 2.453605935, 2.476394416, 2.499258656, 2.522112321, 2.544984341, 2.56766608, 2.590662875, 2.613502659, 2.636576062, 2.659441456, 2.68255794, 2.705550391, 2.728467233, 2.751402673, 2.77412918, 2.796991218, 2.819875409, 2.842947492, 2.865785223, 2.888847064, 2.911959149, 2.934914832, 2.95795179, 2.980728257, 3.003569196, 3.026581279, 3.049784386, 3.072714036, 3.095743092, 3.118644536, 3.141642229, 3.164680354, 3.187536185, 3.205801315, 3.21052212, 3.233370252, 3.256406645, 3.279566575, 3.302589653, 3.325605528, 3.348327778, 3.371440233, 3.39430153, 3.417148259, 3.439696631, 3.462784795, 3.485819841, 3.508696513, 3.531949894, 3.555086339, 3.578278224, 3.601345458, 3.624214828, 3.64728222, 3.670555218, 3.69370456, 3.716475712, 3.739562651, 3.762956623, 3.781172063, 3.786199254, 3.809223507, 3.832193338, 3.855468259, 3.878186266, 3.901264614, 3.924168067, 3.947411177, 3.97054078, 3.993403176, 4.016707928, 4.039632766, 4.062473727, 4.085463862, 4.108348511, 4.131166124, 4.154182229, 4.177136745, 4.200030547, 4.223271446, 4.246508018, 4.269508375, 4.292937589, 4.316259363, 4.339533648, 4.362860318, 4.386309115, 4.409186358, 4.432196883, 4.455435004, 4.478459514, 4.501474235, 4.524387819, 4.547719291, 4.570825365, 4.594071192, 4.617640061, 4.640690843, 4.663785893, 4.686778743, 4.709880046, 4.733074446, 4.756090145, 4.779269231, 4.802411961, 4.825567536, 4.848717571, 4.872021008, 4.89522175, 4.918537517, 4.941785641, 4.964887795, 4.987409063, 5.010650754, 5.034081209, 5.057140266, 5.080282881, 5.103494346, 5.127090049, 5.150197765, 5.173666255, 5.196313769, 5.219343697, 5.242706787, 5.266104606, 5.28843007, 5.31179762, 5.335063002, 5.358095657, 5.381773921, 5.404855256, 5.427903974, 5.451374372, 5.474543557, 5.498048198, 5.521556787, 5.544823874, 5.568715312, 5.592387767, 5.615401958, 5.638906152, 5.662272051, 5.685796065, 5.70985008, 5.733102006, 5.75655406, 5.780000138, 5.803556768, 5.826985829, 5.850296653, 5.873637922, 5.897440622, 5.920702517, 5.944161332, 5.967388922, 5.991193445, 5.996092176, 6.014539008, 6.037875026, 6.061418966, 6.084561038, 6.10861812, 6.131764887, 6.154988266, 6.178153078, 6.202126187, 6.225238346, 6.248542193, 6.272250154, 6.29618716, 6.319454628, 6.342947947, 6.366636523, 6.390371249, 6.414507299, 6.437881502, 6.461193967, 6.484746262, 6.508395649, 6.531686096, 6.555372715, 6.578693242, 6.60181271, 6.625367585, 6.64955699, 6.673381932, 6.696242505, 6.71937168, 6.743525818, 6.766840086, 6.790980752, 6.8145853, 6.838841491, 6.86264795, 6.886788576, 6.910197074, 6.933856574, 6.957815194, 6.980963675, 7.003870313, 7.027440211, 7.051120292, 7.075238583, 7.099032378, 7.122734951, 7.146020754, 7.170083005, 7.194248009, 7.217897071, 7.241302967, 7.265338728, 7.289632045, 7.313404019, 7.337609925, 7.361112204, 7.384561351, 7.40834751, 7.432623959, 7.457273304, 7.481536298, 7.504920422, 7.528416837, 7.552042179, 7.576039315, 7.599695076, 7.623850533, 7.647328672, 7.670432358, 7.694852912, 7.71869535, 7.742622393, 7.766676167, 7.790950779, 7.814596267, 7.837793647, 7.861046812, 7.88472287, 7.908964707, 7.933380992, 7.956880107, 7.980807791, 8.004623639, 8.029450176, 8.05219723, 8.07638889, 8.100281694, 8.123746689, 8.148681603, 8.172432663, 8.195774959, 8.218864135, 8.242572095, 8.266365529, 8.290318439, 8.31528443, 8.339013716, 8.362841603, 8.386989795, 8.410852119, 8.435657946, 8.460643822, 8.484101339, 8.507546763, 8.533000596, 8.557571051, 8.58140926, 8.605228778, 8.630156683, 8.654655691, 8.679603073, 8.703299017, 8.728051444, 8.75117255, 8.776254059, 8.800346029, 8.82487927, 8.84867469, 8.872517632, 8.8971912, 8.922075215, 8.94671743, 8.970307297, 8.995020376, 9.019104858, 9.044253649, 9.068231455, 9.093616892, 9.117245733, 9.141675234, 9.165152016, 9.189456509, 9.215074053, 9.239567511, 9.264067793, 9.289455618, 9.314248578, 9.338637213, 9.36211885, 9.38577755, 9.410195684, 9.434765484, 9.459400005, 9.485255611, 9.509378342, 9.53443768, 9.559501613, 9.58426713, 9.609966772, 9.635764354, 9.660132447, 9.685805777, 9.7116124, 9.736959861, 9.760736083, 9.78499257, 9.809710057, 9.834980423, 9.859177244, 9.884444286, 9.909244405, 9.9356693, 9.961102117, 9.986628475, 10.011220213, 10.03699538, 10.061479622, 10.085738824, 10.109073835, 10.133251649, 10.156565449, 10.18083581, 10.206387847, 10.23108992, 10.255367571, 10.279368187, 10.303645538, 10.328099319, 10.352190684, 10.375890258, 10.398739878, 10.423332855, 10.447428325, 10.471975475, 10.495961805, 10.521511716, 10.547146275, 10.570852906, 10.597959989, 10.623047625, 10.648012837, 10.671090486, 10.694900145, 10.718657347, 10.74482832, 10.771172507, 10.797016738, 10.822223059, 10.826834919, 10.84657588, 10.87443535, 10.901988974, 10.928255255, 10.951335758, 10.976401661, 11.001596466, 11.025809118, 11.050946321, 11.076334535, 11.100002781, 11.124407992, 11.147587527, 11.17324941, 11.196396373, 11.221365618, 11.247949298, 11.271157476, 11.296881227, 11.320730756, 11.34614757, 11.369895156, 11.394888601, 11.420855879, 11.446497465, 11.471077944, 11.498401379, 11.523141767, 11.549923732, 11.575094781, 11.600806584, 11.627496901, 11.652500516, 11.678562551, 11.703570271, 11.731505494, 11.756602444, 11.783951333, 11.809024653, 11.834166158, 11.858164782, 11.884455554, 11.911600392, 11.936472703, 11.963424567, 11.989160829, 12.015606151, 12.043371337, 12.06898879, 12.095706148, 12.119715339, 12.145102166, 12.170470282, 12.194635735, 12.22196279, 12.251404354, 12.2785704, 12.306052016, 12.331530247, 12.356977062, 12.379312854, 12.404761908, 12.42790716, 12.454078676, 12.482536139, 12.508558716, 12.534682775, 12.561452011, 12.586192688, 12.610647834, 12.635521885, 12.662931584, 12.688148057, 12.715401467, 12.744141513, 12.767711729, 12.790245941, 12.820444832, 12.845567498, 12.870919963, 12.895386872, 12.921744024, 12.946455973, 12.970770043, 12.996898456, 13.024094095, 13.047982984, 13.07458088, 13.104337458, 13.131820198, 13.157659638, 13.18318997, 13.210896882, 13.236695629, 13.265219358, 13.2920514, 13.31745077, 13.344154186, 13.368000987, 13.395629359, 13.421412393, 13.448931735, 13.475565069, 13.504810197, 13.528771447, 13.556771951, 13.582827368, 13.610612985, 13.633700736, 13.659210955, 13.682906844, 13.707047461, 13.73431614, 13.75495387, 13.784861981, 13.810314221, 13.837386963, 13.860216992, 13.887480257, 13.915356859, 13.940750233, 13.969161315, 13.995434436, 14.020971473, 14.047305079, 14.072122792, 14.099132024, 14.130305695, 14.157486477, 14.18876272, 14.216533472, 14.238134048, 14.266540252, 14.29023919, 14.316870963, 14.348337356, 14.37515995, 14.400726578, 14.427522299, 14.457021716, 14.480547374, 14.509327192, 14.538923442, 14.5602823, 14.587881298, 14.613752658, 14.640284915, 14.667473265, 14.693660697, 14.718976139, 14.745716052, 14.771410912, 14.798343641, 14.825483639, 14.853247248, 14.876544836, 14.903320871, 14.928510695, 14.957673493, 14.986341902, 15.01001126, 15.045309506, 15.079789256, 15.107206231, 15.130267367, 15.155529736, 15.187598213, 15.214912891, 15.241533538, 15.270850693, 15.295699013, 15.322364302, 15.349690192, 15.369327395, 15.396023269, 15.423292145, 15.448283931, 15.476333995, 15.507032093, 15.530132221, 15.559638982, 15.589004108, 15.62117424, 15.651743528, 15.681245663, 15.703992328, 15.737062612, 15.76230938, 15.790225484, 15.821170126, 15.855458619, 15.881562758, 15.920086362, 15.95399668, 15.975035196, 16.003524973, 16.027292877, 16.052799081, 16.082261235, 16.10837852, 16.114037506, 16.135273034, 16.16432965, 16.194825808, 16.222054388, 16.243600514, 16.276997663, 16.307089087, 16.342577692, 16.369077999, 16.395968827, 16.418086859, 16.441736973, 16.464305545, 16.491299199, 16.516317391, 16.550268283, 16.576956967, 16.59953087, 16.620198594, 16.65049636, 16.679202799, 16.704108673, 16.726856294, 16.755377445, 16.793410253, 16.821001859, 16.851811727, 16.876623427, 16.908413019, 16.928999988, 16.958861072, 16.980858536, 17.008992325, 17.043104091, 17.0813759, 17.115549316, 17.147611806, 17.173892456, 17.200365145, 17.23709191, 17.261980315, 17.29134072, 17.311983566, 17.342498968, 17.370250774, 17.395045231, 17.416688044, 17.446077078, 17.475751379, 17.495457326, 17.512998378, 17.537381739, 17.566458052, 17.595955772, 17.621865105, 17.643277383, 17.674329021, 17.702299171, 17.731950353, 17.763515276, 17.789640104, 17.82028669, 17.849478548, 17.871804513, 17.907584413, 17.931115083, 17.961941923, 17.990006818, 18.0219267, 18.062383203, 18.08215647, 18.11611255, 18.145112307, 18.18462439, 18.214480762, 18.234744338, 18.265269291, 18.292651253, 18.322646133, 18.351590819, 18.373921589, 18.401054655, 18.444926101, 18.46725276, 18.496203668, 18.522298594, 18.550829794, 18.584910721, 18.622713149, 18.65495772, 18.683201078, 18.706043366, 18.73615547, 18.763243157, 18.788988157, 18.812880816, 18.838356741, 18.866667035, 18.899868955, 18.935664815, 18.955230014, 18.977007112, 19.010133525, 19.030283534, 19.066891178, 19.098460612, 19.129509366, 19.159968189, 19.180497578, 19.212977012, 19.241216406, 19.264735574, 19.283699486, 19.310962859, 19.33714602, 19.362885891, 19.389140393, 19.409100122, 19.437236792, 19.464886296, 19.490010927, 19.514776335, 19.540721518, 19.563941389, 19.590612614, 19.621691378, 19.632779214, 19.668762877, 19.697025405, 19.721577666, 19.761964684, 19.787841933, 19.814217875, 19.840066339, 19.882463973, 19.916181931, 19.957381718, 19.980361627, 20.011576179, 20.03974939, 20.067670571, 20.103891372, 20.12565062, 20.176478426, 20.198941265, 20.247834401, 20.275746639, 20.30255529, 20.345959719, 20.374952586, 20.402047861, 20.433219707, 20.458077902, 20.488371106, 20.506971622, 20.525507433, 20.553707177, 20.587685409, 20.61549948, 20.668032671, 20.699486062, 20.750388516, 20.779656444, 20.806401857, 20.847203434, 20.864992258, 20.89066329, 20.920738217, 20.944893756, 20.969811768, 20.990771293, 21.038181814, 21.056173527, 21.087766104, 21.120846193, 21.140385183, 21.159979637, 21.176259146, 21.221702604, 21.293492973, 21.323149193, 21.353822596, 21.401432517, 21.45088487, 21.470719953, 21.490832577, 21.511275887, 21.535518395, 21.552485353, 21.571557117, 21.637564587, 21.679169207, 21.693083873, 21.736949056, 21.775312305, 21.796988207, 21.837014748, 21.865554775, 21.905760701, 21.921620073, 21.957927876, 21.976421716, 22.009296762, 22.03205728, 22.049296395, 22.0801241, 22.131541019, 22.181668184, 22.22018223, 22.23150351, 22.268193674, 22.296136396, 22.316232514, 22.340068785, 22.357068691, 22.395532214, 22.41738902, 22.464978369, 22.500287166, 22.553289024, 22.58083013, 22.608511748, 22.677472004, 22.718297735, 22.73043355, 22.765933757, 22.828699593, 22.832638374, 22.862640518, 22.913989586, 22.924485694, 22.950137874, 22.988286072, 23.016893213, 23.076528808, 23.102270273, 23.122198193, 23.138813756, 23.210604987, 23.234908705, 23.251078599, 23.282798201, 23.303527158, 23.359687384, 23.413695005, 23.463331432, 23.516923721, 23.547884034, 23.5578188, 23.578035392, 23.618222368, 23.659512966, 23.677507102, 23.716774125, 23.72526394, 23.765030403, 23.784719965, 23.801211711, 23.836378809, 23.865676896, 23.886617774, 23.917792245, 23.923424407, 23.946767631, 23.955371799, 23.992375172, 24.012117802, 24.081674162, 24.107289486, 24.121272775, 24.202178525, 24.278370988, 24.340387907, 24.401215567, 24.482842513, 24.521305793, 24.57541267, 24.650009567, 24.663654046, 24.685134372, 24.759934308, 24.809863597, 24.830675374, 24.875414591, 24.886750573, 24.931260653, 24.944690093, 24.961896968, 24.993601239, 25.010040085, 25.036293158, 25.051567619, 25.091424557, 25.128185758, 25.157452893, 25.170288074, 25.237982974, 25.275149098, 25.294860629, 25.3392105, 25.34391782, 25.36710952, 25.449619654, 25.482033357, 25.484894938, 25.578654784, 25.614380421, 25.638685836, 25.675688167, 25.701109126, 25.724240509, 25.76347697, 25.779297009, 25.819074003, 25.879944762, 25.890775034, 25.914374612, 25.957512147, 25.984316107, 25.992554517, 26.118772531, 26.137686038, 26.150101136, 26.198901379, 26.201253666, 26.213216461, 26.237276789, 26.240484045, 26.349777843, 26.36861032, 26.375267328, 26.401794736, 26.421851993, 26.487345848, 26.494794583, 26.50239174, 26.523854545, 26.589160054, 26.636574955, 26.67705635 )), .Names = c("5", "6", "8", "10", "20", "35", "50", "75", "100", "150", "200", "300", "500", "800", "1000", "1400", "1600", "2400", "10000"), row.names = c("1e-05", "1.01e-05", "1.02e-05", "1.04e-05", "1.05e-05", "1.06e-05", "1.07e-05", "1.08e-05", "1.1e-05", "1.11e-05", "1.12e-05", "1.14e-05", "1.15e-05", "1.16e-05", "1.17e-05", "1.19e-05", "1.2e-05", "1.22e-05", "1.23e-05", "1.24e-05", "1.26e-05", "1.27e-05", "1.29e-05", "1.3e-05", "1.32e-05", "1.33e-05", "1.35e-05", "1.36e-05", "1.38e-05", "1.4e-05", "1.41e-05", "1.43e-05", "1.45e-05", "1.46e-05", "1.48e-05", "1.5e-05", "1.51e-05", "1.53e-05", "1.55e-05", "1.57e-05", "1.58e-05", "1.6e-05", "1.62e-05", "1.64e-05", "1.66e-05", "1.68e-05", "1.7e-05", "1.72e-05", "1.74e-05", "1.76e-05", "1.78e-05", "1.8e-05", "1.82e-05", "1.84e-05", "1.86e-05", "1.88e-05", "1.91e-05", "1.93e-05", "1.95e-05", "1.97e-05", "2e-05", "2.02e-05", "2.04e-05", "2.07e-05", "2.09e-05", "2.11e-05", "2.14e-05", "2.16e-05", "2.19e-05", "2.21e-05", "2.24e-05", "2.26e-05", "2.29e-05", "2.32e-05", "2.34e-05", "2.37e-05", "2.4e-05", "2.43e-05", "2.45e-05", "2.48e-05", "2.51e-05", "2.54e-05", "2.57e-05", "2.6e-05", "2.63e-05", "2.66e-05", "2.69e-05", "2.72e-05", "2.75e-05", "2.79e-05", "2.82e-05", "2.85e-05", "2.88e-05", "2.92e-05", "2.95e-05", "2.99e-05", "3.02e-05", "3.05e-05", "3.09e-05", "3.13e-05", "3.16e-05", "3.2e-05", "3.24e-05", "3.27e-05", "3.31e-05", "3.35e-05", "3.39e-05", "3.43e-05", "3.47e-05", "3.51e-05", "3.55e-05", "3.59e-05", "3.63e-05", "3.67e-05", "3.72e-05", "3.76e-05", "3.8e-05", "3.85e-05", "3.89e-05", "3.94e-05", "3.98e-05", "4.03e-05", "4.07e-05", "4.12e-05", "4.17e-05", "4.22e-05", "4.27e-05", "4.32e-05", "4.37e-05", "4.42e-05", "4.47e-05", "4.52e-05", "4.57e-05", "4.62e-05", "4.68e-05", "4.73e-05", "4.79e-05", "4.84e-05", "4.9e-05", "4.95e-05", "5.01e-05", "5.07e-05", "5.13e-05", "5.19e-05", "5.25e-05", "5.31e-05", "5.37e-05", "5.43e-05", "5.5e-05", "5.56e-05", "5.62e-05", "5.69e-05", "5.75e-05", "5.82e-05", "5.89e-05", "5.96e-05", "6.03e-05", "6.1e-05", "6.17e-05", "6.24e-05", "6.31e-05", "6.38e-05", "6.46e-05", "6.53e-05", "6.61e-05", "6.68e-05", "6.76e-05", "6.84e-05", "6.92e-05", "7e-05", "7.08e-05", "7.16e-05", "7.24e-05", "7.33e-05", "7.41e-05", "7.5e-05", "7.59e-05", "7.67e-05", "7.76e-05", "7.85e-05", "7.94e-05", "8.04e-05", "8.13e-05", "8.22e-05", "8.32e-05", "8.41e-05", "8.51e-05", "8.61e-05", "8.71e-05", "8.81e-05", "8.91e-05", "9.02e-05", "9.12e-05", "9.23e-05", "9.33e-05", "9.44e-05", "9.55e-05", "9.66e-05", "9.77e-05", "9.89e-05", "1e-04", "0.0001012", "0.0001023", "0.0001035", "0.0001047", "0.0001059", "0.0001072", "0.0001084", "0.0001096", "0.0001109", "0.0001122", "0.0001135", "0.0001148", "0.0001161", "0.0001175", "0.0001189", "0.0001202", "0.0001216", "0.000123", "0.0001245", "0.0001259", "0.0001274", "0.0001288", "0.0001303", "0.0001318", "0.0001334", "0.0001349", "0.0001365", "0.000138", "0.0001396", "0.0001413", "0.0001429", "0.0001445", "0.0001462", "0.0001479", "0.0001496", "0.0001514", "0.0001531", "0.0001549", "0.0001567", "0.0001585", "0.0001603", "0.0001622", "0.0001641", "0.000166", "0.0001679", "0.0001698", "0.0001718", "0.0001738", "0.0001758", "0.0001778", "0.0001799", "0.000182", "0.0001841", "0.0001862", "0.0001884", "0.0001905", "0.0001928", "0.000195", "0.0001972", "0.0001995", "0.0002018", "0.0002042", "0.0002065", "0.0002089", "0.0002113", "0.0002138", "0.0002163", "0.0002188", "0.0002213", "0.0002239", "0.0002265", "0.0002291", "0.0002317", "0.0002344", "0.0002371", "0.0002399", "0.0002427", "0.0002455", "0.0002483", "0.0002512", "0.0002541", "0.000257", "0.00026", "0.000263", "0.0002661", "0.0002692", "0.0002723", "0.0002754", "0.0002786", "0.0002818", "0.0002851", "0.0002884", "0.0002917", "0.0002951", "0.0002985", "0.000302", "0.0003055", "0.000309", "0.0003126", "0.0003162", "0.0003199", "0.0003236", "0.0003273", "0.0003311", "0.000335", "0.0003388", "0.0003428", "0.0003467", "0.0003508", "0.0003548", "0.0003589", "0.0003631", "0.0003673", "0.0003715", "0.0003758", "0.0003802", "0.0003846", "0.000389", "0.0003936", "0.0003981", "0.0004027", "0.0004074", "0.0004121", "0.0004169", "0.0004217", "0.0004266", "0.0004315", "0.0004365", "0.0004416", "0.0004467", "0.0004519", "0.0004571", "0.0004624", "0.0004677", "0.0004732", "0.0004786", "0.0004842", "0.0004898", "0.0004955", "5e-04", "0.0005012", "0.000507", "0.0005129", "0.0005188", "0.0005248", "0.0005309", "0.000537", "0.0005433", "0.0005495", "0.0005559", "0.0005623", "0.0005689", "0.0005754", "0.0005821", "0.0005888", "0.0005957", "0.0006026", "0.0006095", "0.0006166", "0.0006237", "0.000631", "0.0006383", "0.0006457", "0.0006531", "0.0006607", "0.0006683", "0.0006761", "0.0006839", "0.0006918", "0.0006998", "0.0007079", "0.0007161", "0.0007244", "0.0007328", "0.0007413", "0.0007499", "0.0007586", "0.0007674", "0.0007762", "0.0007852", "0.0007943", "0.0008035", "0.0008128", "0.0008222", "0.0008318", "0.0008414", "0.0008511", "0.000861", "0.000871", "0.000881", "0.0008913", "0.0009016", "0.000912", "0.0009226", "0.0009333", "0.0009441", "0.000955", "0.0009661", "0.0009772", "0.0009886", "0.001", "0.0010116", "0.0010233", "0.0010351", "0.0010471", "0.0010593", "0.0010715", "0.0010839", "0.0010965", "0.0011092", "0.001122", "0.001135", "0.0011482", "0.0011614", "0.0011749", "0.0011885", "0.0012023", "0.0012162", "0.0012303", "0.0012445", "0.0012589", "0.0012735", "0.0012882", "0.0013032", "0.0013183", "0.0013335", "0.001349", "0.0013646", "0.0013804", "0.0013964", "0.0014125", "0.0014289", "0.0014454", "0.0014622", "0.0014791", "0.0014962", "0.0015136", "0.0015311", "0.0015488", "0.0015668", "0.0015849", "0.0016032", "0.0016218", "0.0016406", "0.0016596", "0.0016788", "0.0016982", "0.0017179", "0.0017378", "0.0017579", "0.0017783", "0.0017989", "0.0018197", "0.0018408", "0.0018621", "0.0018836", "0.0019055", "0.0019275", "0.0019498", "0.0019724", "0.0019953", "0.0020184", "0.0020417", "0.0020654", "0.0020893", "0.0021135", "0.002138", "0.0021627", "0.0021878", "0.0022131", "0.0022387", "0.0022646", "0.0022909", "0.0023174", "0.0023442", "0.0023714", "0.0023988", "0.0024266", "0.0024547", "0.0024831", "0.0025119", "0.002541", "0.0025704", "0.0026002", "0.0026303", "0.0026607", "0.0026915", "0.0027227", "0.0027542", "0.0027861", "0.0028184", "0.002851", "0.002884", "0.0029174", "0.0029512", "0.0029854", "0.00302", "0.0030549", "0.0030903", "0.0031261", "0.0031623", "0.0031989", "0.0032359", "0.0032734", "0.0033113", "0.0033497", "0.0033884", "0.0034277", "0.0034674", "0.0035075", "0.0035481", "0.0035892", "0.0036308", "0.0036728", "0.0037154", "0.0037584", "0.0038019", "0.0038459", "0.0038905", "0.0039355", "0.0039811", "0.0040272", "0.0040738", "0.004121", "0.0041687", "0.004217", "0.0042658", "0.0043152", "0.0043652", "0.0044157", "0.0044668", "0.0045186", "0.0045709", "0.0046238", "0.0046774", "0.0047315", "0.0047863", "0.0048417", "0.0048978", "0.0049545", "0.005", "0.0050119", "0.0050699", "0.0051286", "0.005188", "0.0052481", "0.0053088", "0.0053703", "0.0054325", "0.0054954", "0.005559", "0.0056234", "0.0056885", "0.0057544", "0.005821", "0.0058884", "0.0059566", "0.0060256", "0.0060954", "0.006166", "0.0062373", "0.0063096", "0.0063826", "0.0064565", "0.0065313", "0.0066069", "0.0066834", "0.0067608", "0.0068391", "0.0069183", "0.0069984", "0.0070795", "0.0071614", "0.0072444", "0.0073282", "0.0074131", "0.0074989", "0.0075858", "0.0076736", "0.0077625", "0.0078524", "0.0079433", "0.0080353", "0.0081283", "0.0082224", "0.0083176", "0.008414", "0.0085114", "0.0086099", "0.0087096", "0.0088105", "0.0089125", "0.0090157", "0.0091201", "0.0092257", "0.0093325", "0.0094406", "0.0095499", "0.0096605", "0.0097724", "0.0098855", "0.01", "0.0101158", "0.0102329", "0.0103514", "0.0104713", "0.0105925", "0.0107152", "0.0108393", "0.0109648", "0.0110917", "0.0112202", "0.0113501", "0.0114815", "0.0116145", "0.011749", "0.011885", "0.0120226", "0.0121619", "0.0123027", "0.0124451", "0.0125893", "0.012735", "0.0128825", "0.0130317", "0.0131826", "0.0133352", "0.0134896", "0.0136458", "0.0138038", "0.0139637", "0.0141254", "0.0142889", "0.0144544", "0.0146218", "0.0147911", "0.0149624", "0.0151356", "0.0153109", "0.0154882", "0.0156675", "0.0158489", "0.0160325", "0.0162181", "0.0164059", "0.0165959", "0.016788", "0.0169824", "0.0171791", "0.017378", "0.0175792", "0.0177828", "0.0179887", "0.018197", "0.0184077", "0.0186209", "0.0188365", "0.0190546", "0.0192752", "0.0194984", "0.0197242", "0.0199526", "0.0201837", "0.0204174", "0.0206538", "0.020893", "0.0211349", "0.0213796", "0.0216272", "0.0218776", "0.0221309", "0.0223872", "0.0226464", "0.0229087", "0.0231739", "0.0234423", "0.0237137", "0.0239883", "0.0242661", "0.0245471", "0.0248313", "0.0251189", "0.0254097", "0.025704", "0.0260016", "0.0263027", "0.0266073", "0.0269153", "0.027227", "0.0275423", "0.0278612", "0.0281838", "0.0285102", "0.0288403", "0.0291743", "0.0295121", "0.0298538", "0.0301995", "0.0305492", "0.030903", "0.0312608", "0.0316228", "0.031989", "0.0323594", "0.0327341", "0.0331131", "0.0334965", "0.0338844", "0.0342768", "0.0346737", "0.0350752", "0.0354813", "0.0358922", "0.0363078", "0.0367282", "0.0371535", "0.0375837", "0.0380189", "0.0384592", "0.0389045", "0.039355", "0.0398107", "0.0402717", "0.040738", "0.0412098", "0.0416869", "0.0421697", "0.042658", "0.0431519", "0.0436516", "0.044157", "0.0446684", "0.0451856", "0.0457088", "0.0462381", "0.0467735", "0.0473151", "0.047863", "0.0484172", "0.0489779", "0.049545", "0.05", "0.0501187", "0.0506991", "0.0512861", "0.05188", "0.0524807", "0.0530884", "0.0537032", "0.054325", "0.0549541", "0.0555904", "0.0562341", "0.0568853", "0.057544", "0.0582103", "0.0588844", "0.0595662", "0.060256", "0.0609537", "0.0616595", "0.0623735", "0.0630957", "0.0638263", "0.0645654", "0.0653131", "0.0660693", "0.0668344", "0.0676083", "0.0683912", "0.0691831", "0.0699842", "0.0707946", "0.0716143", "0.0724436", "0.0732825", "0.074131", "0.0749894", "0.0758578", "0.0767361", "0.0776247", "0.0785236", "0.0794328", "0.0803526", "0.0812831", "0.0822243", "0.0831764", "0.0841395", "0.0851138", "0.0860994", "0.0870964", "0.0881049", "0.0891251", "0.0901571", "0.0912011", "0.0922571", "0.0933254", "0.0944061", "0.0954993", "0.0966051", "0.0977237", "0.0988553", "0.1", "0.1011579", "0.1023293", "0.1035142", "0.1047129", "0.1059254", "0.1071519", "0.1083927", "0.1096478", "0.1109175", "0.1122018", "0.1135011", "0.1148154", "0.1161449", "0.1174898", "0.1188502", "0.1202264", "0.1216186", "0.1230269", "0.1244515", "0.1258925", "0.1273503", "0.128825", "0.1303167", "0.1318257", "0.1333521", "0.1348963", "0.1364583", "0.1380384", "0.1396368", "0.1412538", "0.1428894", "0.144544", "0.1462177", "0.1479108", "0.1496236", "0.15", "0.1513561", "0.1531087", "0.1548817", "0.1566751", "0.1584893", "0.1603245", "0.162181", "0.164059", "0.1659587", "0.1678804", "0.1698244", "0.1717908", "0.1737801", "0.1757924", "0.1778279", "0.1798871", "0.1819701", "0.1840772", "0.1862087", "0.1883649", "0.1905461", "0.1927525", "0.1949845", "0.1972423", "0.1995262", "0.2", "0.2018366", "0.2041738", "0.206538", "0.2089296", "0.2113489", "0.2137962", "0.2162719", "0.2187762", "0.2213095", "0.2238721", "0.2264644", "0.2290868", "0.2317395", "0.2344229", "0.2371374", "0.2398833", "0.242661", "0.2454709", "0.2483133", "0.2511886", "0.2540973", "0.2570396", "0.260016", "0.2630268", "0.2660725", "0.2691535", "0.2722701", "0.2754229", "0.2786121", "0.2818383", "0.2851018", "0.2884032", "0.2917427", "0.2951209", "0.2985383", "0.3", "0.3019952", "0.3054921", "0.3090295", "0.3126079", "0.3162278", "0.3198895", "0.3235937", "0.3273407", "0.3311311", "0.3349654", "0.3388442", "0.3427678", "0.3467369", "0.3507519", "0.3548134", "0.3589219", "0.3630781", "0.3672823", "0.3715352", "0.3758374", "0.3801894", "0.3845918", "0.3890451", "0.3935501", "0.3981072", "0.4", "0.402717", "0.4073803", "0.4120975", "0.4168694", "0.4216965", "0.4265795", "0.4315191", "0.4365158", "0.4415704", "0.4466836", "0.4518559", "0.4570882", "0.462381", "0.4677351", "0.4731513", "0.4786301", "0.4841724", "0.4897788", "0.4954502", "0.5", "0.5102212", "0.5158276", "0.5213699", "0.5268487", "0.5322649", "0.537619", "0.5429118", "0.5481441", "0.5533164", "0.5584296", "0.5634842", "0.5684809", "0.5734205", "0.5783035", "0.5831306", "0.5879025", "0.5926197", "0.597283", "0.6", "0.6018928", "0.6064499", "0.6109549", "0.6154082", "0.6198106", "0.6241626", "0.6284648", "0.6327177", "0.6369219", "0.6410781", "0.6451866", "0.6492481", "0.6532631", "0.6572322", "0.6611558", "0.6650346", "0.6688689", "0.6726593", "0.6764063", "0.6801105", "0.6837722", "0.6873921", "0.6909705", "0.6945079", "0.6980048", "0.7", "0.7014617", "0.7048791", "0.7082573", "0.7115968", "0.7148982", "0.7181617", "0.7213879", "0.7245771", "0.7277299", "0.7308465", "0.7339275", "0.7369732", "0.739984", "0.7429604", "0.7459027", "0.7488114", "0.7516867", "0.7545291", "0.757339", "0.7601167", "0.7628626", "0.7655771", "0.7682605", "0.7709132", "0.7735356", "0.7761279", "0.7786905", "0.7812238", "0.7837281", "0.7862038", "0.7886511", "0.7910704", "0.793462", "0.7958262", "0.7981634", "0.8", "0.8004738", "0.8027577", "0.8050155", "0.8072475", "0.8094539", "0.8116351", "0.8137913", "0.8159228", "0.8180299", "0.8201129", "0.8221721", "0.8242076", "0.8262199", "0.8282092", "0.8301756", "0.8321196", "0.8340413", "0.835941", "0.837819", "0.8396755", "0.8415107", "0.8433249", "0.8451183", "0.8468913", "0.8486439", "0.85", "0.8503764", "0.8520892", "0.8537823", "0.855456", "0.8571106", "0.8587462", "0.8603632", "0.8619616", "0.8635417", "0.8651037", "0.8666479", "0.8681743", "0.8696833", "0.871175", "0.8726497", "0.8741075", "0.8755485", "0.8769731", "0.8783814", "0.8797736", "0.8811498", "0.8825102", "0.8838551", "0.8851846", "0.8864989", "0.8877982", "0.8890825", "0.8903522", "0.8916073", "0.8928481", "0.8940746", "0.8952871", "0.8964858", "0.8976707", "0.8988421", "0.9", "0.9011447", "0.9022763", "0.9033949", "0.9045007", "0.9055939", "0.9066746", "0.9077429", "0.9087989", "0.9098429", "0.9108749", "0.9118951", "0.9129036", "0.9139006", "0.9148862", "0.9158605", "0.9168236", "0.9177757", "0.9187169", "0.9196474", "0.9205672", "0.9214764", "0.9223753", "0.9232639", "0.9241422", "0.9250106", "0.925869", "0.9267175", "0.9275564", "0.9283857", "0.9292054", "0.9300158", "0.9308169", "0.9316088", "0.9323917", "0.9331656", "0.9339307", "0.9346869", "0.9354346", "0.9361737", "0.9369043", "0.9376265", "0.9383405", "0.9390463", "0.939744", "0.9404338", "0.9411156", "0.9417897", "0.942456", "0.9431147", "0.9437659", "0.9444096", "0.9450459", "0.945675", "0.9462968", "0.9469116", "0.9475193", "0.94812", "0.9487139", "0.9493009", "0.9498813", "0.95", "0.950455", "0.9510221", "0.9515828", "0.952137", "0.9526849", "0.9532265", "0.9537619", "0.9542912", "0.9548144", "0.9553316", "0.955843", "0.9563484", "0.9568481", "0.957342", "0.9578303", "0.9583131", "0.9587902", "0.959262", "0.9597283", "0.9601893", "0.960645", "0.9610955", "0.9615408", "0.9619811", "0.9624163", "0.9628465", "0.9632718", "0.9636922", "0.9641078", "0.9645187", "0.9649248", "0.9653263", "0.9657232", "0.9661156", "0.9665035", "0.9668869", "0.9672659", "0.9676406", "0.968011", "0.9683772", "0.9687392", "0.969097", "0.9694508", "0.9698005", "0.9701462", "0.9704879", "0.9708257", "0.9711597", "0.9714898", "0.9718162", "0.9721388", "0.9724577", "0.972773", "0.9730847", "0.9733927", "0.9736973", "0.9739984", "0.974296", "0.9745903", "0.9748811", "0.9751687", "0.9754529", "0.9757339", "0.9760117", "0.9762863", "0.9765577", "0.9768261", "0.9770913", "0.9773536", "0.9776128", "0.9778691", "0.9781224", "0.9783728", "0.9786204", "0.9788651", "0.979107", "0.9793462", "0.9795826", "0.9798163", "0.9800474", "0.9802758", "0.9805016", "0.9807248", "0.9809454", "0.9811635", "0.9813791", "0.9815923", "0.981803", "0.9820113", "0.9822172", "0.9824208", "0.982622", "0.9828209", "0.9830176", "0.983212", "0.9834041", "0.9835941", "0.9837819", "0.9839675", "0.9841511", "0.9843325", "0.9845118", "0.9846891", "0.9848644", "0.9850376", "0.9852089", "0.9853782", "0.9855456", "0.9857111", "0.9858746", "0.9860363", "0.9861962", "0.9863542", "0.9865104", "0.9866648", "0.9868174", "0.9869683", "0.9871175", "0.987265", "0.9874107", "0.9875549", "0.9876973", "0.9878381", "0.9879774", "0.988115", "0.988251", "0.9883855", "0.9885185", "0.9886499", "0.9887798", "0.9889083", "0.9890352", "0.9891607", "0.9892848", "0.9894075", "0.9895287", "0.9896486", "0.9897671", "0.9898842", "0.99", "0.9901145", "0.9902276", "0.9903395", "0.9904501", "0.9905594", "0.9906675", "0.9907743", "0.9908799", "0.9909843", "0.9910875", "0.9911895", "0.9912904", "0.9913901", "0.9914886", "0.991586", "0.9916824", "0.9917776", "0.9918717", "0.9919647", "0.9920567", "0.9921476", "0.9922375", "0.9923264", "0.9924142", "0.9925011", "0.9925869", "0.9926718", "0.9927556", "0.9928386", "0.9929205", "0.9930016", "0.9930817", "0.9931609", "0.9932392", "0.9933166", "0.9933931", "0.9934687", "0.9935435", "0.9936174", "0.9936904", "0.9937627", "0.993834", "0.9939046", "0.9939744", "0.9940434", "0.9941116", "0.994179", "0.9942456", "0.9943115", "0.9943766", "0.994441", "0.9945046", "0.9945675", "0.9946297", "0.9946912", "0.9947519", "0.994812", "0.9948714", "0.9949301", "0.9949881", "0.995", "0.9950455", "0.9951022", "0.9951583", "0.9952137", "0.9952685", "0.9953226", "0.9953762", "0.9954291", "0.9954814", "0.9955332", "0.9955843", "0.9956348", "0.9956848", "0.9957342", "0.995783", "0.9958313", "0.995879", "0.9959262", "0.9959728", "0.9960189", "0.9960645", "0.9961095", "0.9961541", "0.9961981", "0.9962416", "0.9962846", "0.9963272", "0.9963692", "0.9964108", "0.9964519", "0.9964925", "0.9965326", "0.9965723", "0.9966116", "0.9966503", "0.9966887", "0.9967266", "0.9967641", "0.9968011", "0.9968377", "0.9968739", "0.9969097", "0.9969451", "0.99698", "0.9970146", "0.9970488", "0.9970826", "0.997116", "0.997149", "0.9971816", "0.9972139", "0.9972458", "0.9972773", "0.9973085", "0.9973393", "0.9973697", "0.9973998", "0.9974296", "0.997459", "0.9974881", "0.9975169", "0.9975453", "0.9975734", "0.9976012", "0.9976286", "0.9976558", "0.9976826", "0.9977091", "0.9977354", "0.9977613", "0.9977869", "0.9978122", "0.9978373", "0.997862", "0.9978865", "0.9979107", "0.9979346", "0.9979583", "0.9979816", "0.9980047", "0.9980276", "0.9980502", "0.9980725", "0.9980945", "0.9981164", "0.9981379", "0.9981592", "0.9981803", "0.9982011", "0.9982217", "0.9982421", "0.9982622", "0.9982821", "0.9983018", "0.9983212", "0.9983404", "0.9983594", "0.9983782", "0.9983968", "0.9984151", "0.9984332", "0.9984512", "0.9984689", "0.9984864", "0.9985038", "0.9985209", "0.9985378", "0.9985546", "0.9985711", "0.9985875", "0.9986036", "0.9986196", "0.9986354", "0.998651", "0.9986665", "0.9986817", "0.9986968", "0.9987118", "0.9987265", "0.9987411", "0.9987555", "0.9987697", "0.9987838", "0.9987977", "0.9988115", "0.9988251", "0.9988386", "0.9988518", "0.998865", "0.998878", "0.9988908", "0.9989035", "0.9989161", "0.9989285", "0.9989407", "0.9989529", "0.9989649", "0.9989767", "0.9989884", "0.999", "0.9990114", "0.9990228", "0.9990339", "0.999045", "0.9990559", "0.9990667", "0.9990774", "0.999088", "0.9990984", "0.9991087", "0.999119", "0.999129", "0.999139", "0.9991489", "0.9991586", "0.9991682", "0.9991778", "0.9991872", "0.9991965", "0.9992057", "0.9992148", "0.9992238", "0.9992326", "0.9992414", "0.9992501", "0.9992587", "0.9992672", "0.9992756", "0.9992839", "0.9992921", "0.9993002", "0.9993082", "0.9993161", "0.9993239", "0.9993317", "0.9993393", "0.9993469", "0.9993543", "0.9993617", "0.999369", "0.9993763", "0.9993834", "0.9993905", "0.9993974", "0.9994043", "0.9994112", "0.9994179", "0.9994246", "0.9994311", "0.9994377", "0.9994441", "0.9994505", "0.9994567", "0.999463", "0.9994691", "0.9994752", "0.9994812", "0.9994871", "0.999493", "0.9994988", "0.9995", "0.9995045", "0.9995102", "0.9995158", "0.9995214", "0.9995268", "0.9995323", "0.9995376", "0.9995429", "0.9995481", "0.9995533", "0.9995584", "0.9995635", "0.9995685", "0.9995734", "0.9995783", "0.9995831", "0.9995879", "0.9995926", "0.9995973", "0.9996019", "0.9996064", "0.999611", "0.9996154", "0.9996198", "0.9996242", "0.9996285", "0.9996327", "0.9996369", "0.9996411", "0.9996452", "0.9996492", "0.9996533", "0.9996572", "0.9996612", "0.999665", "0.9996689", "0.9996727", "0.9996764", "0.9996801", "0.9996838", "0.9996874", "0.999691", "0.9996945", "0.999698", "0.9997015", "0.9997049", "0.9997083", "0.9997116", "0.9997149", "0.9997182", "0.9997214", "0.9997246", "0.9997277", "0.9997308", "0.9997339", "0.999737", "0.99974", "0.999743", "0.9997459", "0.9997488", "0.9997517", "0.9997545", "0.9997573", "0.9997601", "0.9997629", "0.9997656", "0.9997683", "0.9997709", "0.9997735", "0.9997761", "0.9997787", "0.9997812", "0.9997837", "0.9997862", "0.9997887", "0.9997911", "0.9997935", "0.9997958", "0.9997982", "0.9998005", "0.9998028", "0.999805", "0.9998072", "0.9998095", "0.9998116", "0.9998138", "0.9998159", "0.999818", "0.9998201", "0.9998222", "0.9998242", "0.9998262", "0.9998282", "0.9998302", "0.9998321", "0.999834", "0.9998359", "0.9998378", "0.9998397", "0.9998415", "0.9998433", "0.9998451", "0.9998469", "0.9998486", "0.9998504", "0.9998521", "0.9998538", "0.9998555", "0.9998571", "0.9998587", "0.9998604", "0.999862", "0.9998635", "0.9998651", "0.9998666", "0.9998682", "0.9998697", "0.9998712", "0.9998726", "0.9998741", "0.9998755", "0.999877", "0.9998784", "0.9998798", "0.9998811", "0.9998825", "0.9998839", "0.9998852", "0.9998865", "0.9998878", "0.9998891", "0.9998904", "0.9998916", "0.9998928", "0.9998941", "0.9998953", "0.9998965", "0.9998977", "0.9998988", "0.9999", "0.9999011", "0.9999023", "0.9999034", "0.9999045", "0.9999056", "0.9999067", "0.9999077", "0.9999088", "0.9999098", "0.9999109", "0.9999119", "0.9999129", "0.9999139", "0.9999149", "0.9999159", "0.9999168", "0.9999178", "0.9999187", "0.9999196", "0.9999206", "0.9999215", "0.9999224", "0.9999233", "0.9999241", "0.999925", "0.9999259", "0.9999267", "0.9999276", "0.9999284", "0.9999292", "0.99993", "0.9999308", "0.9999316", "0.9999324", "0.9999332", "0.9999339", "0.9999347", "0.9999354", "0.9999362", "0.9999369", "0.9999376", "0.9999383", "0.999939", "0.9999397", "0.9999404", "0.9999411", "0.9999418", "0.9999425", "0.9999431", "0.9999438", "0.9999444", "0.999945", "0.9999457", "0.9999463", "0.9999469", "0.9999475", "0.9999481", "0.9999487", "0.9999493", "0.9999499", "0.9999505", "0.999951", "0.9999516", "0.9999521", "0.9999527", "0.9999532", "0.9999538", "0.9999543", "0.9999548", "0.9999553", "0.9999558", "0.9999563", "0.9999568", "0.9999573", "0.9999578", "0.9999583", "0.9999588", "0.9999593", "0.9999597", "0.9999602", "0.9999606", "0.9999611", "0.9999615", "0.999962", "0.9999624", "0.9999628", "0.9999633", "0.9999637", "0.9999641", "0.9999645", "0.9999649", "0.9999653", "0.9999657", "0.9999661", "0.9999665", "0.9999669", "0.9999673", "0.9999676", "0.999968", "0.9999684", "0.9999687", "0.9999691", "0.9999695", "0.9999698", "0.9999701", "0.9999705", "0.9999708", "0.9999712", "0.9999715", "0.9999718", "0.9999721", "0.9999725", "0.9999728", "0.9999731", "0.9999734", "0.9999737", "0.999974", "0.9999743", "0.9999746", "0.9999749", "0.9999752", "0.9999755", "0.9999757", "0.999976", "0.9999763", "0.9999766", "0.9999768", "0.9999771", "0.9999774", "0.9999776", "0.9999779", "0.9999781", "0.9999784", "0.9999786", "0.9999789", "0.9999791", "0.9999793", "0.9999796", "0.9999798", "0.99998", "0.9999803", "0.9999805", "0.9999807", "0.9999809", "0.9999812", "0.9999814", "0.9999816", "0.9999818", "0.999982", "0.9999822", "0.9999824", "0.9999826", "0.9999828", "0.999983", "0.9999832", "0.9999834", "0.9999836", "0.9999838", "0.999984", "0.9999842", "0.9999843", "0.9999845", "0.9999847", "0.9999849", "0.999985", "0.9999852", "0.9999854", "0.9999855", "0.9999857", "0.9999859", "0.999986", "0.9999862", "0.9999864", "0.9999865", "0.9999867", "0.9999868", "0.999987", "0.9999871", "0.9999873", "0.9999874", "0.9999876", "0.9999877", "0.9999878", "0.999988", "0.9999881", "0.9999883", "0.9999884", "0.9999885", "0.9999886", "0.9999888", "0.9999889", "0.999989", "0.9999892", "0.9999893", "0.9999894", "0.9999895", "0.9999896", "0.9999898", "0.9999899", "0.99999" ), class = "data.frame") } ################################################################################ fBasics/R/dist-ght.R0000644000176200001440000001131313202116742013670 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dght Density of the generalized hyperbolic Student-t # pght Probability of the GHT # dght Quantiles of the GHT # rght Random variates of the GHT ################################################################################ dght <- function(x, beta = 0.1, delta = 1, mu = 0, nu = 10, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density of the generalized hyperbolic Student-t # Arguments: # Example: # x = (-5):5; dght(x) # FUNCTION: # Parameters: if (length(beta) == 4) { nu = beta[4] mu = beta[3] delta = beta[2] beta = beta[1] } # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Density: ans = dgh(x, alpha, beta, delta, mu, lambda, log = log) # Return Value: ans } # ------------------------------------------------------------------------------ pght <- function(q, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns probabilities of the generalized hyperbolic Student-t # Arguments: # Example: # q = (-5):5; pght(q) # FUNCTION: # Parameters: if (length(beta) == 4) { nu = beta[4] mu = beta[3] delta = beta[2] beta = beta[1] } # Cumulative Probability: ans = NULL for (Q in q) { Integral = integrate(dght, -Inf, Q, stop.on.error = FALSE, beta = beta, delta = delta, mu = mu, nu = nu) ans = c(ans, as.numeric(unlist(Integral)[1]) ) } # Return Value: ans } # ------------------------------------------------------------------------------ qght <- function(p, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of the generalized hyperbolic Student-t # Arguments: # Example: # p = (1:9)/10; qght(p); round(pght(qght(p)), digits = 4) # FUNCTION: # Parameters: if (length(beta) == 4) { nu = beta[4] mu = beta[3] delta = beta[2] beta = beta[1] } # Internal Functions: .froot <- function(x, beta = beta, delta = delta, mu = mu, nu = nu, p) { pght(q = x, beta = beta, delta = delta, mu = mu, nu = nu) - p } # Loop over all p's: result = NULL for (pp in p) { lower = -1 upper = +1 counter = 0 iteration = NA while (is.na(iteration)) { iteration = .unirootNA(f = .froot, interval = c(lower, upper), beta = beta, delta = delta, mu = mu, nu = nu, p = pp) counter = counter + 1 lower = lower - 2^counter upper = upper + 2^counter } result = c(result, iteration) } # Return Value: ans = result + mu ans } # ------------------------------------------------------------------------------ rght <- function(n, beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns random Variates of generalized hyperbolic Student-t # Arguments: # Example: # r = rght(10) # FUNCTION: # Parameters: if (length(beta) == 4) { nu = beta[4] mu = beta[3] delta = beta[2] beta = beta[1] } # GH Parameters: alpha = abs(beta) + 1e-6 lambda = -nu/2 # Random Variates: x = rgh(n, alpha, beta = beta, delta = delta, mu = mu, lambda) # Return Value: x } ################################################################################ fBasics/R/plot-subPlot.R0000644000176200001440000001566313202116741014564 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .emptyPlot Creates an empty plot page # .subPlot Creates a sub plot # .cnvrt.coords Converts coordinates ################################################################################ .emptyPlot <- function() { # Description: # Creates an empty plot page # FUNCTION: # Plot: plot(c(0, 1), c(0, 1), type = "n", xlab = "", ylab = "", ann = TRUE, axes = FALSE) # Return Value: invisible() } # ------------------------------------------------------------------------------ # Package: TeachingDemos # Title: Demonstrations for teaching and learning # Version: 1.6 # Author: Greg Snow # Description: This package is a set of demonstration functions that can # be used in a classroom to demonstrate statistical concepts, or on your # own to better understand the concepts or the programming. # Maintainer: Greg Snow # License: Artistic-2.0 # Date: 2007-09-07 # Suggests: tcltk, lattice, tkrplot, MASS, rgl, sgeostat, mapproj # Enhances: maptools, qcc # LazyData: true # Packaged: Wed Nov 28 12:13:53 2007; hornik # ------------------------------------------------------------------------------ # Example: # plot(c(0, 1), c(0, 1)); .subPlot(hist(rnorm(100)), x = 0.5, y = 0.5) # ------------------------------------------------------------------------------ .subPlot <- function(fun, x, y = NULL, size = c(1, 1), vadj = 0.5, hadj = 0.5, pars = NULL) { # Description: # Creates a sub plot # FUNCTION: # Par: old.par <- par(no.readonly=TRUE) on.exit(par(old.par)) if(missing(x)) x <- locator(2) xy <- xy.coords(x,y) if(length(xy$x) != 2){ pin <- par('pin') tmp <- .cnvrt.coords(xy$x[1],xy$y[1],'usr')$plt x <- c( tmp$x - hadj*size[1]/pin[1], tmp$x + (1-hadj)*size[1]/pin[1] ) y <- c( tmp$y - vadj*size[2]/pin[2], tmp$y + (1-vadj)*size[2]/pin[2] ) xy <- .cnvrt.coords(x,y,'plt')$fig } else { xy <- .cnvrt.coords(xy,,'usr')$fig } par(pars) par(plt=c(xy$x,xy$y), new = TRUE) fun tmp.par <- par(no.readonly = TRUE) return(invisible(tmp.par)) } # ------------------------------------------------------------------------------ .cnvrt.coords <- function(x,y=NULL,input=c('usr','plt','fig','dev','tdev')) { # Description: # Converts Coordinates # FUNCTION: input <- match.arg(input) xy <- xy.coords(x,y) cusr <- par('usr') cplt <- par('plt') cfig <- par('fig') cdin <- par('din') comi <- par('omi') cdev <- c(comi[2]/cdin[1],(cdin[1]-comi[4])/cdin[1], comi[1]/cdin[2],(cdin[2]-comi[3])/cdin[2]) if(input=='usr'){ usr <- xy plt <- list() plt$x <- (xy$x-cusr[1])/(cusr[2]-cusr[1]) plt$y <- (xy$y-cusr[3])/(cusr[4]-cusr[3]) fig <- list() fig$x <- plt$x*(cplt[2]-cplt[1])+cplt[1] fig$y <- plt$y*(cplt[4]-cplt[3])+cplt[3] dev <- list() dev$x <- fig$x*(cfig[2]-cfig[1])+cfig[1] dev$y <- fig$y*(cfig[4]-cfig[3])+cfig[3] tdev <- list() tdev$x <- dev$x*(cdev[2]-cdev[1])+cdev[1] tdev$y <- dev$y*(cdev[4]-cdev[3])+cdev[3] return( list( usr=usr, plt=plt, fig=fig, dev=dev, tdev=tdev ) ) } if(input=='plt') { plt <- xy usr <- list() usr$x <- plt$x*(cusr[2]-cusr[1])+cusr[1] usr$y <- plt$y*(cusr[4]-cusr[3])+cusr[3] fig <- list() fig$x <- plt$x*(cplt[2]-cplt[1])+cplt[1] fig$y <- plt$y*(cplt[4]-cplt[3])+cplt[3] dev <- list() dev$x <- fig$x*(cfig[2]-cfig[1])+cfig[1] dev$y <- fig$y*(cfig[4]-cfig[3])+cfig[3] tdev <- list() tdev$x <- dev$x*(cdev[2]-cdev[1])+cdev[1] tdev$y <- dev$y*(cdev[4]-cdev[3])+cdev[3] return( list( usr=usr, plt=plt, fig=fig, dev=dev, tdev=tdev ) ) } if(input=='fig') { fig <- xy plt <- list() plt$x <- (fig$x-cplt[1])/(cplt[2]-cplt[1]) plt$y <- (fig$y-cplt[3])/(cplt[4]-cplt[3]) usr <- list() usr$x <- plt$x*(cusr[2]-cusr[1])+cusr[1] usr$y <- plt$y*(cusr[4]-cusr[3])+cusr[3] dev <- list() dev$x <- fig$x*(cfig[2]-cfig[1])+cfig[1] dev$y <- fig$y*(cfig[4]-cfig[3])+cfig[3] tdev <- list() tdev$x <- dev$x*(cdev[2]-cdev[1])+cdev[1] tdev$y <- dev$y*(cdev[4]-cdev[3])+cdev[3] return( list( usr=usr, plt=plt, fig=fig, dev=dev, tdev=tdev ) ) } if(input=='dev'){ dev <- xy fig <- list() fig$x <- (dev$x-cfig[1])/(cfig[2]-cfig[1]) fig$y <- (dev$y-cfig[3])/(cfig[4]-cfig[3]) plt <- list() plt$x <- (fig$x-cplt[1])/(cplt[2]-cplt[1]) plt$y <- (fig$y-cplt[3])/(cplt[4]-cplt[3]) usr <- list() usr$x <- plt$x*(cusr[2]-cusr[1])+cusr[1] usr$y <- plt$y*(cusr[4]-cusr[3])+cusr[3] tdev <- list() tdev$x <- dev$x*(cdev[2]-cdev[1])+cdev[1] tdev$y <- dev$y*(cdev[4]-cdev[3])+cdev[3] return( list( usr=usr, plt=plt, fig=fig, dev=dev, tdev=tdev ) ) } if(input=='tdev'){ tdev <- xy dev <- list() dev$x <- (tdev$x-cdev[1])/(cdev[2]-cdev[1]) dev$y <- (tdev$y-cdev[3])/(cdev[4]-cdev[3]) fig <- list() fig$x <- (dev$x-cfig[1])/(cfig[2]-cfig[1]) fig$y <- (dev$y-cfig[3])/(cfig[4]-cfig[3]) plt <- list() plt$x <- (fig$x-cplt[1])/(cplt[2]-cplt[1]) plt$y <- (fig$y-cplt[3])/(cplt[4]-cplt[3]) usr <- list() usr$x <- plt$x*(cusr[2]-cusr[1])+cusr[1] usr$y <- plt$y*(cusr[4]-cusr[3])+cusr[3] tdev <- list() tdev$x <- dev$x*(cdev[2]-cdev[1])+cdev[1] tdev$y <- dev$y*(cdev[4]-cdev[3])+cdev[3] return( list( usr=usr, plt=plt, fig=fig, dev=dev, tdev=tdev ) ) } } ################################################################################ fBasics/R/stats-basicStats.R0000644000176200001440000000721113202116741015402 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: BASIC STATISTICS: # basicStats Returns a basic statistics summary ################################################################################ basicStats = function(x, ci = 0.95) { # A function implemented by Diethelm Wuertz # Description: # Calculates Basic Statistics # Arguments: # x - an object which can be transformed by the function # as.matrix() into an object of class matrix. # ci - a numeric value setting the confidence interval. # Value: # a two-column data frame, where the first column takes the # value of the statistics, and the second its name, e.g. # "nobs", "NAs", "Minimum", "Maximum", "1. Quartile", # "3. Quartile", "Mean", "Median", "Sum", "SE Mean", # "LCL Mean", "UCL Mean", "Variance", "Stdev", "Skewness", # "Kurtosis") # FUNCTION: # Univariate/Multivariate: y = as.matrix(x) # Handle Column Names: if (is.null(colnames(y))) { Dim = dim(y)[2] if (Dim == 1) { colnames(y) = paste(substitute(x), collapse = ".") } else if (Dim > 1) { colnames(y) = paste(paste(substitute(x), collapse = ""), 1:Dim, sep = "") } } # Internal Function - CL Levels: cl.vals = function(x, ci) { x = x[!is.na(x)] n = length(x) if(n <= 1) return(c(NA, NA)) se.mean = sqrt(var(x)/n) t.val = qt((1 - ci)/2, n - 1) mn = mean(x) lcl = mn + se.mean * t.val ucl = mn - se.mean * t.val c(lcl, ucl) } # Basic Statistics: nColumns = dim(y)[2] ans = NULL for (i in 1:nColumns) { X = y[, i] # Observations: X.length = length(X) X = X[!is.na(X)] X.na = X.length - length(X) # Basic Statistics: z = c( X.length, X.na, min(X), max(X), as.numeric(quantile(X, prob = 0.25, na.rm = TRUE)), as.numeric(quantile(X, prob = 0.75, na.rm = TRUE)), mean(X), median(X), sum(X), sqrt(var(X)/length(X)), cl.vals(X, ci)[1], cl.vals(X, ci)[2], var(X), sqrt(var(X)), skewness(X), kurtosis(X) ) # Row Names: znames = c( "nobs", "NAs", "Minimum", "Maximum", "1. Quartile", "3. Quartile", "Mean", "Median", "Sum", "SE Mean", "LCL Mean", "UCL Mean", "Variance", "Stdev", "Skewness", "Kurtosis") # Output as data.frame result = matrix(z, ncol = 1) row.names(result) = znames ans = cbind(ans, result) } # Column Names: colnames(ans) = colnames(y) # Return Value: data.frame(round(ans, digits = 6)) } ################################################################################ fBasics/R/dist-hypMode.R0000644000176200001440000000700113202116741014511 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # hypMode Computes the hyperbolic mode # FUNCTION: DESCRIPTION: # .hyp[1234]Mode Internal functions called by 'hypMode' ################################################################################ hypMode <- function(alpha = 1, beta = 0, delta = 1, mu = 0, pm = c(1, 2, 3, 4)) { # A function implemented by Diethelm Wuertz # Description: # Computes the mode of the Hyperbolic PDF # FUNCTION: # Settings: pm = pm[1] # Return Value: ans = NA if (pm == 1) return(.hyp1Mode(alpha, beta, delta, mu)) if (pm == 2) return(.hyp2Mode(alpha, beta, delta, mu)) if (pm == 3) return(.hyp3Mode(alpha, beta, delta, mu)) if (pm == 4) return(.hyp4Mode(alpha, beta, delta, mu)) } # ------------------------------------------------------------------------------ .hyp1Mode <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the mode of the Hyperbolic PDF # FUNCTION: # Mode: ans = mu + delta * beta / sqrt(alpha^2 - beta^2) # Return Value: ans } # ------------------------------------------------------------------------------ .hyp2Mode <- function(zeta = 1, rho = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the hyperbolic mode in the 2nd parameterization # FUNCTION: # Parameter Change: alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = hypMode(alpha, beta, delta, mu) ans } # ------------------------------------------------------------------------------ .hyp3Mode <- function(xi = 1/sqrt(2), chi = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the hyperbolic mode in the 3rd parameterization # FUNCTION: # Parameter Change: rho = chi / xi zeta = 1/xi^2 - 1 alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho ans = hypMode(alpha, beta, delta, mu) # Return Value: ans } # ------------------------------------------------------------------------------ .hyp4Mode <- function(a.bar = 1, b.bar = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the hyperbolic mode in the 4th parameterization # FUNCTION: # Parameter Change: alpha = a.bar / delta beta = b.bar / delta ans = hypMode(alpha, beta, delta, mu) # Return Value: ans } ################################################################################ fBasics/R/plot-boxPlot.R0000644000176200001440000001320113202116742014546 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # boxPlot Produces a side-by-side standard box plot # boxPercentilePlot Produces a side-by-side box-percentile plot ################################################################################ boxPlot <- function(x, col = "steelblue", title = TRUE, ...) { # A function Implemented by Diethelm Wuertz # Description: # Produces a standard box plot # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.matrix()' into an object of class 'matrix'. # Optional Arguments: # las, oma - allows to change style of X labels and creates # required space below plot. # Try: e.g. las = 3, and oma = c(9, 0, 0, 0) # FUNCTION: # Settings: x = as.matrix(x) assetNames = colnames(x) # Plot: ans = boxplot(as.data.frame(x), col = col, ...) abline(h = 0 , lty = 3) # Add Title: if (title) { title(main = "Box Plot", ylab = "Value") } # Result: colnames(ans$stats) = ans$names rownames(ans$stats) = c("lower whisker", "lower hinge", "median", "upper hinge", "upper whisker") # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ boxPercentilePlot <- function(x, col = "steelblue", title = TRUE, ...) { # A modified copy from Hmisc # Description: # Produces a side-by-side box-percentile plot # Details: # Box-percentile plots are similiar to boxplots, except box-percentile # plots supply more information about the univariate distributions. At # any height the width of the irregular "box" is proportional to the # percentile of that height, up to the 50th percentile, and above the # 50th percentile the width is proportional to 100 minus the percentile. # Thus, the width at any given height is proportional to the percent of # observations that are more extreme in that direction. As in boxplots, # the median, 25th and 75th percentiles are marked with line segments # across the box. [Source: Hmisc] # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.matrix()' into an object of class 'matrix'. # FUNCTION: # Settings: x = as.matrix(x) assetNames = colnames(x) n = ncol(x) all.x = list() for (i in 1:n) all.x[[i]] = as.vector(x[, i]) centers = seq(from = 0, by = 1.2, length = n) ymax = max(sapply(all.x, max, na.rm = TRUE)) ymin = min(sapply(all.x, min, na.rm = TRUE)) xmax = max(centers) + 0.5 xmin = -0.5 # Plot: if (length(col) == 1) col = rep(col, times = n) plot(c(xmin, xmax), c(ymin, ymax), type = "n", xlab = "", ylab = "", xaxt = "n", ...) xpos = NULL for (i in 1:n) { # plot.values = .bpxAssetsPlot(all.x[[i]], centers[i]) y = all.x[[i]] offset = centers[i] y = y[!is.na(y)] n = length(y) delta = 1/(n + 1) prob = seq(delta, 1 - delta, delta) quan = sort(y) med = median(y) q1 = median(y[y < med]) q3 = median(y[y > med]) first.half.p = prob[quan <= med] second.half.p = 1 - prob[quan > med] plotx = c(first.half.p, second.half.p) options(warn = -1) qx = approx(quan, plotx, xout = q1)$y q1.x = c(-qx, qx) + offset qx = approx(quan, plotx, xout = q3)$y options(warn = 0) q3.x = c(-qx, qx) + offset q1.y = c(q1, q1) q3.y = c(q3, q3) med.x = c(-max(first.half.p), max(first.half.p)) + offset med.y = c(med, med) plot.values = list(x1 = (-plotx) + offset, y1 = quan, x2 = plotx + offset, y2 = quan, q1.y = q1.y, q1.x = q1.x, q3.y = q3.y, q3.x = q3.x, med.y = med.y, med.x = med.x) # Continue: xpos = c(xpos, mean(plot.values$med.x)) x.p = c(plot.values$x1, plot.values$x2) y.p = c(plot.values$y1, plot.values$y2) polygon(x.p, y.p, col = col[i], border = "grey", ...) lines(plot.values$x1, plot.values$y1) lines(plot.values$x2, plot.values$y2) lines(plot.values$q1.x, plot.values$q1.y) lines(plot.values$q3.x, plot.values$q3.y) lines(plot.values$med.x, plot.values$med.y) } axis(side = 1, at = xpos, labels = assetNames, ...) abline(h = 0, lty = 3, col = "black") # Add Title: if (title) { title(main = "Box Percentiles", ylab = "Value") } # Return Value: invisible() } ################################################################################ fBasics/R/dist-ssd.R0000644000176200001440000000526413202116741013706 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTIONS: DESCRIPTION: # dssd Returns spline smoothed density estimate # pssd Returns spline smoothed probability estimate # qssd Returns spline smoothed quantiles estimate # rssd Returns spline smoothed random variates # LIBRARY: DESCRPTION: # stabledist Stable Duistribution ################################################################################ dssd <- function(x, param, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Evaluate density using smoothing spline ANOVA model # FUNCTION: # Density: ans <- gss::dssden(object = param, x = x) # Log: if(log) ans <- log(ans) # Return Value: ans } # ------------------------------------------------------------------------------ pssd <- function(q, param) { # A function implemented by Diethelm Wuertz # Description: # Evaluate probability using smoothing spline ANOVA model # FUNCTION: # Return Value: gss::pssden(object = param, q = q) } # ------------------------------------------------------------------------------ qssd <- function(p, param) { # A function implemented by Diethelm Wuertz # Description: # Evaluate quantiles using smoothing spline ANOVA model # FUNCTION: # Return Value: gss::qssden(object = param, p = p) } # ------------------------------------------------------------------------------ rssd <- function(n, param) { # A function implemented by Diethelm Wuertz # Description: # Generate random deviates using smoothing spline ANOVA model # FUNCTION: # Return Value: gss::qssden(object = param, p = runif(n)) } ################################################################################ fBasics/R/stats-maxdd.R0000644000176200001440000002240513202116742014402 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR Description. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # maxddStats Expectation of Drawdowns for BM with drift # .maxddStats Utility function called by "maxddStats" # FUNCTION: DISTRIBUTION AND RANDOM VARIATES: # dmaxdd Density function of mean Max-Drawdowns # pmaxdd Probability function of mean Max-Drawdowns # rmaxdd Random Variates of mean Max-Drawdowns ################################################################################ maxddStats <- function(mean = 0, sd = 1, horizon = 1000) { # A function implemented by Diethelm Wuertz # Description: # Calculates Expectation Value E[D] of maximum Drawdowns of # Brownian Motion for a given drift "mu", variance "sigma", # and runtime "horizon" of the Brownian Motion process. # Arguments: # mu - Drift of Brownian Motion, a numeric vector. # sigma - Standard Deviation of Brownian Motion, a numeric value. # horizon - Runtime of the process, the time horizon of the # investor, a numeric value. # Details: # Interpolates the data given in the table of Appendix B # in Magdon-Ismail et al. [2003], "On the Maximum Drawdown # of Brownian Motion". The interpolation is done with R's # function spline(). # Notes. # This computes for a vector of horizon values. # FUNCTION: # Statistics: ans = NULL for (i in 1:length(horizon)) { ans = c(ans, .maxddStats(mu = mean, sigma = sd, horizon = horizon[i])) } # Return Value: ans } # ------------------------------------------------------------------------------ .maxddStats <- function(mu = 0, sigma = 1, horizon = 1000) { # A function implemented by Diethelm Wuertz # Description: # Utility function called by "maxddStats" # Arguments: # see function "maxddStats # FUNCTION: # Internal Function - POSITIVE CASE: mu > 0 # Left Table from Appendix B: QP = function(x) { gamma = sqrt(pi/8) vqn = t(matrix(c( 0.0005,0.019690, 0.0010,0.027694, 0.0015,0.033789, 0.0020,0.038896, 0.0025,0.043372, 0.0050,0.060721, 0.0075,0.073808, 0.0100,0.084693, 0.0125,0.094171, 0.0150,0.102651, 0.0175,0.110375, 0.0200,0.117503, 0.0225,0.124142, 0.0250,0.130374, 0.0275,0.136259, 0.0300,0.141842, 0.0325,0.147162, 0.0350,0.152249, 0.0375,0.157127, 0.0400,0.161817, 0.0425,0.166337, 0.0450,0.170702, 0.0500,0.179015, 0.0600,0.194248, 0.0700,0.207999, 0.0800,0.220581, 0.0900,0.232212, 0.1000,0.243050, 0.2000,0.325071, 0.3000,0.382016, 0.4000,0.426452, 0.5000,0.463159, 1.5000,0.668992, 2.5000,0.775976, 3.5000,0.849298, 4.5000,0.905305, 10.000,1.088998, 20.000,1.253794, 30.000,1.351794, 40.000,1.421860, 50.000,1.476457, 150.00,1.747485, 250.00,1.874323, 350.00,1.958037, 450.00,2.020630, 1000.0,2.219765, 2000.0,2.392826, 3000.0,2.494109, 4000.0,2.565985, 5000.0,2.621743), 2)) # Interpolation: if (x < 0.0005) { y = gamma*sqrt(2*x) } if (x >= 0.0005 & x <= 5000) { y = spline(log(vqn[,1]), vqn[,2], n = 1, xmin = log(x), xmax = log(x))$y } if (x > 5000) { y = 0.25*log(x) + 0.49088} # Return Value: y } # Internal Function - NEGATIVE CASE: mu < 0 # Right Table from Appendix B: QN = function(x) { gamma = sqrt(pi/8) vqn = t(matrix(c( 0.0005,0.019965, 0.0010,0.028394, 0.0015,0.034874, 0.0020,0.040369, 0.0025,0.045256, 0.0050,0.064633, 0.0075,0.079746, 0.0100,0.092708, 0.0125,0.104259, 0.0150,0.114814, 0.0175,0.124608, 0.0200,0.133772, 0.0225,0.142429, 0.0250,0.150739, 0.0275,0.158565, 0.0300,0.166229, 0.0325,0.173756, 0.0350,0.180793, 0.0375,0.187739, 0.0400,0.194489, 0.0425,0.201094, 0.0450,0.207572, 0.0475,0.213877, 0.0500,0.220056, 0.0550,0.231797, 0.0600,0.243374, 0.0650,0.254585, 0.0700,0.265472, 0.0750,0.276070, 0.0800,0.286406, 0.0850,0.296507, 0.0900,0.306393, 0.0950,0.316066, 0.1000,0.325586, 0.1500,0.413136, 0.2000,0.491599, 0.2500,0.564333, 0.3000,0.633007, 0.3500,0.698849, 0.4000,0.762455, 0.5000,0.884593, 1.0000,1.445520, 1.5000,1.970740, 2.0000,2.483960, 2.5000,2.990940, 3.0000,3.492520, 3.5000,3.995190, 4.0000,4.492380, 4.5000,4.990430, 5.0000,5.498820), 2)) # Interpolation: if (x < 0.0005) { y = gamma*sqrt(2*x) } if (x >= 0.0005 & x <= 5) { y = spline(vqn[,1], vqn[,2], n = 1, xmin = x, xmax = x)$y } if (x > 5) { y = x + 1/2 } # Return Value: y } # Result: ED = NULL for (i in 1:length(mu)) { if (mu[i] == 0) { gamma = sqrt(pi/8) ED[i] = 2 * gamma * sigma * sqrt(horizon) } else { x = mu[i]^2 * horizon / ( 2 * sigma^2 ) if (mu[i] > 0) { ED[i] = ( 2* sigma^2 / mu[i] ) * QP(x) } if (mu[i] < 0) { ED[i] = - ( 2* sigma^2 / mu[i] ) * QN(x) } } } # Return Value: ED } ################################################################################ dmaxdd <- function(x, sd = 1, horizon = 100, N = 1000) { # Description: # Calculates for a trendless Brownian process (mean=0) and # standard deviation "sd" the density from the probability # that the maximum drawdown "D" is larger or equal to "h" # in the interval [0,T], where "T" denotes the time horizon # of the investor. # Arguments: # x - Vector of Drawdowns # sd - Standard Deviation # horizon - Time horizon of the investor # N - number of summands # Notes: # The drift dependent case is not yet implemented! # FUNCTION: # Use "h", "sigma" to be conform with Magdon-Ismael et al. [2003] h = x sigma = sd # Settings: n = 1:N pn = 2 * sin((n-0.5)*pi) * sigma^2 * (n-0.5) * pi * horizon en = sigma^2 * (n-0.5)^2 * pi^2 * horizon / 2 # Loop over all Drawdowns: result = rep(NA, times = length(h)) for (i in 1:length(h)) { if (h[i] == 0) { result[i] = 0 } else { g = pn * exp(-en/(h[i]^2)) / h[i]^3 result[i] = sum(g) } } # Return Value: result } # ------------------------------------------------------------------------------ pmaxdd <- function(q, sd = 1, horizon = 100, N = 1000) { # Description: # Calculates for a trendless Brownian process (mean=0) # with standard deviation "sd" the probability that the # maximum drawdown "D" is larger or equal to "h" in the # interval [0,T], where "T" denotes the time horizon of # the investor. # Arguments: # q - Vector of Drawdowns # sd - Standard Deviation # horizon - Time horizon of the investor # N - number of summands # Value: # GD(h) - eqn(14) In Magdon-Ismail et al. # Notes: # The drift dependent case is not yet implemented! # FUNCTION: # Use "h", "sigma" to be conform with Magdon-Ismael et al. [2003] h = q sigma = sd # Settings: n = 1:N pn = 2 * ( sin((n-0.5)*pi) / ((n-0.5)*pi) ) en = sigma^2 * (n-0.5)^2 * pi^2 * horizon / 2 # Loop over all Drawdowns: result = rep(NA, times = length(h)) for (i in 1:length(h)) { g = pn * ( 1 - exp(-en/(h[i]^2)) ) result[i] = sum(g) } # Return Value: result } # ------------------------------------------------------------------------------ rmaxdd <- function(n, mean = 0, sd = 1, horizon = 100) { # Description: # Generates for a Brownian process with mean "mean" and # standard deviation "sd" random variates of maximum # Drawdowns. # Arguments: # n - Number of Drawdown rvs # mean - Drift # sd - Standard Deviation # horizon - Time horizon of the investor # FUNCTION: # Simulation of "n" max Drawdowns "h": result = NULL for (i in 1:n) { D = cumsum(rnorm(horizon, mean = mean, sd = sd)) result[i] = max(cummax(D)-D) } # Return Value: result } ################################################################################ fBasics/R/matrix-norm.R0000644000176200001440000000465313202116741014432 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # norm2 Returns the norm2 of a matrix ################################################################################ # IMPORTANT NOTICE: # The function fBasics::norm() has become obsolete, use instead: # base::norm(x, type) - Note, the arguments are different. # The original Rmetrics function is still available as fBasics:norm2() norm2 <- function(x, p = 2) { # A function implemented by Diethelm Wuertz # Description: # Returns the spectral norm of a matrix # Details: # http://mathworld.wolfram.com/MatrixNorm.html: # For p = 1 # The maximum absolute column sum norm |A|_1 is defined # as the maximum of the sum of the absolute valued elements # of columns of the matrix. # For p = 2: # The spectral |A|_2 norm is "the" of a matrix. This value # is computed as the square root of the maximum eigenvalue # of A^H A where A^H is the conjugate transpose. # For p = Inf: # The maximum absolute row sum norm |A|_inf is defined # as the maximum of the sum of the absolute valued elements # of rows of the matrix. # FUNCTION: # Compute Norm: ans <- NA if (p == 1) { x <- abs(x) ans <- max(apply(x, 2, sum)) } if (p == 2) { ans <- sqrt(max(eigen(t(x) %*% x)$values)) } if (p == Inf) { x <- abs(x) ans <- max(apply(x, 1, sum)) } if (is.na(ans)) stop("Invalid value for p") # Return value: ans } ################################################################################ fBasics/R/utils-colorLocator.R0000644000176200001440000000631413202116741015751 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: COLOR NAMES: # colorLocator Plots R's 657 named colors for selection # colorMatrix Returns matrix of R's color names ################################################################################ ################################################################################ # Package: epitools # Version: 0.4-9 # Date: 2007-06-27 # Title: Epidemiology Tools # Author: Tomas Aragon # Maintainer: Tomas Aragon # Depends: R (>= 2.1.0) # Description: EpiTools: R Package for Epidemiologic Data and Graphics # License: GPL version 2 or newer # URL: http://www.epitools.net # Packaged: Wed Jun 27 20:27:33 2007; Tomas colorLocator <- function(locator = FALSE, cex.axis = 0.7) { # A function implemented by Diethelm Wuertz # Description: # Plots R's 657 named colors for selection # Source: # Code borrowed from contributed R-package epitools # FUNCTION: # Plot: xx <- rep(1:30, 22) yy <- rep(1:22, rep(30, 22)) yyy <- matrix(yy, ncol = 22) cm <- colorMatrix() matplot(xx[1:30], yyy, pch = 15, type = "n", axes = FALSE, xlab = "colorMatrix[row, ]", ylab = "colorMatrix[ , col]", main = "Identify Color Names.") ## title(sub = "Source: www.epitools.net", cex.sub = 0.7) points(xx, yy, type = "p", pch = 15, cex = 2, col = c(colors(), NA, NA, NA)) axis(1, at = c(0:30 + 0.5), labels = FALSE, tick = TRUE) axis(1, at = 1:30, labels = 1:30, cex.axis = cex.axis, tick = FALSE) axis(2, at = c(0:22 + 0.5), labels = FALSE, tick = TRUE) axis(2, at = 1:22, labels = 1:22, cex.axis = cex.axis, tick = FALSE, las = 1) # Locator: if (locator) { lxy <- locator() xy <- round(data.frame(lxy)) xym <- as.matrix(xy) ## return located := data.frame(xy, color.names = cm[xym]) } else { invisible(cm) } } # ------------------------------------------------------------------------------ colorMatrix <- function() { # A function implemented by Diethelm Wuertz # Description: # Returns matrix of R's color names # Source: # Code borrowed from contributed R-package epitools # FUNCTION: # Color Names: x <- matrix(c(colors(), NA, NA, NA), 30, 22) # Return Value: invisible(x) } ################################################################################ fBasics/R/matrix-colVec.R0000644000176200001440000000344613202116742014672 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # colVec Creates a column vector from a data vector # rowVec Creates a row vector from a data vector ################################################################################ colVec <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Converts a vector to a column vector # Details: # A column vector is a matrix with one column. # Return Value: # FUNCTION: # Double Transpose: ans = t(t(x)) # Return Value: ans } # ------------------------------------------------------------------------------ rowVec <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Converts a vector to a row vector # Details: # A row vector is a matrix with one row. # FUNCTION: # Transpose: ans = t(x) # Return Value: ans } ################################################################################ fBasics/R/dist-normRobMoments.R0000644000176200001440000000723413202116741016075 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # normMED Returns true normal median # normIQR Returns true normal inter quartal range # normSKEW Returns true normal robust skewness # normKURT Returns true normal robust kurtosis ################################################################################ normMED <- function(mean =0, sd = 1) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh median # Arguments: # mean - a numeric value, the location parameter # sd - a numeric value, the scale parameter # FUNCTION: # Median: Q = qnorm(p=0.5, mean, sd) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ normIQR <- function(mean=0, sd=1) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh inter quartal range # Arguments: # mean - a numeric value, the location parameter # sd - a numeric value, the scale parameter # FUNCTION: # Inter Quartile Range: Q = numeric() Q[1] = qnorm(p=0.25, mean, sd) Q[2] = qnorm(p=0.75, mean, sd) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ normSKEW <- function(mean=0, sd=1) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh skewness # Arguments: # mean - a numeric value, the location parameter # sd - a numeric value, the scale parameter # FUNCTION: # Robust Skewness: Q = numeric() Q[1] = qnorm(p=0.25, mean, sd) Q[2] = qnorm(p=0.50, mean, sd) Q[3] = qnorm(p=0.75, mean, sd) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ normKURT <- function(mean=0, sd=1) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh kurtosis # Arguments: # mean - a numeric value, the location parameter # sd - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, qnorm(p, mean, sd)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/utils-Heaviside.R0000644000176200001440000001002013202116742015176 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: HEAVISIDE AND RELATED FUNCTIONS: # Heaviside Computes Heaviside unit step function # Sign Another signum function # Delta Computes delta function # Boxcar Computes boxcar function # Ramp Computes ramp function ################################################################################ Heaviside <- function(x, a = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the Heaviside or unit step function. # Arguments: # x - a numeric vector. # a - the location of the break. # Details: # The Heaviside step function is 1 for x>a, 1/2 for x=a, # and 0 for xa, 0 for x=a, # and -1 for x0 lower = quantile(x, probs = pl[i]) lines(z[i], lower, col = "brown") pl = p+s i = pl < 1 & pl > 0 upper = quantile(x, probs = pl[i]) lines(z[i], upper, col = "brown") abline(h = mean(x), col = "grey") abline(v = mean(x), col = "grey") # Result: ans = list(x = z, y = x) attr(ans, "control")<-par # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ qqnigPlot <- function(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a NIG quantile-quantile Plot # Arguments: # x - an univariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # Example: # qqnigPlot(rnig(100)) # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) stopifnot(isUnivariate(x)) Units = x@units x = as.vector(x) n = length(x) ## YC: no scaling ## FIXME: should take care of too small time series # Fit: fit = nigFit(x, doplot = FALSE, trace = FALSE) par = fit@fit$estimate names(par) = c("alpha", "beta", "delta", "mu") # Quantiles: x = sort(x) p = ppoints(x) z = qnig(p, par[1], par[2], par[3], par[4]) # Plot: if (labels) { xlab = "Theoretical Quantiles" ylab = "Sample Quantiles" plot(z, x, xlab = xlab, ylab = ylab, col = col, pch = pch, ...) } else { plot(z, x, ...) } # Title: if (title) { title(main = "NIG QQ Plot") } # Margin Text: rpar = signif(par, 3) text = paste( "alpha =", rpar[1], "| beta =", rpar[2], "| delta =", rpar[3], "| mu =", rpar[4]) mtext(text, side = 4, adj = 0, col = "grey", cex = 0.7) # Grid: if (grid) { grid() } # Add Fit: abline(lsfit(z, x)) # Add Rugs: if(rug) { rug(z, ticksize = 0.01, side = 3, quiet = TRUE) rug(x, ticksize = 0.01, side = 4, quiet = TRUE) } # Result: ans = list(x = z, y = x) attr(ans, "control") <- par # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ qqghtPlot <- function(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a GHT quantile-quantile Plot # Arguments: # x - an univariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # Example: # qqnigPlot(rgh(100)) # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) stopifnot(isUnivariate(x)) Units = x@units x = as.vector(x) n = length(x) # Fit: fit = ghtFit(x, doplot = FALSE, trace = FALSE) par = fit@fit$estimate names(par) = c("beta", "delta", "mu", "nu") # Plot: x <- sort(x) p <- ppoints(x) z <- qght(p, par[1], par[2], par[3], par[4]) if (labels) { plot(z, x, col = col, ann = FALSE, ...) } else { plot(z, x, ...) } # Add Grid: if (grid) { grid() } # Add title: if (title) { title( main = "GHT QQ Plot", xlab = "Theoretical Quantiles", ylab = "Sample Quantiles") } # Add Fit: abline(lsfit(z, x)) # Add Rugs: if(rug) { rug(z, ticksize = 0.01, side = 3, quiet = TRUE) rug(x, ticksize = 0.01, side = 4, quiet = TRUE) } # Result: ans = list(x = z, y = x) attr(ans, "control")<-par # Return Value: invisible(ans) } ################################################################################ qqgldPlot <- function(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Displays a Generalized lambda Distribution quantile-quantile Plot # Arguments: # x - an univariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # Example: # qqgldPlot(rgld(100)) # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) stopifnot(isUnivariate(x)) Units = x@units x = as.vector(x) n = length(x) ## YC: no scaling ## FIXME: should take care of too small time series # Fit: fit = gldFit(x, doplot = FALSE, trace = FALSE) par = fit@fit$estimate names(par) = c("lambda1", "lambda2", "lambda3", "lambda4") # Quantiles: x = sort(x) p = ppoints(x) z = qgld(p, par[1], par[2], par[3], par[4]) # Plot: if (labels) { xlab = "Theoretical Quantiles" ylab = "Sample Quantiles" plot(z, x, xlab = xlab, ylab = ylab, col = col, pch = pch, ...) } else { plot(z, x, ...) } # Title: if (title) { title(main = "NIG QQ Plot") } # Margin Text: rpar = signif(par, 3) text = paste( "lambda1 =", rpar[1], "| lambda2 =", rpar[2], "| lambda3 =", rpar[3], "| lambda4 =", rpar[4]) mtext(text, side = 4, adj = 0, col = "grey", cex = 0.7) # Grid: if (grid) { grid() } # Add Fit: abline(lsfit(z, x)) # Add Rugs: if(rug) { rug(z, ticksize = 0.01, side = 3, quiet = TRUE) rug(x, ticksize = 0.01, side = 4, quiet = TRUE) } # Result: ans = list(x = z, y = x) attr(ans, "control") <- par # Return Value: invisible(ans) } ################################################################################fBasics/R/dist-stableFit.R0000644000176200001440000006113313202116742015030 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: STABLE DISTRIBUTION: # stableFit Fits parameters of a stable density # .phiStable Creates contour table for McCulloch estimators # .PhiStable Contour table created by function .phiStable() # .qStableFit Estimates parameters by McCulloch's approach # .mleStableFit Estimates stable parameters by MLE approach # .stablePlot Plots results of stable parameter estimates # LIBRARY: DESCRPTION: # stabledist Stable Duistribution ################################################################################ stableFit <- function(x, alpha = 1.75, beta = 0, gamma = 1, delta = 0, type = c("q", "mle"), doplot = TRUE, control = list(), trace = FALSE, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description # Stable Parameter Estimation # FUNCTION: # Start Values: Use Quantile Method: ans = .qStableFit(x, doplot, title, description) # Continue with MLE Approach: if (type[1] == "mle") { Alpha = ans@fit$estimate[1] Beta = ans@fit$estimate[2] Gamma = ans@fit$estimate[3] Delta = ans@fit$estimate[4] if (is.na(Alpha)) Alpha = alpha if (is.na(Beta)) Beta = beta if (is.na(Gamma)) Gamma = gamma if (is.na(Delta)) Delta = delta ans = .mleStableFit(x, Alpha, Beta, Gamma, Delta, doplot, control, trace, title, description) } # Return Value: ans } # ------------------------------------------------------------------------------ .phiStable <- function() { # A function implemented by Diethelm Wuertz # Description: # Creates contour table for McCulloch estimators # Note: # Stable Distribution - delta=1 and gamma=0 fixed! # FUNCTION: # Settings: alpha = c(seq(0.50, 1.95, by = 0.1), 1.95, 1.99) beta = c(-0.95, seq(-0.90, 0.90, by = 0.10), 0.95) m = length(alpha) n = length(beta) # phi1: phi1 = function(alpha, beta) { ( stabledist::qstable(0.95, alpha, beta) - stabledist::qstable(0.05, alpha, beta) ) / ( stabledist::qstable(0.75, alpha, beta) - stabledist::qstable(0.25, alpha, beta) ) } # phi2: phi2 = function(alpha, beta) { ( ( stabledist::qstable(0.95, alpha, beta) - stabledist::qstable(0.50, alpha, beta) ) - ( stabledist::qstable(0.50, alpha, beta) - stabledist::qstable(0.05, alpha, beta) ) ) / ( stabledist::qstable(0.95, alpha, beta) - stabledist::qstable(0.05, alpha, beta) ) } # Phi: Phi1 = Phi2 = matrix(rep(0, n*m), ncol = n) for ( i in 1:m ) { for ( j in 1:n ) { Phi1[i,j] = phi1(alpha[i], beta[j]) Phi2[i,j] = phi2(alpha[i], beta[j]) print( c(alpha[i], beta[j], Phi1[i,j], Phi2[i,j]) ) } } #Plot: contour(alpha, beta, Phi1, levels = c(2.5, 3, 5, 10, 20, 40), xlab = "alpha", ylab = "beta", labcex = 1.5, xlim = c(0.5, 2.0)) contour(alpha, beta, Phi2, levels = c(-0.8, -0.6, -0.4, -0.2, 0, 0.2, 0.4, 0.6, 0.8), col = "red", labcex = 1.5, add = TRUE) # Result: .PhiStable <- list(Phi1 = Phi1, Phi2 = Phi2, alpha = alpha, beta = beta) # Dump: if (FALSE) dump(".PhiStable", "PhiStable.R") # Return Value: .PhiStable } # ------------------------------------------------------------------------------ .PhiStable <- structure( # Contour table created by .phiStable() list( Phi1 = structure(c(28.1355600962322, 15.7196640771722, 10.4340722145276, 7.72099712337154, 6.14340919629241, 5.14081963876442, 4.45927409495436, 3.97057677836415, 3.60450193720703, 3.31957820409758, 3.09091185492284, 2.9029090263133, 2.74659551412658, 2.61782756430233, 2.51560631141019, 2.47408801877228, 2.44525363752631, 28.3483300097440, 15.8035063527296, 10.4727953966709, 7.74141823634036, 6.15576314177463, 5.14915506532249, 4.46531988542058, 3.97505189771183, 3.60736868847651, 3.32104702700423, 3.09111342044363, 2.90219825204304, 2.74552084086904, 2.61707392900167, 2.51531961206501, 2.47401179006119, 2.44525268403340, 28.9048147202382, 16.0601313263480, 10.6117049719320, 7.8237753182648, 6.20955682299195, 5.18679961805621, 4.49216000186678, 3.99373973242068, 3.61933010719953, 3.3275594162867, 3.09331226057454, 2.90155994459038, 2.74368539137288, 2.61555847928520, 2.51479444686423, 2.47387109904253, 2.44525093764076, 29.8026200973137, 16.5596243974224, 10.9360864131028, 8.04563520952583, 6.35889612112486, 5.28397230078563, 4.55431822343012, 4.03266384946799, 3.64246979110989, 3.33973615437707, 3.09810405845187, 2.90191073816964, 2.7422687239301, 2.61421528380001, 2.51433181630644, 2.47374639426837, 2.44524854839106, 31.1711919144382, 17.3256645589998, 11.4257682914949, 8.37916374365985, 6.59111369941092, 5.4435297531592, 4.65827423282770, 4.09593909348039, 3.67827370972420, 3.35788028768518, 3.10538249512478, 2.90322430476313, 2.7411383952518, 2.61307358265729, 2.51393064512464, 2.47363793686619, 2.44524473760244, 33.1948934984822, 18.4071500759968, 12.0794579487667, 8.80181848446003, 6.8744516193679, 5.6351929385469, 4.78568154439060, 4.17585254205654, 3.72404890551037, 3.38077811930023, 3.11457663716798, 2.90522469731234, 2.74043557937936, 2.61209710262770, 2.51359601849030, 2.47354590407541, 2.44523688699559, 35.9578028398622, 19.7936882741385, 12.8664734285429, 9.28349135864713, 7.18278427917665, 5.83729171895546, 4.91779143967590, 4.25960094973301, 3.77307337255403, 3.4057709031586, 3.12469898537975, 2.90767817230573, 2.7399388028832, 2.61130578115398, 2.51330169831474, 2.47347041290067, 2.4452243360266, 38.9647018181828, 21.2269841758554, 13.6587928142908, 9.75737930074977, 7.47910500668215, 6.02679068365276, 5.03975173429821, 4.33641171958119, 3.81844774991854, 3.42948489228359, 3.13453596844362, 2.91006724722144, 2.73965159366498, 2.61068126597691, 2.51309087992836, 2.47342375837911, 2.44524639012562, 41.7818369588849, 22.4602363370435, 14.3128567516975, 10.1435099877839, 7.72005687380391, 6.18048140792379, 5.13779081982581, 4.39769218775219, 3.85488105109873, 3.44880791704519, 3.14262443869137, 2.91215029990006, 2.73947335432536, 2.61026149741526, 2.51293721037603, 2.47333463795113, 2.44523871005695, 43.8597008728084, 23.308181530155, 14.7432127411421, 10.3930748979735, 7.87518470289541, 6.2796283727218, 5.20095216574708, 4.43724315622136, 3.87838777226609, 3.46128790559551, 3.14792806986726, 2.91355836113947, 2.7394048824397, 2.60999397178590, 2.51287974154683, 2.4733261698261, 2.44523291863013, 44.6351177921226, 23.612190997173, 14.8937659530932, 10.4791077126402, 7.9285095195091, 6.31375867971341, 5.2228691158165, 4.45085115209764, 3.88645952709398, 3.46562279514434, 3.14978921717977, 2.91402779433739, 2.73939000980242, 2.60993524495366, 2.51289337121820, 2.47330017392183, 2.44524525291192, 43.8597008728085, 23.3081815301550, 14.7432127411420, 10.3930748979735, 7.87518470289542, 6.2796283727218, 5.20095216574709, 4.43724315622136, 3.87838777226609, 3.46128790559551, 3.14792806986726, 2.91355836113947, 2.7394048824397, 2.60999397178590, 2.51287974154683, 2.4733261698261, 2.44523291863013, 41.7818369588849, 22.4602363370436, 14.3128567516975, 10.1435099877840, 7.72005687380392, 6.18048140792379, 5.13779081982581, 4.39769218775219, 3.85488105109874, 3.44880791704519, 3.14262443869137, 2.91215029990006, 2.73947335432536, 2.61026149741526, 2.51293721037603, 2.47333463795113, 2.44523871005695, 38.9647018181828, 21.2269841758554, 13.6587928142909, 9.75737930074976, 7.47910500668216, 6.02679068365277, 5.0397517342982, 4.33641171958119, 3.81844774991854, 3.42948489228359, 3.13453596844362, 2.91006724722144, 2.73965159366498, 2.61068126597691, 2.51309087992836, 2.47342375837911, 2.44524639012562, 35.9578028398623, 19.7936882741384, 12.8664734285429, 9.28349135864712, 7.18278427917667, 5.83729171895546, 4.91779143967590, 4.25960094973301, 3.77307337255403, 3.4057709031586, 3.12469898537975, 2.90767817230572, 2.7399388028832, 2.61130578115398, 2.51330169831474, 2.47347041290067, 2.4452243360266, 33.1948934984822, 18.4071500759967, 12.0794579487667, 8.80181848446, 6.8744516193679, 5.6351929385469, 4.78568154439059, 4.17585254205653, 3.72404890551037, 3.38077811930023, 3.11457663716797, 2.90522469731234, 2.74043557937936, 2.61209710262770, 2.51359601849030, 2.47354590407541, 2.44523688699559, 31.1711919144381, 17.3256645589999, 11.4257682914948, 8.37916374365983, 6.59111369941092, 5.44352975315921, 4.65827423282769, 4.09593909348039, 3.67827370972420, 3.35788028768518, 3.10538249512478, 2.90322430476312, 2.7411383952518, 2.61307358265729, 2.51393064512464, 2.47363793686619, 2.44524473760245, 29.8026200973136, 16.5596243974222, 10.9360864131028, 8.04563520952581, 6.35889612112487, 5.28397230078562, 4.55431822343012, 4.03266384946799, 3.64246979110989, 3.33973615437707, 3.09810405845187, 2.90191073816964, 2.7422687239301, 2.61421528380001, 2.51433181630644, 2.47374639426837, 2.44524854839106, 28.904814720238, 16.0601313263481, 10.6117049719320, 7.82377531826481, 6.20955682299195, 5.18679961805620, 4.49216000186678, 3.99373973242068, 3.61933010719952, 3.3275594162867, 3.09331226057455, 2.90155994459037, 2.74368539137288, 2.61555847928520, 2.51479444686423, 2.47387109904253, 2.44525093764076, 28.3483300097438, 15.8035063527296, 10.4727953966709, 7.74141823634038, 6.15576314177465, 5.1491550653225, 4.46531988542057, 3.97505189771183, 3.60736868847651, 3.32104702700424, 3.09111342044363, 2.90219825204304, 2.74552084086904, 2.61707392900167, 2.51531961206501, 2.47401179006119, 2.44525268403340, 28.1355600962322, 15.7196640771723, 10.4340722145275, 7.72099712337151, 6.1434091962924, 5.14081963876442, 4.45927409495435, 3.97057677836415, 3.60450193720703, 3.31957820409757, 3.09091185492284, 2.9029090263133, 2.74659551412658, 2.61782756430233, 2.51560631141019, 2.47408801877228, 2.44525363752631), .Dim = as.integer(c(17, 21))), Phi2 = structure(c(-0.984831521754346, -0.96178750287388, -0.925815277018118, -0.877909786944587, -0.820184465666658, -0.755031918545081, -0.684592921700777, -0.610570901457792, -0.534175805219629, -0.456236240234657, -0.377306837254648, -0.297867095171864, -0.218666685919607, -0.141143940005887, -0.0674987199592516, -0.0328701597273596, -0.00642990194045526, -0.984833720280198, -0.96124832221758, -0.92402252050786, -0.87419335313835, -0.81415246030398, -0.74662653505109, -0.674063099101783, -0.598388680797427, -0.520979416823626, -0.442739494396008, -0.364272193075272, -0.286088382456793, -0.208957354222478, -0.1342789733294, -0.0640144100029875, -0.0311490271069921, -0.006091726394748, -0.979153629182453, -0.95106168789293, -0.909673941239617, -0.85602448791855, -0.791828629762056, -0.720369142925194, -0.644748722301942, -0.567214164881932, -0.489279988980024, -0.411880943403832, -0.335605401995838, -0.260987626602553, -0.188786833912990, -0.120269390643364, -0.0570145517746281, -0.0277025095388298, -0.0054153433806392, -0.956099620177616, -0.91510100889139, -0.863494586547947, -0.804340589970157, -0.739811913292119, -0.670992067490536, -0.598508014750715, -0.523938483324115, -0.449119649196787, -0.375320171482799, -0.303334211640077, -0.233819259537015, -0.167632931803862, -0.105970645511563, -0.0499759998221647, -0.0242509183116938, -0.00473892214395457, -0.91091521430624, -0.854269872890404, -0.792380659464175, -0.728324327412516, -0.663641470500818, -0.598766118303959, -0.533390833007158, -0.466958108675312, -0.399718402638334, -0.332810169846175, -0.267433026630897, -0.204649764654678, -0.145582752525226, -0.0913961065988934, -0.042902827489912, -0.0207949382390745, -0.004062467796571, -0.838142578217344, -0.767730556629547, -0.699387193072487, -0.634346095207953, -0.572568000770375, -0.513428073110925, -0.456016815864829, -0.399237447140644, -0.342164056355244, -0.284798223846443, -0.228151639956042, -0.173628819918976, -0.122674652213850, -0.0765638152109311, -0.0358016086121756, -0.0173352283908653, -0.00338423605633909, -0.732960648615699, -0.655211639338905, -0.586717060962992, -0.525770503418058, -0.470570307907465, -0.419573011635011, -0.371434023729476, -0.324886123523844, -0.278750785874156, -0.232309518692667, -0.185933156371725, -0.140978784025337, -0.0990680854456507, -0.0615175707971035, -0.0286670029088599, -0.0138724303903631, -0.00270395845154647, -0.592691443906747, -0.517917221384721, -0.456902886405761, -0.405327421204478, -0.360251537992231, -0.319685291504111, -0.282167838420900, -0.246496132463733, -0.211596523966543, -0.176602222829403, -0.141397972727901, -0.106937786396409, -0.0748572933895385, -0.0462908166605395, -0.0215205174484398, -0.0104071747947459, -0.00203767706388774, -0.418561278354954, -0.359043286074154, -0.313110693536944, -0.275656631235694, -0.243720459128403, -0.215493360906447, -0.18976206222188, -0.165585707487220, -0.142157842427747, -0.118764989711438, -0.0951531051692878, -0.0718822809574559, -0.0501702371114745, -0.0309413187181704, -0.0143569748225324, -0.00693928545290556, -0.00135914851834483, -0.217058958479026, -0.183957984146554, -0.159253973812649, -0.139529858864502, -0.122956050946611, -0.108468261383110, -0.095363933833862, -0.0831489044941912, -0.0713807547092049, -0.0596749091239935, -0.0478406346829651, -0.0361189030171852, -0.0251638752545685, -0.0154951657479659, -0.00718251696063777, -0.00347157285038577, -0.000682830247122471, -1.30195010613456e-15, -7.12101008020212e-16, -9.8472751183435e-16, -1.13492047149954e-15, -1.21096413626332e-15, -1.05505102779748e-15, -1.11782289130157e-15, -8.13224377427617e-16, -5.85149540688739e-16, 4.61239028385592e-16, 1.45510576814449e-16, -4.733934001018e-16, -3.36773719381392e-16, 0, 9.23542032962673e-17, -1.87944839722067e-16, -2.8550539469612e-16, 0.217058958479025, 0.183957984146551, 0.159253973812647, 0.139529858864502, 0.12295605094661, 0.108468261383109, 0.0953639338338615, 0.0831489044941909, 0.0713807547092042, 0.0596749091239931, 0.0478406346829641, 0.036118903017185, 0.0251638752545679, 0.0154951657479665, 0.00718251696063749, 0.00347157285038558, 0.00068283024712209, 0.418561278354956, 0.359043286074156, 0.313110693536942, 0.275656631235694, 0.243720459128404, 0.215493360906444, 0.189762062221879, 0.165585707487219, 0.142157842427746, 0.118764989711438, 0.0951531051692875, 0.0718822809574556, 0.0501702371114741, 0.0309413187181703, 0.0143569748225322, 0.00693928545290556, 0.00135914851834492, 0.59269144390675, 0.517917221384721, 0.456902886405764, 0.405327421204478, 0.360251537992232, 0.319685291504111, 0.2821678384209, 0.246496132463732, 0.211596523966543, 0.176602222829402, 0.141397972727901, 0.106937786396409, 0.074857293389538, 0.0462908166605391, 0.0215205174484394, 0.0104071747947454, 0.00203767706388774, 0.7329606486157, 0.655211639338903, 0.58671706096299, 0.525770503418055, 0.470570307907467, 0.419573011635009, 0.371434023729475, 0.324886123523844, 0.278750785874155, 0.232309518692667, 0.185933156371724, 0.140978784025336, 0.0990680854456504, 0.0615175707971032, 0.0286670029088598, 0.0138724303903627, 0.00270395845154656, 0.838142578217343, 0.767730556629544, 0.699387193072486, 0.634346095207951, 0.572568000770374, 0.513428073110924, 0.456016815864827, 0.399237447140644, 0.342164056355244, 0.284798223846443, 0.228151639956042, 0.173628819918976, 0.122674652213850, 0.0765638152109311, 0.0358016086121755, 0.0173352283908648, 0.00338423605633909, 0.910915214306239, 0.854269872890404, 0.792380659464175, 0.728324327412515, 0.663641470500817, 0.598766118303959, 0.533390833007157, 0.466958108675312, 0.399718402638334, 0.332810169846175, 0.267433026630897, 0.204649764654678, 0.145582752525226, 0.0913961065988931, 0.0429028274899118, 0.020794938239074, 0.00406246779657053, 0.956099620177616, 0.915101008891389, 0.863494586547946, 0.804340589970156, 0.739811913292119, 0.670992067490536, 0.598508014750714, 0.523938483324114, 0.449119649196786, 0.375320171482798, 0.303334211640076, 0.233819259537015, 0.167632931803862, 0.105970645511562, 0.0499759998221642, 0.0242509183116936, 0.00473892214395428, 0.979153629182453, 0.95106168789293, 0.909673941239617, 0.85602448791855, 0.791828629762055, 0.720369142925193, 0.644748722301942, 0.567214164881931, 0.489279988980024, 0.411880943403833, 0.335605401995838, 0.260987626602552, 0.188786833912991, 0.120269390643364, 0.0570145517746277, 0.0277025095388299, 0.00541534338063891, 0.984833720280198, 0.96124832221758, 0.92402252050786, 0.87419335313835, 0.81415246030398, 0.746626535051091, 0.674063099101783, 0.598388680797427, 0.520979416823626, 0.442739494396008, 0.364272193075271, 0.286088382456793, 0.208957354222478, 0.1342789733294, 0.0640144100029874, 0.0311490271069919, 0.00609172639474771, 0.984831521754346, 0.96178750287388, 0.925815277018118, 0.877909786944586, 0.820184465666658, 0.75503191854508, 0.684592921700776, 0.610570901457792, 0.534175805219629, 0.456236240234657, 0.377306837254648, 0.297867095171864, 0.218666685919607, 0.141143940005886, 0.0674987199592513, 0.0328701597273591, 0.00642990194045459), .Dim = as.integer(c(17, 21))), alpha = c(0.5, 0.6, 0.7, 0.8, 0.9, 1, 1.1, 1.2, 1.3, 1.4, 1.5, 1.6, 1.7, 1.8, 1.9, 1.95, 1.99), beta = c(-0.95, -0.9, -0.8, -0.7, -0.6, -0.5, -0.4, -0.3, -0.2, -0.1, 0, 0.1, 0.2, 0.3, 0.4, 0.5, 0.6, 0.7, 0.8, 0.9, 0.95)), .Names = c("Phi1", "Phi2", "alpha", "beta") ) # ------------------------------------------------------------------------------ .qStableFit <- function(x, doplot = TRUE, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Estimates stable parameters by McCulloch's approach # Note: # This implementation assumes delta=1 and gamma=0 # FUNCTION: # Settings: CALL = match.call() # Load Contour Table: # data(PhiStable) Phi1 = .PhiStable$Phi1 Phi2 = .PhiStable$Phi2 alpha = .PhiStable$alpha beta = .PhiStable$beta # Estimate phi: r = sort(x) N = length(r) q95 = r[round(0.95*N)] q75 = r[round(0.75*N)] q50 = r[round(0.50*N)] q25 = r[round(0.25*N)] q05 = r[round(0.05*N)] phi1 = max( (q95-q05) / (q75-q25), 2.4389 ) phi2 = ((q95-q50)-(q50-q05)) / (q95-q05) # print(c(min(Phi1), phi1, max(Phi1))) # print(c(min(Phi2), phi2, max(Phi2))) # Plot: if (doplot) { contour(alpha, beta, Phi1, levels = c(2.5, 3, 5, 10, 20, 40), xlab = "alpha", ylab = "beta", xlim = c(0.5, 2.0)) contour(alpha, beta, Phi2, levels = c(-0.8, -0.6, -0.4, -0.2, 0.2, 0.4, 0.6, 0.8), col = "red", add = TRUE) lines(c(0.5, 2), c(0, 0), col = "red") contour(alpha, beta, Phi1, levels = phi1, add = TRUE, lty = 3, col = "blue") contour(alpha, beta, Phi2, levels = phi2, add = TRUE, lty = 3, col = "blue") title(main = "Stable Quantiles") } # Extract Estimate from Contours, if possible: u = contourLines(alpha, beta, Phi1, levels = phi1) Len = length(u) if( Len > 0) { u = u[[1]][-1] v = contourLines(alpha, beta, Phi2, levels = phi2) # print("v") # print(v) v = v[[1]][-1] xout = seq(min(v$y), max(v$y), length = 200) z = approx(v$y, v$x, xout = xout)$y - approx(u$y, u$x, xout = xout)$y index = which.min(abs(z)) V = round(xout[index], 3) U = round(approx(v$y, v$x, xout = xout[index])$y, 3) if (doplot) points(U, V, pch = 19, cex = 1) } else { U = V = NA } # Add Title and Description: if (is.null(title)) title = "Stable Parameter Estimation" if (is.null(description)) description = description() if (is.na(U) | is.na(V)) { GAM = NA } else { phi3 = stabledist::qstable(0.75, U, V) - stabledist::qstable(0.25, U, V) GAM = (q75-q25) / phi3 } if (is.na(U) | is.na(V)) { DELTA = NA } else { phi4 = -stabledist::qstable(0.50, U, V) + V*tan(pi*U/2) DELTA = phi4*GAM - V*GAM*tan(pi*U/2) + q50 } # Fit: fit = list(estimate = c(alpha = U, beta = V, gamma = GAM, delta = DELTA)) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Stable Distribution", data = as.data.frame(x), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .mleStableFit <- function(x, alpha = 1.75, beta = 0, gamma = 1, delta = 0, doplot = TRUE, control = list(), trace = FALSE, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Estimates stable parameters by MLE approach # Note: # This implementation assumes delta=1 and gamma=0 # FUNCTION: # Transform: x.orig = x x = as.vector(x) # Settings: CALL = match.call() # Log-likelihood Function: obj = function(x, y = x, trace = FALSE) { f = -mean(log(stabledist::dstable(y, alpha = x[1], beta = x[2], gamma = x[3], delta = x[4]))) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Stable Estimate: ", x) cat("\n") } f } # Minimization: eps = 1e-4 r <- nlminb( objective = obj, start = c(alpha, beta, gamma, delta), lower = c( eps, -1+eps, 0+eps, -Inf), upper = c(2-eps, 1-eps, Inf, Inf), y = x, control = control, trace = trace) alpha = r$par[1] beta = r$par[2] gamma = r$par[3] delta = r$par[4] # Optional Plot: if (doplot) .stablePlot(x, alpha, beta, gamma, delta) # Add Title and Description: if (is.null(title)) title = "Stable Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list(estimate = c(alpha, beta, gamma, delta), minimum = -r$objective, code = r$convergence, gradient = r$gradient) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Stable Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .stablePlot <- function(x, alpha, beta, gamma, delta) { # A function implemented by Diethelm Wuertz # Description: # Estimates stable parameters by MLE approach # FUNCTION: # Plot: span.min <- stabledist::qstable(0.01, alpha, beta, gamma, delta) span.max <- stabledist::qstable(0.99, alpha, beta, gamma, delta) span = seq(span.min, span.max, length = 100) par(err = -1) z = density(x, n = 100) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = stabledist::dstable(span, alpha, beta, gamma, delta) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)") title("Stable Distribution: Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") grid() # Return Value: invisible() } ################################################################################ fBasics/R/dist-snig.R0000644000176200001440000000750313202116742014054 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dsnig Returns density of the SNIG distribution # psnig Returns probabilities of the SNIG distribution # qsnig Returns quantiles of the SNIG distribution # rsnig Generates SNIG distributed random variates # FUNCTION: DESCRIPTION: # .psnigC Fast psnig from C code # .qsnigC Fast qsnig from C code ################################################################################ dsnig <- function(x, zeta = 1, rho = 0, log = FALSE) { # Description: # Returns density of the snig distribution # FUNCTION: # Parameters: if (length(zeta) == 2) { rho = zeta[2] zeta = zeta[1] } # Compute Density - Quick and Dirty: ans = dsgh(x, zeta, rho, lambda = -0.5, log = log) # Log: if(log) ans = log(ans) # Return Value: ans } # ------------------------------------------------------------------------------ psnig <- function(q, zeta = 1, rho = 0) { # Description: # Returns probabilities of the snig distribution # FUNCTION: # Compute Probabilities - Quick and Dirty: ans = psgh(q, zeta, rho, lambda = -0.5) # Return Value: ans } # ------------------------------------------------------------------------------ qsnig <- function(p, zeta = 1, rho = 0) { # Description: # Returns quantiles of the snig distribution # FUNCTION: # Compute Quantiles: ans = qsgh(p, zeta, rho, lambda = -0.5) # Return Value: ans } # ------------------------------------------------------------------------------ rsnig <- function(n, zeta = 1, rho = 0) { # Description: # Generates snig distributed random variates # FUNCTION: # Generate Random Numbers: ans = rsgh(n, zeta, rho, lambda = -0.5) # Return Value: ans } ################################################################################ .psnigC <- function(q, zeta = 1, rho = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of the snig distribution # FUNCTION: # Compute Quantiles: param = .paramGH(zeta, rho, lambda = -0.5) ans = .pnigC(q, param[1], param[2], param[3], param[4]) # Return Value: ans } # ------------------------------------------------------------------------------ .qsnigC <- function(p, zeta = 1, rho = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of the snig distribution # FUNCTION: # Compute Quantiles: param = .paramGH(zeta, rho, lambda = -0.5) ans = .qnigC(p, param[1], param[2], param[3], param[4]) # Return Value: ans } ################################################################################ fBasics/R/builtin-testNortest.R0000644000176200001440000000166013202116742016153 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # testNortest ################################################################################ fBasics/R/dist-ssdFit.R0000644000176200001440000000420013202116741014336 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTIONS: DESCRIPTION # ssdFit Estimate probability densities using smoothing spline ANOVA # .print.ssd S3 Print Method ################################################################################ ssdFit <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Estimate probability densities using smoothing spline ANOVA # models with cubic spline, linear spline, or thin-plate spline # marginals for numerical variables. # FUNCTION: # Parameter Fit: ans <- gss::ssden(~x) # Return Value: ans } # ------------------------------------------------------------------------------ .print.ssd <- function(x, ...) { # A function implemented by Diethelm Wuertz # Description: # FUNCTION: # call cat("\nCall:\n", deparse(x$call), "\n\n", sep = "") # Terms: cat("Terms:\n") print.default(x$terms$labels) cat("\n") # terms overview cat("Number of unpenalized and penalized terms:\n\n") print.default(x$desc) cat("\n") cat("Smoothing parameters are selected by CV with alpha=", x$alpha, ".", sep = "") cat("\n") # the rest are suppressed invisible() } ################################################################################ fBasics/R/dist-nigMoments.R0000644000176200001440000001246713202116742015241 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # nigMean Returns true NIG mean # nigVar Returns true NIG variance # nigSkew Returns true NIG skewness # nigKurt Returns true NIG kurtosis # FUNCTION: DESCRIPTION: # nigMoments Returns true NIG moments # FUNCTION: DESCRIPTION: # nigShapeTriangle Plots NIG Shape Triangle ################################################################################ nigMean <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG mean # FUNCTION: # Mean: gamma = sqrt(alpha^2 - beta^2) ans = c(mean = (mu + delta * beta / gamma)[[1]]) # Return Value: ans } # ------------------------------------------------------------------------------ nigVar <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG variance # FUNCTION: # Variance: gamma = sqrt(alpha^2 - beta^2) ans = c(var = (delta * alpha^2 / gamma^3)[[1]]) # Return Value: ans } # ------------------------------------------------------------------------------ nigSkew <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG skewness # FUNCTION: # Skewness: gamma = sqrt(alpha^2 - beta^2) ans = c(skew = (3*beta / ( alpha * sqrt(delta*gamma) ))[[1]] ) # Return Value: ans } # ------------------------------------------------------------------------------ nigKurt <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true NIG kurtosis # FUNCTION: # Skewness: gamma = sqrt(alpha^2 - beta^2) ans = c(kurt = (3 * ( 1 + 4 * beta^2 / alpha^2) / (delta * gamma))[[1]]) # Return Value: ans } ############################################################################### nigMoments <- function(order, type = c("raw", "central", "mu"), alpha=1, beta=0, delta=1, mu=0) { # A function implemented by Diethelm Wuertz # Descriptions: # Returns true moments of the NIG distribution # FUNCTION: # Settings: type = match.arg(type) # Moments: lambda = -1/2 if (type == "raw") { ans = .ghRawMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "central") { ans = .ghCentralMoments(order, alpha, beta, delta, mu, lambda) } else if (type == "central") { ans = .ghMuMoments(order, alpha, beta, delta, mu, lambda) } # Return Value: ans } ################################################################################ nigShapeTriangle <- function(object, add = FALSE, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Plots NIG Shape Triangle # Arguments: # object - an object of class 'fDISTFIT' as returned by the # function nigFit() # Example: # nigShapeTriangle(nigFit(rnig(100), doplot = FALSE)) # FUNCTION: # Settings: stopifnot(class(object) == "fDISTFIT") # Plot Frame: if (labels) { xlab = "Asymmetry: chi" ylab = "Steepness: zeta" main = "NIG Shape Traingle" } else { xlab = ylab = main = "" } if (!add) { x = c(-1, 0, 1, -1) y = c( 1, 0, 1, 1) plot(x, y, type = "l", xlab = xlab, ylab = ylab, main = main, ...) for (s in c(0.8, 0.6, 0.4, 0.2)) lines(c(-s, s), c(s, s), lty = 3, col = "grey") lines(c(0, 0), c(0, 1), lty = 3, col = "grey") } # Transform: par = object@fit$estimate names(par) = c("alpha", "beta", "delta", "mu") alpha = par[1] beta = par[2] delta = par[3] mu = par[4] # Add Points: zeta = 1/sqrt(1+delta*sqrt(alpha^2-beta^2)) chi = zeta*(beta/alpha) if (labels) { points(chi, zeta, pch = 19, ...) } else { points(chi, zeta, ...) } # Result: ans = list(chi = chi[[1]], zeta = zeta[[1]]) attr(ans, "control")<-par # Return Value: ans } ################################################################################ fBasics/R/dist-hypRobMoments.R0000644000176200001440000001015413202116742015716 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # hypMED Returns true hyp median # hypIQR Returns true hyp inter quartal range # hypSKEW Returns true hyp robust skewness # hypKURT Returns true hyp robust kurtosis ################################################################################ hypMED <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh median # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Median Q = qgh(p=0.5, alpha, beta, delta, mu, lambda=1) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ hypIQR <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh inter quartal range # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Inter Quartile Range Q = numeric() Q[1] = qgh(p=0.25, alpha, beta, delta, mu, lambda=1) Q[2] = qgh(p=0.75, alpha, beta, delta, mu, lambda=1) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ hypSKEW <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh skewness # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Robust Skewness: Q = numeric() Q[1] = qgh(p=0.25, alpha, beta, delta, mu, lambda=1) Q[2] = qgh(p=0.50, alpha, beta, delta, mu, lambda=1) Q[3] = qgh(p=0.75, alpha, beta, delta, mu, lambda=1) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ hypKURT <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns true gh robust gh kurtosis # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # gh Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, qgh(p, alpha, beta, delta, mu, lambda=1)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/matrix-pdl.R0000644000176200001440000000442713202116741014235 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # pdl Regressor matrix for polynomial distributed lags ################################################################################ pdl <- function(x, d = 2, q = 3, trim = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Regressor matrix for polynomial distributed lags # Aruments: # x - a numeric vector. # d - an integer specifying the order of the polynomial. # q - an integer specifying the number of lags to use in # creating polynomial distributed lags. This must be # greater than d. # trim - a logical flag; if TRUE, the missing values at # the beginning of the returned matrix will be trimmed. # Value: # Returns a matrix representing the regressor matrix. # Example: # stack.loss = c( # 42, 37, 37, 28, 18, 18, 19, 20, 15, 14, 14, # 13, 11, 12, 8, 7, 8, 8, 9, 15, 15) # pdl(stack.loss) # FUNCTION: # Check: stopifnot(q > d) # Polynomial distributed lags: M = tslag(x, 1:q, FALSE) C = NULL for (i in 0:d) { C = rbind(C, (1:q)^i) } Z = NULL for (i in 1:(d+1)) { Z = cbind(Z, apply(t(C[i,]*t(M)), 1, sum)) } Z[, 1] = Z[, 1] + x # Trim: if (trim) { indexes = (1:length(Z[,1]))[!is.na(apply(Z, 1, sum))] Z = Z[indexes, ] } # Return Value: Z } ################################################################################ fBasics/R/matrix-pascal.R0000644000176200001440000000376313202116741014723 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # pascal Creates a Pascal matrix ################################################################################ pascal <- function(n) { # A function implemented by Diethelm Wuertz # Description: # Creates a Pascal matrix # Arguments: # n - the dimension of the square matrix # Details: # http://mathworld.wolfram.com/PascalMatrix.html # Pascal matrices are symmetric and positive definite. # The determinant of a Pascal matrix is 1. # The inverse of a Pascal matrix has integer entries. # If lambda is an eigenvalue of a Pascal matrix, # then 1/lambda is also an eigenvalue of the matrix. # The Cholesky factor of a Pascal matrix consists of # the elements of Pascal's triangle # FUNCTION: # Pascal: N = n-1 n.over.r = function(n, r) { prod(1:n) / (prod(1:(n-r)) * prod(1:r) ) } X = rep(1, N) for ( i in 1:N ) for ( j in 1:N ) X = c(X, n.over.r(i+j, j)) X = cbind(rep(1, N+1), matrix(X, byrow = TRUE, ncol = N)) # Return Value: X } ################################################################################ fBasics/R/utils-getS4.R0000644000176200001440000001036313202116742014275 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR Description. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # getCall Extracts the call slot from a S4 object # getModel Extracts the model slot from a S4 object # getTitle Extracts the title slot from a S4 object # getDescription Extracts the description slot from a S4 object # getSlot Extracts a specified slot from a S4 object # getArgs Shows the arguments of a S4 functiong ################################################################################ if(getRversion() < "2.14") { getCall <- function(x) slot(x, "call") } ## since 2.14.0, getCall() is an S3 generic in 'stats' ## *AND* its default method also works for S4 and a "call" slot # ------------------------------------------------------------------------------ getModel <- function(object) { # A function implemented by Tobias Setz # FUNCTION: # Return Value: UseMethod("getModel") } getModel.default <- function(object) { # A function implemented by Rmetrics # Description: # gets the "model" slot from an object of class 4 # Arguments: # object - an object of class S4 # FUNCTION: # Return Value: slot(object, "model") } # ------------------------------------------------------------------------------ getTitle <- function(object) { # A function implemented by Rmetrics # Description: # gets the "title" slot from an object of class 4 # Arguments: # object - an object of class S4 # FUNCTION: # Return Value: slot(object, "title") } # ------------------------------------------------------------------------------ getDescription <- function(object) { # A function implemented by Rmetrics # Description: # Extracts the "description" slot from an object of class 4 # Arguments: # object - an object of class S4 # FUNCTION: # Return Value: slot(object, "description") } # ------------------------------------------------------------------------------ getSlot <- function(object, slotName) { # a simple wrapper around slot to avoid compatibilty troubles with # other packages. # FUNCTION: slot(object, slotName) } # ------------------------------------------------------------------------------ getArgs <- function(f, signature = character()) { # A function implemented by Diethelm Wuertz # Description: # Shows the arguments of a S4 functiong # Arguments: # f - a generic function or the character-string name of one # signature - the signature of classes to match to the arguments # of f # Note: # such a function is missing in the methods package, # see, e.g he function getMethod() # FUNCTION: # Get arguments: fun <- getMethod(f, signature)@.Data test <- class(try(body(fun)[[2]][[3]], silent = TRUE)) if (test == "function") { ans <- args(body(fun)[[2]][[3]]) } else { ans <- args(fun) } cat(substitute(f), ",", paste(signature, collapse = ","), ":\n", sep = "") # Return Value: ans } ################################################################################ fBasics/R/builtin-varpieA2R.R0000644000176200001440000000165313202116742015412 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # varpie ################################################################################ fBasics/R/dist-gld.R0000644000176200001440000001246513202116742013665 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dgld Returns density for Generalized Lambda DF # pgld Returns probability for Generalized Lambda DF # qgld Returns quantiles for Generalized Lambda DF # rgld Returns random variates for Generalized Lambda DF ################################################################################ dgld <- function(x, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density for Generalized Lambda DF # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Details: # This a simple wrapper for the GLD using the RS parameterisation # in Region 4. The parameter range is restricted to negative lambda3 # and lambda4 parameters # Note: # Uses gld functions from package gld # Example: # dgld( (-25:25)/10 ) # FUNCTION: # Parameters: if (length(lambda1) == 4) { lambda4 = lambda1[4] lambda3 = lambda1[3] lambda2 = lambda1[2] lambda1 = lambda1[1] } # Check Parameters: stopifnot (lambda2 < 0) stopifnot (lambda3 < 0) stopifnot (lambda4 < 0) # Density: d = .dgld(x, lambda1=lambda1, lambda2=lambda2, lambda3=lambda3, lambda4=lambda4, param="rs") # Log: if(log) d = log(d) # Return Value: d } # ------------------------------------------------------------------------------ pgld <- function(q, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns probability for Generalized Lambda DF # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Note: # Uses gld functions from package gld # Example: # pgld( (-25:25)/10 ) # FUNCTION: # Check Parameters: stopifnot (lambda2 < 0) stopifnot (lambda3 < 0) stopifnot (lambda4 < 0) # Probability: p = .pgld(q, lambda1=lambda1, lambda2=lambda2, lambda3=lambda3, lambda4=lambda4, param="rs") # Return Value: p } # ------------------------------------------------------------------------------ qgld <- function(p, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles for Generalized Lambda DF # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Note: # Uses gld functions from package gld # Example: # qgld((1:99)/100) # FUNCTION: # Check Parameters: stopifnot (lambda2 < 0) stopifnot (lambda3 < 0) stopifnot (lambda4 < 0) # Quantiles: q = .qgld(p, lambda1=lambda1, lambda2=lambda2, lambda3=lambda3, lambda4=lambda4, param="rs") # Return Value: q } # ------------------------------------------------------------------------------ rgld <- function(n = 100, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) { # A function implemented by Diethelm Wuertz # Description: # Returns random variates for Generalized Lambda DF # Arguments: # lambda1 - a numeric value, the location parameter # lambda2 - a numeric value, the scale parameter # lambda3 - a numeric value, the first shape parameter # lambda4 - a numeric value, the second parameter # Note: # Uses gld functions from package gld # FUNCTION: # Check Parameters: stopifnot (lambda2 < 0) stopifnot (lambda3 < 0) stopifnot (lambda4 < 0) # Random Variates: r = .rgld(n, lambda1=lambda1, lambda2=lambda2, lambda3=lambda3, lambda4=lambda4, param="rs") # Return Value: r } ################################################################################ fBasics/R/dist-tFit.R0000644000176200001440000000634213202116742014022 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # tFit Fits parameters of a Student-t density ################################################################################ tFit <- function(x, df = 4, doplot = TRUE, span = "auto", trace = FALSE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Return Maximum log-likelihood estimated # Note: # Function Calls: nlminb(), density() # Example: # tFit(rt(1000, df=4)) # FUNCTION: # Transform: x.orig = x x = as.vector(x) # Settings: CALL = match.call() # Log-likelihood Function: obj = function(x, y = x, trace) { # Prevent from negative df's if (x[1] <= 0) x[1] = getRmetricsOptions(".x.save") f = -sum(log(dt(y, x[1]))) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Students df Estimate: ", x[1], "\n") } setRmetricsOptions(.x.save = x[1]) f } # Minimization: r = nlm(f = obj, p = c(df), y = x, trace = trace) # Optional Plot: if (doplot) { if (span == "auto") { df = r$estimate[1] span.min = qt(0.001, df) span.max = qt(0.999, df) span = seq(span.min, span.max, length = 100) } par(err = -1) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dt(span, df = r$estimate[1]) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("STUDENT-T: Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") if (exists("grid")) grid() } # Add Title and Description: if (is.null(title)) title = "Student-t Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list(estimate = c(df = r$estimate), minimum = -r$minimum, code = r$code, gradient = r$gradient) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Student-t Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } ################################################################################ fBasics/R/plot-scalinglawPlot.R0000644000176200001440000000734413202116742016115 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # scalinglawPlot Evaluates and displays scaling law behavior ################################################################################ scalinglawPlot <- function(x, span = ceiling(log(length(x)/252)/log(2)), doplot = TRUE, labels = TRUE, trace = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Investigates the scaling law. # The input "x" requires log-returns. # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Labels: if (labels) { main = "Scaling Law Plot" xlab = "log-time" ylab = "log-volatility" } else { main = xlab = ylab = "" } X = x DIM = dim(X)[2] Intercept = Exponent = InverseExponent = NULL for (i in 1:DIM) { # Get Data: x = as.vector(as.matrix(X)[, i]) if (labels) main = Units[i] # Settings: logtimesteps = span xmean = mean(x) # x have to be logarithmic returns y = (x-xmean) logprices = cumsum(y) # Scaling Power Low: scale = function(nx, logprices) { sum(abs(diff(logprices, lag = (2^nx))))} nx = 0:logtimesteps; x = nx*log(2) y = log(apply(matrix(nx), 1, scale, logprices)) # fit = lsfit(x, y)$coefficients # Runs in both environments, R and SPlus: fit = lsfit(x, y) # Robust Fit: # fit = l1fit(x, y) # Fit Result: Fit = unlist(fit)[1:2] alpha = 1.0/Fit[2] if (doplot) { plot(x, y, main = main, xlab = xlab, ylab = ylab, ...) abline(Fit[1], Fit[2]) abline(Fit[1], 0.5, col = "steelblue") } if (labels) grid() # Trace: if (trace) { cat ("\nScaling Law: ", Units[i]) cat ("\n Plot Intercept ", fit$coefficients[1]) cat ("\n Plot Slope ", fit$coefficients[2]) cat ("\n Plot Inverse Slope ", 1/fit$coefficients[2]) cat ("\n\n") } Intercept = c(Intercept, fit$coefficients[1]) Exponent = c(Exponent, fit$coefficients[2]) InverseExponent = c(InverseExponent, 1/fit$coefficients[2]) } names(Intercept) = Units names(Exponent) = Units names(InverseExponent) = Units result = list( Intercept = Intercept, Exponent = Exponent, InverseExponent = InverseExponent) # Return Value: invisible(result) } ################################################################################ fBasics/R/dist-sghFit.R0000644000176200001440000001031613202116741014333 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: GENERALIZED DISTRIBUTION: # sghFit Fits parameters of a standardized GH density ################################################################################ sghFit <- function(x, zeta = 1, rho = 0, lambda = 1, include.lambda = TRUE, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { x.orig = x x = as.vector(x) if (scale) x = (x-mean(x)) / sd(x) eps = .Machine$double.eps^0.5 BIG = 1000 if (include.lambda) { # LLH Function: obj.include = function(x, y = x, trace) { f = -sum(log(dsgh(y, x[1], x[2], x[3], log = FALSE))) if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], "\n") } f } # LLH Optimization: r = nlminb( start = c(zeta, rho, lambda), objective = obj.include, lower = c(eps, -0.9999, -2), upper = c(BIG, +0.9999, +5), y = x, trace = trace) names(r$par) <- c("zeta", "rho", "lambda") } else { # LLH Function: obj = function(x, y = x, lambda, trace) { f = -sum(log(dsgh(y, x[1], x[2], lambda, log = FALSE))) if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x[1], x[2], "\n") } f } # LLH Optimization: r = nlminb( start = c(zeta, rho), objective = obj, lower = c(eps, -0.9999), upper = c(BIG, +0.9999), y = x, lambda = lambda, trace = trace) r$par = c(r$par, lambda) names(r$par) <- c("zeta", "rho", "fix.lambda") } param = .paramGH(r$par[1], r$par[2], r$par[3]) if (trace) { cat("\n Standardized Parameters:", "\n ") print(r$par) names(param) = c("alpha", "beta", "delta", "mu") cat("\n 1st Parameterization:", "\n ") print(param) } # Default Title and Description: if (is.null(title)) title = "SGH Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list( estimate = r$par, minimum = -r$objective, code = r$convergence, param = param, mean = mean(x.orig), var = var(x.orig)) # Optional Plot: if (doplot) { if (span == "auto") span = seq(min(x), max(x), length = 101) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dsgh(span, zeta = r$par[1], rho = r$par[2], lambda) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main = title) lines(x = span, y = log(y.points), col = "steelblue") } # Return Value: new("fDISTFIT", call = match.call(), model = "Standarized GH Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description()) } ################################################################################ fBasics/R/matrix-kron.R0000644000176200001440000000241213202116742014420 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # LINEAR ALGEBRA: DESCRIPTION: # kron Returns the Kronecker product ################################################################################ kron <- function(x, y) { # A function implemented by Diethelm Wuertz # Description: # Returns the Kronecker product # FUNCTION: # Kronecker Product: ans = x %x% y # Return Value: ans } ################################################################################ fBasics/R/test-locationTest.R0000644000176200001440000001670113202116742015600 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: LOCATION TESTS: # locationTest Performs locations tests on two samples # .tTest Unpaired t test for differences in mean # .kw2Test Kruskal-Wallis test for differences in locations ################################################################################ locationTest <- function(x, y, method = c("t", "kw2"), title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Correlation Tests # FUNCTION: # Test: method = match.arg(method) if (method == "t") { ans = .tTest(x, y, title = title, description = description) } if (method == "kw2") { ans = .kw2Test(x, y, title = title, description = description) } # Return Value: ans } # ------------------------------------------------------------------------------ .tTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Tests if two population means are equal. # Arguments: # x, y - two numeric vector of data values or time series objects # description - a brief description of the porject of type character. # title - a character string which allows for a project title. # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Asymptotic Test: two.sided = t.test(x = x, y = y, alternative = "two.sided", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) less = t.test(x = x, y = y, alternative = "less", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) greater = t.test(x = x, y = y, alternative = "greater", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) # Assume Equal Variances: two.sided.equal = t.test(x = x, y = y, alternative = "two.sided", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) less.equal = t.test(x = x, y = y, alternative = "less", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) greater.equal = t.test(x = x, y = y, alternative = "greater", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) # Sample Estimates: PARAMETER = c(length(x), length(y), 0) names(PARAMETER) = c( "x Observations", "y Observations", "mu") test$parameter = PARAMETER # Sample Estimates: ESTIMATE = c(two.sided$estimate, var(x), var(y)) names(ESTIMATE) = c("Mean of x", "Mean of y", "Var of x", "Var of y") test$estimate = ESTIMATE # P Values: PVAL = c( two.sided$p.value, less$p.value, greater$p.value, two.sided.equal$p.value, less.equal$p.value, greater.equal$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater", "Alternative Two-Sided | Equal Var", "Alternative Less | Equal Var", "Alternative Greater | Equal Var") test$p.value = PVAL # Statistic: STATISTIC = c( two.sided$statistic, two.sided.equal$statistic) names(STATISTIC) = c( " T", "T | Equal Var") test$statistic = STATISTIC # Confidence Intervals: CONF.INT = cbind( a = two.sided$conf.int, b = less$conf.int, c = greater$conf.int, d = two.sided.equal$conf.int, e = less.equal$conf.int, f = greater.equal$conf.int) # For Splus compatibility use named a CONF.INT # and dimnames instead of colnames! dimnames(CONF.INT)[[2]] = c( "Two-Sided", " Less", " Greater", "Two-Sided | Equal Var", " Less | Equal Var", " Greater | Equal Var") test$conf.int = CONF.INT # Add: if (is.null(title)) title = "t Test" if (is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ .kw2Test <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs a Kruskal-Wallis rank sum test of the null that # the location parameters of the distribution of x are the # same in each group (sample). The alternative is that they # differ in at least one. # Arguments: # x, y - two numeric vector of data values or time series objects # description - a brief description of the porject of type character. # title - a character string which allows for a project title. # Note: # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) # Sample Estimates: ESTIMATE = c(mean(x), mean(y), var(x), var(y)) names(ESTIMATE) = c("Mean of x", "Mean of y", "Var of x", "Var of y") test$estimate = ESTIMATE # Parameter: PARAMETER = c(length(x), length(y)) names(PARAMETER) = c( "x Observations", "y Observations") test$parameter = PARAMETER # Operate on Lists: x = list(x = x, y = y) if (length(x) < 2) stop("x must be a list with at least 2 elements") k = length(x) l = sapply(x, "length") g = factor(rep(1 : k, l)) x = unlist(x) # Test: n = length(x) if (n < 2) stop("not enough observations") r = rank(x) TIES = table(x) # Statistic: STATISTIC = sum(tapply(r, g, "sum")^2 / tapply(r, g, "length")) STATISTIC = ((12 * STATISTIC / (n * (n + 1)) - 3 * (n + 1)) / (1 - sum(TIES^3 - TIES) / (n^3 - n))) names(STATISTIC) = "KW chi-squared" test$statistic = STATISTIC # P Value: PVAL = 1 - pchisq(STATISTIC, 1) names(PVAL) = "" test$p.value = PVAL # Add: if(is.null(title)) title = "Kruskal-Wallis Two Sample Test" if(is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/R/utils-colorTable.R0000644000176200001440000000344113202116742015374 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # colorTable Shows a table of plot color codes ################################################################################ colorTable <- function(cex = 0.7) { # A function implemented by Diethelm Wuertz # Description: # Displays a table of plot colors. # Author: # Unknown, piece of code found on the internet. # Example: # colorTable() # FUNCTION: # Plot: plot(0, 0, xlim = c(-1, 10), ylim = c(0, 10), type = 'n', axes = FALSE, xlab = '', ylab = '', cex = cex, main = "Table of Color Codes") ## DW ## j = -1 j = -2 ## here I have shifted the plot to the left ... DW for(i in 0:99) { if(i %% 10 == 0) {j = j+1; k = 10} k = k-1 points(j, k, pch = 15, col = i, cex = 2) text(j+0.45, k, i, cex = cex)} # Return Value: invisible() } ################################################################################ fBasics/R/dist-distCheck.R0000644000176200001440000001060513202116741015011 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # distCheck Checks consistency of distributions ################################################################################ distCheck <- function(fun = "norm", n = 1000, robust = TRUE, subdivisions = 100, ...) { # A function implemented by Diethelm Wuertz # Description: # Checks consistency of distributions # Arguments: # fun - a character string denoting the name of the distribution # n - an integer specifying the number of random variates to be # generated # robust - a logical flag, should robust estimates be used? By # default \code{TRUE} # subdivisions - an integer specifying the numbers of subdivisions # in integration __ NB: only used in one place, *not* in the other.. hmm # ... - the distributional parameters and passed to integrate() ### FIXME (MM): add args.integrate = list() to be passed to integrate(), ### ----- and pass the others to distrib.functions # Examples: # .distCheck("norm", mean = 1, sd = 1) # .distCheck("t", df = 4) # .distCheck("exp", rate = 2) # .distCheck("weibull", shape = 1) # FUNCTION: # Distribution Functions: cat("\nDistribution Check for:", fun, "\n ") CALL = match.call() cat("Call: ") cat(paste(deparse(CALL), sep = "\n", collapse = "\n"), "\n", sep = "") dfun = match.fun(paste("d", fun, sep = "")) pfun = match.fun(paste("p", fun, sep = "")) qfun = match.fun(paste("q", fun, sep = "")) rfun = match.fun(paste("r", fun, sep = "")) # Range: xmin = qfun(p = 0.01, ...) xmax = qfun(p = 0.99, ...) # Check 1 - Normalization: NORM = integrate(dfun, lower = -Inf, upper = Inf, subdivisions = subdivisions, stop.on.error = FALSE, ...) cat("\n1. Normalization Check:\n NORM ") print(NORM) normCheck = (abs(NORM[[1]]-1) < 0.01) # Check 2: cat("\n2. [p-pfun(qfun(p))]^2 Check:\n ") p = c(0.001, 0.01, 0.1, 0.5, 0.9, 0.99, 0.999) P = pfun(qfun(p, ...), ...) pP = round(rbind(p, P), 3) print(pP) RMSE = sd(p-P) print(c(RMSE = RMSE)) rmseCheck = (abs(RMSE) < 0.0001) # Check 3: cat("\n3. r(", n, ") Check:\n", sep = "") r = rfun(n = n, ...) if (!robust) { SAMPLE.MEAN = mean(r) SAMPLE.VAR = var(r) } else { robustSample = MASS::cov.mcd(r, quantile.used = floor(0.95*n)) SAMPLE.MEAN = robustSample$center SAMPLE.VAR = robustSample$cov[1,1] } SAMPLE = data.frame(t(c(MEAN = SAMPLE.MEAN, "VAR" = SAMPLE.VAR)), row.names = "SAMPLE") print(signif(SAMPLE, 3)) fun1 = function(x, ...) { x * dfun(x, ...) } fun2 = function(x, M, ...) { x^2 * dfun(x, ...) } MEAN = integrate(fun1, lower = -Inf, upper = Inf, subdivisions = 5000, stop.on.error = FALSE,...) cat(" X ") print(MEAN) VAR = integrate(fun2, lower = -Inf, upper = Inf, subdivisions = 5000, stop.on.error = FALSE, ...) cat(" X^2 ") print(VAR) EXACT = data.frame(t(c(MEAN = MEAN[[1]], "VAR" = VAR[[1]] - MEAN[[1]]^2)), row.names = "EXACT ") print(signif(EXACT, 3)) meanvarCheck = (abs(SAMPLE.VAR-EXACT$VAR)/EXACT$VAR < 0.1) cat("\n") # Done: ans = list( normCheck = normCheck, rmseCheck = rmseCheck, meanvarCheck = meanvarCheck) # Return Value: unlist(ans) } # ------------------------------------------------------------------------------ .distCheck <- distCheck # Keep for older Rmetrics Versions ################################################################################ fBasics/R/dist-ghtFit.R0000644000176200001440000000711713202116742014342 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghtFit Fits parameters of a generalized hyperbolic density ################################################################################ ghtFit <- function(x, beta = 0.1, delta = 1, mu = 0, nu = 10, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a generalized hyperbolic density # Example: # x = rght(10000); ghtFit(x, 0.2, 0.8, mean(x), 8) # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Log-likelihood Function: obj <- function(x, y = x, trace){ if (NA %in% x) return(1e99) ## if (abs(x[2]) >= x[1]) return(1e99) f = -sum(log(dght(y, x[1], x[2], x[3], x[4]))) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x, "\n") } f } # Variable Transformation and Minimization: eps = 1e-10 BIG = 1000 f = obj(x = c(beta, delta, mu, nu), y = x, trace = FALSE) r = nlminb(start = c(beta, delta, mu, nu), objective = obj, lower = c(-BIG, eps, -BIG, -BIG), upper = BIG, y = x, trace = trace) names(r$par) <- c("beta", "delta", "mu", "nu") # Result: if (scale) { r$par = r$par / c(SD, 1/SD, 1/SD, 1) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 51) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dght(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("GHT Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } # Add Title and Description: if (is.null(title)) title = "Generalized Hyperbolic Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list( estimate = r$par, minimum = -r$objective, code = r$convergence) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Generalized Hyperbolic Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } ################################################################################ fBasics/R/dist-norm.R0000644000176200001440000000251213202116742014062 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dnorm Returns density of the normal distribution # pnorm Returns probabilities of mormal distribution # qnorm Returns quantiles of the normal distribution # rnorm Generates normal distributed random variates ################################################################################ ## The functions are part of R's base package ################################################################################ fBasics/R/stats-interpAkima.R0000644000176200001440000001261213202116741015547 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # akimaInterp Interpolates irregularly spaced points # akimaInterpp Interpolates and smoothes pointwise ################################################################################ akimaInterp <- function(x, y = NULL, z = NULL, gridPoints = 21, xo = seq(min(x), max(x), length = gridPoints), yo = seq(min(y), max(y), length = gridPoints), extrap = FALSE) { # A function implemented by Diethelm Wuertz ### ==> ../man/stats-interpAkima.Rd ### ~~~~~~~~~~~~~~~~~~~~ # Description: # Interpolates and Smoothes Irregularly Distributed Data Points # Arguments: # x, y, z - either three numeric vectors of equal length or if # y and z are NULL, a list with entries x, y, a, or named # data.frame with x in the first, y in the second, and z in # the third column. # gridPoints - number of grid points in x and y direction. # xo, yo, a sequence of data points spanning the grid # extrap - a logical, if TRUE then the data points are extrapolated.\ # Value: # A list with three elements, $x and $y which are vectors of length # 'gridPoints' and $z which is a matrix of size 'gridPoints^2'. # Example: # set.seed(1953) # x = runif(999)-0.5; y = runif(999)-0.5; z = cos(2*pi*(x^2+y^2)) # ans = akimaInterp(x, y, z, extrap = FALSE) # persp(ans, theta = -50, phi = 30, col = "steelblue") # ans = akimaInterp(x, y, z, extrap = TRUE) # persp(ans, theta = -50, phi = 30, col = "steelblue") # FUNCTION: if (!requireNamespace("akima", quietly = TRUE)) stop("Needs Package 'akima' which is not auto-installed because of a different licence\n") # Arguments: if (is.data.frame(x)) x <- as.matrix.data.frame(x) else if (is.list(x)) x <- matrix(unlist(x), ncol = 3) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } # Interpolation: ans <- akima::interp(x, y, z, xo, yo, linear = FALSE, extrap = extrap, duplicate = "median", dupfun = NULL) colnames(ans$z) <- as.character(signif(ans$x, round(log(gridPoints), 0))) rownames(ans$z) <- as.character(signif(ans$y, round(log(gridPoints), 0))) class(ans) <- "gridData" # Return Value: ans } # ------------------------------------------------------------------------------ akimaInterpp <- function(x, y = NULL, z = NULL, xo, yo, extrap = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Interpolates and Smoothes Irregularly Distributed Data Points # Arguments: # x, y, z - either three numeric vectors of equal length or if # y and z are NULL, a list with entries x, y, a, or named # data.frame with x in the first, y in the second, and z in # the third column. # gridPoints - number of grid points in x and y direction. # xo, yo, a sequence of data points for pointwise interpolation # Note: # Extrapolation is not possible in the case of linear interpolation. # Value: # A list with three elements, $x and $y which are vectors of length # 'gridPoints' and $z which is a matrix of size 'gridPoints^2'. # Requirements: # akima Builtin Fortran Code. # Example: # set.seed(1953) # x = runif(999)-0.5; y = runif(999)-0.5; z = cos(2*pi*(x^2+y^2)) # ans = akimaInterpp(x, y, z, c(mean(x), 0, 100), c(mean(y), 0, 100)) # persp(ans, theta = -50, phi = 30, col = "steelblue") # Note: # Uses Fortran akima Builtin # FUNCTION: if (!requireNamespace("akima", quietly = TRUE)) stop("Needs package 'akima' which is not auto-installed because of a different licence\n") # Arguments: if (is.data.frame(x)) x <- as.matrix.data.frame(x) else if (is.list(x)) x <- matrix(unlist(x), ncol = 3) if (is.matrix(x)) { z = x[, 3] y = x[, 2] x = x[, 1] } # Settings: duplicate = "median" dupfun = NULL linear = TRUE # Interpolation: interpp <- eval(parse(text=paste0("akima",":::","interpp"))) ans <- interpp(x, y, z, xo, yo, linear = FALSE, extrap = extrap, duplicate = "median", dupfun = NULL) ans <- data.frame(matrix(unlist(t(ans)), 3)) colnames(ans) = c("x", "y", "z") # Return Value: ans } ################################################################################ fBasics/R/dist-nig.R0000644000176200001440000002037513202116742013673 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # dnig Returns density for inverse Gaussian DF # pnig Returns probability for for inverse Gaussian DF # qnig Returns quantiles for for inverse Gaussian DF # rnig Returns random variates for inverse Gaussian DF # FUNCTION: DESCRIPTION: # .pnigC Fast C implementation # .qnigC Fast C implementation ################################################################################ .dnig <- function(x, alpha, beta, delta, mu, log = FALSE) { x. <- x - mu log.a <- delta*sqrt(alpha^2-beta^2) + log(delta*alpha/pi) Sqrt <- sqrt(delta^2 + x.^2) log.K1 <- log(besselK(alpha * Sqrt, 1, expon.scaled = TRUE)) - alpha*Sqrt dnig <- log.a -log(Sqrt) + log.K1 + beta*x. if(log) dnig else exp(dnig) } dnig <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, log = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Returns density for inverse Gaussian DF # Example: # x = rnorm(1000); u = dgh(x, 1.1, 0.2, 0.8, 0.4, -0.5) # v = dnig(rnorm(x), 1.1, 0.2, 0.8, 0.4); u -v # FUNCTION: # Parameters: if (length(alpha) == 4) { mu = alpha[4] delta = alpha[3] beta = alpha[2] alpha = alpha[1] } # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") .dnig(x, alpha=alpha, beta=beta, delta=delta, mu=mu, log=log) } # ------------------------------------------------------------------------------ pnig <- function(q, alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns probability for for inverse Gaussian DF # Function: # Probability: # pgh(q = q, alpha = alpha, beta = beta, delta = delta, mu = mu, # lambda = -0.5) if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") ans <- q for(i in seq_along(q)) { ans[i] <- integrate(.dnig, -Inf, q[i], stop.on.error = FALSE, alpha = alpha, beta = beta, delta = delta, mu = mu)$value } ans } # ------------------------------------------------------------------------------ qnig <- function(p, alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles for for inverse Gaussian DF # FUNCTION: # Quantiles: # qgh(p = p, alpha = alpha, beta = beta, delta = delta, mu = mu, # lambda = -0.5) # Checks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Internal Function: .froot <- function(x, alpha, beta, delta, mu, p) pnig(q = x, alpha = alpha, beta = beta, delta = delta, mu = mu) - p # Quantiles: ans <- p for(i in seq_along(p)) { lower = -1 upper = +1 counter = 0 v <- NA while(is.na(v) && counter < 1000) { v <- .unirootNA(f = .froot, interval = c(lower, upper), alpha = alpha, beta = beta, delta = delta, mu = mu, p = p[i]) counter = counter + 1 lower = lower - 2^counter upper = upper + 2^counter } ans[i] <- v } # Return Value: ans } # ------------------------------------------------------------------------------ rnig <- function(n, alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Return normal inverse Gaussian distributed random variates # Arguments: # n - number of deviates to be generated # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Settings: gamma = sqrt(alpha*alpha - beta*beta) # GAMMA: if (gamma == 0) { # GAMMA = 0: V = rnorm(n)^2 Z = delta*delta / V X = sqrt(Z)*rnorm(n) } else { # GAMMA > 0: U = runif(n) V = rnorm(n)^2 # FIXED ... z1 <- function(v, delta, gamma) { delta/gamma + v/(2*gamma^2) - sqrt(v*delta/(gamma^3) + (v/(2*gamma^2))^2 ) } z2 <- function(v, delta, gamma) { (delta/gamma)^2 / z1(v = v, delta = delta, gamma = gamma) } pz1 <- function(v, delta, gamma) { delta / (delta + gamma * z1(v = v, delta = delta, gamma = gamma) ) } s = (1-sign(U-pz1(v = V, delta = delta, gamma = gamma)))/2 Z = z1(v = V, delta = delta, gamma = gamma)*s + z2(v = V, delta = delta, gamma = gamma)*(1-s) X = mu + beta*Z + sqrt(Z)*rnorm(n) } # Attributes: attr(X, "control") = c(dist = "nig", alpha = alpha, beta = beta, delta = delta, mu = mu) # Return Value: X } ################################################################################ .qnigC <- function(p, alpha = 1, beta = 0, delta = 1, mu = 0) { # Description: # Returns quantiles for for inverse Gaussian DF # Example: # p = runif(10); .qnigC(p) # FUNCTION: # Checks: if(alpha <= 0) stop("Invalid parameters: alpha <= 0.0\n") if(alpha^2 <= beta^2) stop("Invalid parameters: alpha^2 <= beta^2.0\n") if(delta <= 0) stop("Invalid parameters: delta <= 0.0\n") if((sum(is.na(p)) > 0)) stop("Invalid probabilities:\n",p,"\n") else if(sum(p < 0)+sum(p > 1) > 0) stop("Invalid probabilities:\n",p,"\n") # Evaluate NIG cdf by calling C function n <- length(p) q <- rep(0, n) retValues <- .C("qNIG", as.double(p), as.double(mu), as.double(delta), as.double(alpha), as.double(beta), as.integer(n), as.double(q), PACKAGE = "fBasics") quantiles <- retValues[[7]] quantiles[quantiles <= -1.78e+308] <- -Inf quantiles[quantiles >= 1.78e+308] <- Inf # Return Value: quantiles } # ------------------------------------------------------------------------------ .pnigC <- function(q, alpha = 1, beta = 0, delta = 1, mu = 0) { # Description: # Returns probabilities for for inverse Gaussian DF # IMPORTANT NOTE: # DW: C program fails, remains to check # Example: # q = sort(rnorm(10)); .pnigC(q) # FAILS # FUNCTION: # Checks: if(alpha <= 0) stop("Invalid parameters: alpha <= 0.0\n") if(alpha^2 <= beta^2) stop("Invalid parameters: alpha^2 <= beta^2.0\n") if(delta <= 0) stop("Invalid parameters: delta <= 0.0\n") if(sum(is.na(q)) > 0) stop("Invalid quantiles:\n", q) # Evaluate NIG cdf by calling C function n <- length(q) p <- rep(0, n) retValues <- .C("pNIG", as.double(q), as.double(mu), as.double(delta), as.double(alpha), as.double(beta), as.integer(n), as.double(p), PACKAGE = "fBasics") probs <- retValues[[7]] # Return Value: probs } ################################################################################ fBasics/R/matrix-triang.R0000644000176200001440000000323613202116742014740 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # GENERATION: DESCRIPTION: # triang Extracs the lower tridiagonal part from a matrix # Triang Extracs the upper tridiagonal part from a matrix ################################################################################ triang <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns lower triangle matrix # FUNCTION: # Triangulate: x[row(x) < col(x)] = 0 # Return Value: x } # ------------------------------------------------------------------------------ Triang <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns upper triangle matrix # FUNCTION: # Triangulate x[row(x) > col(x)] = 0 # Return Value: x } ################################################################################ fBasics/R/builtin-hypHyperbolicDist.R0000644000176200001440000004764513202116742017277 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: # .rghyp # .rgigjd # .rgigjd1 # .dhyp1 # .dhyp2 # .dhyp3 # .dhyp4 # .phyp1 # .phyp2 # .phyp3 # .phyp4 # .qhyp1 # .qhyp2 # .qhyp3 # .qhyp4 # .rhyp1 # .rhyperb # .hyperb.change.pars # .rhyp2 # .rhyp3 # .rhyp4 ################################################################################ # This is code borrowed from # David Scott's website. # The functions are also part of previous versions of the R contributed # package Hyperbolic Dist. # Rmetrics: # Note that these functions are not packaged and available on Debian # as of 2007-06-23. # To run these functions under Debian/Rmetrics we have them # implemented here as a builtin. ################################################################################ .rghyp <- function(n, theta) { # A function implemented by Diethelm Wuertz # Author: # Original Version by David Scott # FUNCTION: # Settings: lambda = theta[1] alpha = theta[2] beta = theta[3] delta = theta[4] mu = theta[5] chi = delta^2 psi = alpha^2 - beta^2 # Ckecks: if (alpha <= 0) stop("alpha must be greater than zero") if (delta <= 0) stop("delta must be greater than zero") if (abs(beta) >= alpha) stop("abs value of beta must be less than alpha") # Random Numbers: if (lambda == 1){ X = .rgigjd1(n, c(lambda, chi, psi)) } else{ X = .rgigjd(n, c(lambda, chi, psi)) } # Result: sigma = sqrt(X) Z = rnorm(n) Y = mu + beta*sigma^2 + sigma*Z # Return Value: Y } # ------------------------------------------------------------------------------ .rgigjd <- function(n, theta) { # A function implemented by Diethelm Wuertz # Author: # Original Version by David Scott # FUNCTION: # Settings: lambda = theta[1] chi = theta[2] psi = theta[3] # Checks: if (chi < 0) stop("chi can not be negative") if (psi < 0) stop("psi can not be negative") if ((lambda >= 0)&(psi==0)) stop("When lambda >= 0, psi must be > 0") if ((lambda <= 0)&(chi==0)) stop("When lambda <= 0, chi must be > 0") if (chi == 0) stop("chi = 0, use rgamma") if (psi == 0) stop("algorithm only valid for psi > 0") alpha = sqrt(psi/chi) beta = sqrt(psi*chi) m = (lambda-1+sqrt((lambda-1)^2+beta^2))/beta g = function(y){ 0.5*beta*y^3 - y^2*(0.5*beta*m+lambda+1) + y*((lambda-1)*m-0.5*beta) + 0.5*beta*m } upper = m while (g(upper) <= 0) upper = 2*upper yM = uniroot(g, interval=c(0,m))$root yP = uniroot(g, interval=c(m,upper))$root a = (yP-m)*(yP/m)^(0.5*(lambda-1))*exp(-0.25*beta*(yP+1/yP-m-1/m)) b = (yM-m)*(yM/m)^(0.5*(lambda-1))*exp(-0.25*beta*(yM+1/yM-m-1/m)) c = -0.25*beta*(m+1/m) + 0.5*(lambda-1)*log(m) output = numeric(n) for(i in 1:n){ need.value = TRUE while(need.value==TRUE){ R1 = runif (1) R2 = runif (1) Y = m + a*R2/R1 + b*(1-R2)/R1 if (Y>0){ if (-log(R1)>=-0.5*(lambda-1)*log(Y)+0.25*beta*(Y+1/Y)+c){ need.value = FALSE } } } output[i] = Y } # Return Value: output/alpha } # ------------------------------------------------------------------------------ .rgigjd1 <- function(n, theta) { # A function implemented by Diethelm Wuertz # Description: # Modified version of rgigjd to generate random observations # from a generalised inverse Gaussian distribution in the # special case where lambda = 1. # Author: # Original Version by David Scott # FUNCTION: if (length(theta) == 2) theta = c(1, theta) # Settings: lambda = 1 chi = theta[2] psi = theta[3] # Checks: if (chi < 0) stop("chi can not be negative") if (psi < 0) stop("psi can not be negative") if (chi == 0) stop("chi = 0, use rgamma") if (psi == 0) stop("When lambda >= 0, psi must be > 0") alpha = sqrt(psi/chi) beta = sqrt(psi*chi) m = abs(beta)/beta g = function(y){ 0.5*beta*y^3 - y^2*(0.5*beta*m+lambda+1) + y*(-0.5*beta) + 0.5*beta*m } upper = m while (g(upper)<=0) upper = 2*upper yM = uniroot(g,interval=c(0,m))$root yP = uniroot(g,interval=c(m,upper))$root a = (yP-m)*exp(-0.25*beta*(yP+1/yP-m-1/m)) b = (yM-m)*exp(-0.25*beta*(yM+1/yM-m-1/m)) c = -0.25*beta*(m+1/m) output = numeric(n) for(i in 1:n){ need.value = TRUE while(need.value==TRUE){ R1 = runif (1) R2 = runif (1) Y = m + a*R2/R1 + b*(1-R2)/R1 if (Y>0){ if (-log(R1)>=0.25*beta*(Y+1/Y)+c){ need.value = FALSE } } } output[i] = Y } # Return Value: output/alpha } # ------------------------------------------------------------------------------ .dhyp1 <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns Hyperbolic Density Function PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Density: efun = exp( -alpha*sqrt(delta^2 + (x-mu)^2) + beta*(x-mu) ) sqr = sqrt(alpha^2-beta^2) bK1 = besselK(delta*sqr, nu = 1) prefac = sqr / ( 2 * alpha * delta * bK1) ans = prefac * efun # Return Value: ans } # ------------------------------------------------------------------------------ .dhyp2 <- function(x, zeta = 1, rho = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns Hyperbolic density in the 2nd parameterization # FUNCTION: # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # Parameter Change: alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = dhyp(x, alpha, beta, delta, mu) ans } # ------------------------------------------------------------------------------ .dhyp3 <- function(x, xi = 1/sqrt(2), chi = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns Hyperbolic density in the 2nd parameterization # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: rho = chi / xi zeta = 1/xi^2 - 1 alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = dhyp(x, alpha, beta, delta, mu) ans } # ------------------------------------------------------------------------------ .dhyp4 <- function(x, a.bar = 1, b.bar = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns Hyperbolic density in the 2nd parameterization # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = a.bar / delta beta = b.bar / delta # Return Value: ans = dhyp(x, alpha, beta, delta, mu) ans } # ------------------------------------------------------------------------------ .phyp1 <- function(q, alpha = 1, beta = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Return cumulative probability of Hyperbolic PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Cumulative Probability: ans = NULL for (Q in q) { Integral = integrate(dhyp, -Inf, Q, stop.on.error = FALSE, alpha = alpha, beta = beta, delta = delta, mu = mu, ...) # Works in both, R and SPlus: ans = c(ans, as.numeric(unlist(Integral)[1]) ) } # Return Value: ans } # ------------------------------------------------------------------------------ .phyp2 <- function(q, zeta = 1, rho = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns cumulative probability in the 2nd parameterization # Arguments: # zeta, rho - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = phyp(q, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .phyp3 <- function(q, xi = 1/sqrt(2), chi = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns cumulative probability in the 3rd parameterization # Arguments: # xi, xhi - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: rho = chi / xi zeta = 1/xi^2 - 1 alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = phyp(q, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .phyp4 <- function(q, a.bar = 1, b.bar = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns cumulative probability in the 4th parameterization # Arguments: # a.bar, b.bar - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = a.bar / delta beta = b.bar / delta # Return Value: ans = phyp(q, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .qhyp1 <- function(p, alpha = 1, beta = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of Hyperbolic PDF # Arguments: # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # Note: # This procedure will not run under Splus. # FUNCTION: # Internal Functions: .froot <- function(x, alpha, beta, delta, p) { phyp(q = x, alpha = alpha, beta = beta, delta = delta, mu = 0) - p } # Loop over all p's: result = NULL for (pp in p) { lower = -1 upper = +1 counter = 0 iteration = NA while (is.na(iteration)) { iteration = .unirootNA(f = .froot, interval = c(lower, upper), alpha = alpha, beta = beta, delta = delta, p = pp) counter = counter + 1 lower = lower-2^counter upper = upper+2^counter } result = c(result, iteration) } # Return Value: ans = result + mu ans } # ------------------------------------------------------------------------------ .qhyp2 <- function(p, zeta = 1, rho = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of Hyperbolic PDF in the 2nd parameterization # Arguments: # zeta, rho - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = qhyp(p, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .qhyp3 <- function(p, xi = 1/sqrt(2), chi = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of Hyperbolic PDF in the 3rd parameterization # Arguments: # zeta, chi - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: rho = chi / xi zeta = 1/xi^2 - 1 alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho # Return Value: ans = qhyp(p, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .qhyp4 <- function(p, a.bar = 1, b.bar = 0, delta = 1, mu = 0, ...) { # A function implemented by Diethelm Wuertz # Description: # Returns quantiles of Hyperbolic PDF in the 4th parameterization # Arguments: # a.bar, b.bar - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = NA beta = NA # Return Value: ans = qhyp(p, alpha, beta, delta, mu, ...) ans } # ------------------------------------------------------------------------------ .rhyp1 <- function(n, alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns random deviates of Hyperbolic PDF # Arguments: # n - number of random deviates to be generated # alpha, beta - Shape Parameter, |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # Notes: # I have removed my original Fortran program and replaced it by # the dhyperb() function from the HyperbolicDist Package, written # by David Scott, Ai-Wei Lee, Jennifer Tso, Richard Trendall. # License: GPL # FUNCTION: # Result - Use Standard Parameterization: Zeta = delta * sqrt(alpha^2 - beta^2) hyp.Pi = beta / sqrt(alpha^2 - beta^2) theta = c(hyp.Pi, Zeta, delta, mu) # Return Value: ans = .rhyperb(n = n, theta = theta) ans } # ------------------------------------------------------------------------------ .rhyperb <- function(n, theta) { # FUNCTION: # Internal Function: hyp.pi = theta[1] zeta = theta[2] delta = theta[3] mu = theta[4] alpha = as.numeric(.hyperb.change.pars(1, 2, theta))[1] * delta beta = as.numeric(.hyperb.change.pars(1, 2, theta))[2] * delta phi = as.numeric(.hyperb.change.pars(1, 3, theta))[1] * delta gamma = as.numeric(.hyperb.change.pars(1, 3, theta))[2] * delta theta.start = -sqrt(phi * gamma) t = -sqrt(gamma/phi) w = sqrt(phi/gamma) delta1 = exp(theta.start)/phi delta2 = (w - t) * exp(theta.start) delta3 = exp(-gamma * w)/gamma k = 1/(delta1 + delta2 + delta3) r = k * delta1 v = 1 - k * delta3 output = numeric(n) need.value = TRUE for (i in 1:n) { while (need.value == TRUE) { U = runif(1) E = rexp(1) if (U <= r) { x = 1/phi * log(phi * U/k) if (E >= alpha * (sqrt(1 + x^2) + x)) { need.value = FALSE } } if ((U > r) & (U <= v)) { x = t - 1/phi + U * exp(-theta.start)/k if (E >= alpha * sqrt(1 + x^2) - beta * x + theta.start) { need.value = FALSE } } if (U > v) { x = 1/gamma * log(k/gamma) - 1/gamma * log(1 - U) if (E >= alpha * (sqrt(1 + x^2) - x)) { need.value = FALSE } } } output[i] = delta * x + mu need.value = TRUE } # Return Value: output } # ------------------------------------------------------------------------------ .hyperb.change.pars <- function(from, to, theta) { # FUNCTION: # Internal Function: delta <- theta[3] mu <- theta[4] hyperb.pi <- theta[1] zeta <- theta[2] if (from == 1 && to == 2) { alpha <- zeta * sqrt(1 + hyperb.pi^2)/delta beta <- zeta * hyperb.pi/delta output = c(alpha = alpha, beta = beta, delta = delta, mu = mu) } if (from == 1 && to == 3) { phi <- zeta/delta * (sqrt(1 + hyperb.pi^2) + hyperb.pi) gamma <- zeta/delta * (sqrt(1 + hyperb.pi^2) - hyperb.pi) output = c(phi = phi, gamma = gamma, delta = delta, mu = mu) } # Return Value: output } # ------------------------------------------------------------------------------ .rhyp2 <- function(n, zeta = 1, rho = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns random deviates of Hyperbolic PDF in the 2nd parameterization # Arguments: # zeta, rho - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho ans = rhyp(n, alpha, beta, delta, mu) # Return Value: ans } # ------------------------------------------------------------------------------ .rhyp3 <- function(n, xi = 1/sqrt(2), chi = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns random deviates of Hyperbolic PDF in the 3rd parameterization # Arguments: # zeta, chi - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: rho = chi / xi zeta = 1/xi^2 - 1 alpha = zeta / ( delta * sqrt(1 - rho*rho) ) beta = alpha * rho ans = rhyp(n, alpha, beta, delta, mu) # Return Value: ans } # ------------------------------------------------------------------------------ .rhyp4 <- function(n, a.bar = 1, b.bar = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Returns random deviates of Hyperbolic PDF in the 4th parameterization # Arguments: # a.bar, b.bar - Shape Parameter, resulting |beta| <= alpha # delta - Scale Parameter, 0 <= delta # mu - Location Parameter # FUNCTION: # Parameter Change: alpha = a.bar / delta beta = b.bar / delta ans = rhyp(n, alpha, beta, delta, mu) # Return Value: ans } ################################################################################ fBasics/R/dist-ghtRobMoments.R0000644000176200001440000001023613202116742015701 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # ghtMED Returns true GHT median # ghtIQR Returns true GHT inter quartal range # ghtSKEW Returns true GHT robust skewness # ghtKURT Returns true GHT robust kurtosis ################################################################################ ghtMED <- function(beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns true ght median # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # ght Median Q = qght(p=0.5, beta, delta, mu, nu) med = c(MED = Q) # Return Value: med } # ------------------------------------------------------------------------------ ghtIQR <- function(beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns true ght inter quartal range # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # ght Inter Quartile Range Q = numeric() Q[1] = qght(p=0.25, beta, delta, mu, nu) Q[2] = qght(p=0.75, beta, delta, mu, nu) iqr = c(IQR = Q[[2]] - Q[[1]]) # Return Value: iqr } # ------------------------------------------------------------------------------ ghtSKEW <- function(beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns true ght robust ght skewness # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # ght Robust Skewness: Q = numeric() Q[1] = qght(p=0.25, beta, delta, mu, nu) Q[2] = qght(p=0.50, beta, delta, mu, nu) Q[3] = qght(p=0.75, beta, delta, mu, nu) skew = c(SKEW = ( Q[[3]] + Q[[1]] - 2* Q[[2]] ) / (Q[[3]] - Q[[1]] ) ) # Return Value: skew } # ------------------------------------------------------------------------------ ghtKURT <- function(beta = 0.1, delta = 1, mu = 0, nu = 10) { # A function implemented by Diethelm Wuertz # Description: # Returns true ght robust ght kurtosis # Arguments: # beta - a numeric value, the location parameter # delta - a numeric value, the scale parameter # mu - a numeric value, the first shape parameter # nu - a numeric value, the second parameter # FUNCTION: # ght Robust Kurtosis: Q = numeric() for (p in (1:7)/8) Q = c(Q, qght(p, beta, delta, mu, nu)) kurt = c(KURT = (Q[[7]] - Q[[5]] + Q[[3]] - Q[[1]]) / (Q[[6]] - Q[[2]])) # Return Value: kurt } ################################################################################ fBasics/R/zzz.R0000644000176200001440000000343713202136131013004 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ .onAttach <- function(libname, pkgname) { # do whatever needs to be done when the package is loaded # some people use it to bombard users with # messages using # packageStartupMessage( "\n" ) # packageStartupMessage( "Rmetrics Package fBasics" ) # packageStartupMessage( "Analysing Markets and calculating Basic Statistics" ) # packageStartupMessage( "Copyright (C) 2005-2014 Rmetrics Association Zurich" ) # packageStartupMessage( "Educational Software for Financial Engineering and Computational Science" ) # packageStartupMessage( "Rmetrics is free software and comes with ABSOLUTELY NO WARRANTY." ) # packageStartupMessage( "https://www.rmetrics.org --- Mail to: info@rmetrics.org" ) } ################################################################################ .onLoad <- function(libname, pkgname) { setRmetricsOptions(.x.save = NA) } ################################################################################ fBasics/R/utils-printControl.R0000644000176200001440000000345413202116742016007 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: CONTROL ATTRIBUTES: # print.control Prints unlisted control attributes # FUNCTION: DESCRIPTION: # .print Used in regression package ################################################################################ print.control <- function(x, ...) { # Return Value: print(unlist(x)) } ################################################################################ .print <- function(x, ...) { UseMethod(".print") } # ------------------------------------------------------------------------------ .plot <- function(x, ...) { UseMethod(".plot") } # ------------------------------------------------------------------------------ .summary <- function(object, ...) { UseMethod(".summary") } # ------------------------------------------------------------------------------ .predict <- function(object, ...) { UseMethod(".predict") } ################################################################################ fBasics/R/dist-nigMode.R0000644000176200001440000000312513202116742014472 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # nigMode Computes the normal inverse Gaussian mode ################################################################################ nigMode <- function(alpha = 1, beta = 0, delta = 1, mu = 0) { # A function implemented by Diethelm Wuertz # Description: # Computes the mode of the Normal Inverse Gaussian PDF # FUNCTION: # Find Maximum: min = qnig(0.01, alpha, beta, delta, mu) max = qnig(0.99, alpha, beta, delta, mu) ans = optimize(f = dnig, interval = c(min, max), alpha = alpha, beta = beta, delta = delta, mu = mu, maximum = TRUE, tol = .Machine$double.eps)$maximum # Return Value: ans } ################################################################################ fBasics/R/utils-colorRGB.R0000644000176200001440000001057513202116742014765 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .asRGB Converts any R color to RGB (red/green/blue) # .chcode Changes from one to another number system # .hex.to.dec Converts heximal numbers do decimal numbers # .dec.to.hex Converts decimal numbers do heximal numbers ################################################################################ .asRGB <- function(col = rainbowPalette(64), alpha = FALSE) { # A function implemented by Diethelm Wuertz # Description: # Converts any R color to RGB (red/green/blue) # Arguments: # col - vector of any of the three kind of R colors, i.e., either a # color name (an element of colors()), a hexadecimal string of # the form "#rrggbb", or an integer i meaning palette()[i]. # alpha - a logical value indicating whether alpha channel values # should be returned. # FUNCTION: # Color Conversion: result <- col2rgb(col = col, alpha = alpha) # Return Value: t(result) } # ------------------------------------------------------------------------------ .chcode <- function(b, base.in = 2, base.out = 10, digits = "0123456789ABCDEF") { # A function implemented by Diethelm Wuertz # Description: # Changes from one to another number system # Arguments: # b - number specified in the input base # b.in - input base # b.out - output base # digits - digits string # Value: # returns the input in the form represented by the output base # Author: # Peter Wolf Universitaet Bielefeld # from: http://tolstoy.newcastle.edu.au/R/help/05/04/2085.html # FUNCTION: # Change Number System: digits = substring(digits,1:nchar(digits),1:nchar(digits)) if (length(base.in) == 1) base.in = rep(base.in, max(nchar(b) - 1)) if (is.numeric(b)) b = as.character(as.integer(b)) b.num = lapply(strsplit(b, ""), function(x) {match(x, digits)-1} ) result = lapply(b.num, function(x) {cumprod(rev(c(base.in,1))[1:length(x)]) %*% rev(x)} ) number = unlist(result) # DW Print Output Suppressed # cat("decimal representation:",number,"\n") if (length(base.out) == 1) { base.out<-rep(base.out, 1+ceiling(log(max(number), base = base.out))) } n.base = length(base.out) result = NULL for(i in n.base:1){ result = rbind(number %% base.out[i], result) number = floor(number/base.out[i]) } result[]<-digits[result+1] ans = apply(result, 2, paste, collapse = "") # Return Value: ans } # ------------------------------------------------------------------------------ .hex.to.dec <- function(b) { # A function implemented by Diethelm Wuertz # Description: # Converts heximal numbers do decimal numbers # Arguments: # b - a heximal number # Value: # returns a heximal numbers as decimal numbers # FUNCTION: # Hex to Bin: ans = as.numeric(.chcode(b, base.in = 16, base.out = 10)) # Return Value: ans } # ------------------------------------------------------------------------------ .dec.to.hex <- function(b) { # A function implemented by Diethelm Wuertz # Description: # Converts decimal numbers do heximal numbers # Arguments: # x - a decimal number # Value: # returns a decimal numbers as heximal numbers # FUNCTION: # Decimal to Hex: ans = .chcode(b, base.in = 10, base.out = 16) # Return Value: ans } ################################################################################ fBasics/R/utils-recessionLines.R0000644000176200001440000000371213202116742016274 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # .recessionLines Adds vertical recession lines to a plot ################################################################################ .recessionLines <- function() { # A function implemented by Diethelm Wuertz # Description: # Adds vertical recession lines to a plot # Arguments: # none # References: # http://www.nber.org/cycles/cyclesmain.html # FUNCTION: # Add Recession Liones: abline(v = as.POSIXct(c( "1920-01-01", "1921-08-01", "1923-05-01", "1924-07-01", "1926-10-01", "1927-11-01", "1929-08-01", "1933-03-01", "1945-01-01", "1945-10-01", "1948-11-01", "1949-10-01", "1953-07-01", "1954-05-01", "1957-08-01", "1958-04-01", "1960-04-01", "1961-02-01", "1969-12-01", "1970-11-01", "1973-11-01", "1975-03-01", "1990-07-01", "1991-03-01", "2001-03-01", "2001-11-01", "2007-12-07")), col = "grey") } ################################################################################ fBasics/R/plot-acfPlot.R0000644000176200001440000002302513202116741014513 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # acfPlot Displays tailored autocorrelations function plot # pacfPlot Displays tailored partial autocorrelation function plot # teffectPlot Estimates and displays the Taylor effect # lacfPlot Displays lagged autocorrelations ################################################################################ acfPlot <- function(x, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Autocorrelations function plot # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Labels: if (labels) { main = "" xlab = "lag" ylab = "ACF" } else { main = xlab = ylab = "" } # ACF: for (i in 1:dim(x)[2]) { if (labels) main = Units[i] ans = acf(x = as.vector(x[, i]), main = main, xlab = xlab, ylab = ylab, ...) } # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ pacfPlot <- function(x, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Partial autocorrelation function plot # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Labels: if (labels) { main = "" xlab = "lag" ylab = "PACF" } else { main = xlab = ylab = "" } # Partial ACF: for (i in 1:dim(x)[2]) { if (labels) main = Units[i] ans = pacf(x = as.vector(x[, i]), main = main, xlab = xlab, ylab = ylab, ...) } # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ teffectPlot <- function(x, deltas = seq(from = 0.2, to = 3.0, by = 0.2), lag.max = 10, ymax = NA, standardize = TRUE, labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Evaluate and Display Taylor Effect # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Labels: if (labels) { main = "" xlab = "Exponent Delta" ylab = "Autocorrelation" } else { main = xlab = ylab = "" } # Taylor Effect: ans = list() maxDelta = NULL for (i in 1:dim(x)[2]) { if (labels) main = Units[i] X = as.vector(x[, i]) # Standardize: if(standardize) X = (X-mean(X))/sqrt(var(X)) data = matrix(data = rep(0, times = lag.max*length(deltas)), nrow = lag.max, byrow = TRUE) for (id in 1:length(deltas)) data[,id] = as.double(acf(abs(X)^deltas[id], lag.max = lag.max, type = "corr", plot = FALSE)$acf)[2:(lag.max+1)] if (is.na(ymax)) ymax = max(data) # Plot: if (labels) { plot(deltas, data[1,], ylim = c(0, ymax), type = "n", main = main, xlab = xlab, ylab = ylab, ...) } else { plot(deltas, data[1,], type = "n", main = main, xlab = xlab, ylab = ylab, ...) } xl = 1:length(deltas) for (il in 1:(lag.max)) { yp = max(data[il, ]) yl = xl[data[il, ] == yp] lines(deltas, data[il, ], col = il) points(deltas[yl], yp, pch = 19) maxDelta = c(maxDelta, deltas[yl]) lines (c(1, 1), c(0, ymax)) } # Grid: if (labels) { mtext("Taylor Effect", side = 4, adj = 0, col = "darkgrey", cex = 0.7) grid() } ans[[i]] = data } names(ans) = Units # Deltas for max Peak: ans$maxDelta = maxDelta # Return Value: invisible(ans) } # ------------------------------------------------------------------------------ lacfPlot <- function(x, n = 12, lag.max = 20, type = c("returns", "values"), labels = TRUE, ...) { # A function implemented by Diethelm Wuertz # Description: # Computes the lagged autocorrelation function # Arguments: # x - an uni- or multivariate return series of class 'timeSeries' # or any other object which can be transformed by the function # 'as.timeSeries()' into an object of class 'timeSeries'. # type - a character string which specifies the type of the input # series, either "returns" or series "values". In the case of # a return series as input, the required value series is # computed by cumulating the financial returns: 'exp(colCumsums(x))' # labels - a logical flag, by default true. Should a default # main title and labels addet to the plot? # FUNCTION: # Settings: if (!is.timeSeries(x)) x = as.timeSeries(x) Units = colnames(x) # Cumulated Returns: type = match.arg(type) if (type == "values") { cumX = x } else if (type == "returns") { cumX = exp(colCumsums(x)) } # Labels: if (labels) { main = "" xlab = "tau" ylab = "Lagged Correlation" } else { main = xlab = ylab = "" } cumRho = cumLagged = NULL DIM = dim(cumX)[2] for (i in 1:DIM) { # Get Data: x = as.vector(as.matrix(cumX)[, i]) if (labels) main = Units[i] # Truncate to multiple of n: N = trunc(length(x)/n) M = length(x) - n*N if (M > 0) x = x[-c(1:M)] # One Step Volatilities: x.ret = c(0, diff(log(x))) x.mat = matrix(x.ret, byrow = TRUE, ncol = n) u = apply(abs(x.mat), 1, mean) # n-step Volatilities: index = n*(1:N) v = abs(c(0, diff(log(x[index])))) # Zero Tau: L = length(u) RhoZero = cor(u, v) # print(RhoZero) # Positive Tau: RhoPos = NULL for (tau in 1:lag.max) { X = u[-((L-tau+1):L)] X2 = X Y = v[-((L-tau+1):L)] Y2 = v[-(1:tau)] X.mean = mean(X) Y.mean = mean(Y) X1 = sum((X - X.mean)^2) Y1 = sum((Y - Y.mean)^2) XY1 = sum( (X2-X.mean)*(Y2-Y.mean) ) rho = XY1/sqrt(X1*Y1) RhoPos = c(RhoPos, rho) } # Negative Tau: RhoNeg = NULL for (tau in 1:lag.max) { X = v[-((L-tau+1):L)] X2 = X Y = u[-((L-tau+1):L)] Y2 = u[-(1:tau)] X.mean = mean(X) Y.mean = mean(Y) X1 = sum((X - X.mean)^2) Y1 = sum((Y - Y.mean)^2) XY1 = sum( (X2-X.mean)*(Y2-Y.mean) ) rho = XY1/sqrt(X1*Y1) RhoNeg = c(RhoNeg, rho) } # Correlations: Lagged = RhoPos - RhoNeg Rho = c(rev(RhoNeg), RhoZero, RhoPos) # Plot: plot(x = (-lag.max):(lag.max), y = Rho, type = "l", xlab = xlab, ylab = ylab, ylim = c(min(Lagged), max(Rho)), main = main, ...) Text = paste("n =", n, " | lag =", lag.max) mtext(Text, side = 4, adj = 0, col ="darkgrey", cex = 0.7) points(-lag.max:lag.max, Rho, pch = 19, cex = 0.7) lines(0:lag.max, c(0, Lagged), col = "red") points(0:lag.max, c(0, Lagged), pch = 19, cex = 0.7, col = "red") abline(h = 0, col = "grey", lty = 3) ci = 1/sqrt(length(u)) abline(h = +ci, col = "blue") abline(h = -ci, col = "blue") if (labels) grid() # Grid: if (labels) grid() cumRho = rbind(cumRho, Rho) cumLagged = c(cumLagged, Lagged) } # Return Value: invisible(list(Rho = cumRho, Lagged = cumLagged)) } ################################################################################ fBasics/R/dist-hypFit.R0000644000176200001440000000650713202116741014361 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: GENERALIZED DISTRIBUTION: # hypFit Fits parameters of a hyperbolic density ################################################################################ hypFit <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a hyperbolic density # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Log-likelihood Function: ehypmle = function(x, y = x, trace) { if (abs(x[2]) >= x[1]) return(1e99) f = -sum(log(dhyp(y, x[1], x[2], x[3], x[4]))) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } # Minimization: eps = 1e-10 BIG = 1000 r = nlminb(start = c(alpha, beta, delta, mu), objective = ehypmle, lower = c(eps, -BIG, eps, -BIG), upper = BIG, y = x, trace = trace) names(r$par) <- c("alpha", "beta", "delta", "mu") # Add Title and Description: if (is.null(title)) title = "Hyperbolic Parameter Estimation" if (is.null(description)) description = description() # Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = ehypmle(r$par, y = as.vector(x.orig), trace = trace) } fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 51) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dhyp(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("HYP Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Hyperbolic Distribution", data = as.data.frame(x.orig), fit = fit, title = title, description = description ) } ################################################################################ fBasics/R/dist-nigFit.R0000644000176200001440000003336313202116741014336 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: GENERALIZED DISTRIBUTION: # nigFit Fits parameters of a normal inverse Gaussian density # .nigFit.mle max Log-likelihood Estimation # .nigFit.gmm gemeralized method of moments estimation # .nigFit.mps maximum product spacings estimation # .nigFit.vmps minimum variance product spacings estimation ################################################################################ nigFit <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, method = c("mle", "gmm", "mps", "vmps"), scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # FUNCTION: # Settings: method = match.arg(method) # Select: if (method == "mle") { # MLE: fit = .nigFit.mle(x = x, alpha = alpha, beta = beta, delta = delta, mu = mu , scale = scale, doplot = doplot, span = span, trace = trace, title = title, description = description, ...) } else if (method == "gmm") { # GMM: fit = .nigFit.gmm(x = x, alpha = alpha, beta = beta, delta = delta, mu = mu , scale = scale, doplot = doplot, span = span, trace = trace, title = title, description = description, ...) } else if (method == "mps") { # MPS: fit = .nigFit.mps(x = x, alpha = alpha, beta = beta, delta = delta, mu = mu , scale = scale, doplot = doplot, span = span, trace = trace, title = title, description = description, ...) } else if (method == "vmps") { # MPS: fit = .nigFit.vmps(x = x, alpha = alpha, beta = beta, delta = delta, mu = mu , scale = scale, doplot = doplot, span = span, trace = trace, title = title, description = description, ...) } # Return Value: fit } # ------------------------------------------------------------------------------ .nigFit.mle <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, scale = TRUE, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a NIG using maximum log-likelihood # Example: # set.seed(4711); x = rnig(500); mle = .nigFit.mle(x); mle@fit$estimate # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Objective Function: obj = function(x, y = x, trace) { if (abs(x[2]) >= x[1]) return(1e9) f = -sum(dnig(y, x[1], x[2], x[3], x[4], log = TRUE)) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x, "\n") } f } # Parameter Estimation: eps = 1e-10 BIG = 1000 fit = nlminb( start = c(alpha, beta, delta, mu), objective = obj, lower = c(eps, -BIG, eps, -BIG), upper = BIG, y = x, trace = trace) names(fit$par) <- c("alpha", "beta", "delta", "mu") # Rescale Result: if (scale) { fit$scaleParams = c(SD, SD, 1/SD, 1/SD) fit$par = fit$par / fit$scaleParams fit$objective = obj(fit$par, y = as.vector(x.orig), trace = trace) } else { fit$scaleParams = rep(1, time = length(fit$par)) } fit$scale = scale fit$estimate = fit$par fit$minimum = -fit$objective fit$code = fit$convergence # Standard Errors and t-Values: fit = .distStandardErrors(fit, obj, x) # Add Title and Description: if (is.null(title)) title = "Normal Inverse Gaussian Parameter Estimation" if (is.null(description)) description = description() # Optional Plot: if (doplot) .distFitPlot( fit, x = x.orig, FUN = "dnig", main = "NIG Parameter Estimation", span = span, add = add, ...) # Return Value: new("fDISTFIT", call = match.call(), model = "Normal Inverse Gaussian Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .nigFit.gmm <- function(x, scale = TRUE, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a NIG using GMM estimator # Example: # set.seed(4711); x = rnig(500); gmm = .nigFit.gmm(x)@fit$estimate; gmm # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Parameter Estimation: obj <- function(Theta, x) { # Parameters: alpha = Theta[1] beta = Theta[2] delta = Theta[3] mu = Theta[4] names(Theta) <- c("alpha", "beta", "delta", "mu") # Trace: if (TRUE) print(Theta) # Moments: m1 <- x - .ghMuMoments(1, alpha, beta, delta, mu, lambda = -0.5) m2 <- x^2 - .ghMuMoments(2, alpha, beta, delta, mu, lambda = -0.5) m3 <- x^3 - .ghMuMoments(3, alpha, beta, delta, mu, lambda = -0.5) m4 <- x^4 - .ghMuMoments(4, alpha, beta, delta, mu, lambda = -0.5) # Result: f <- cbind(m1, m2, m3, m4) return(f) } r <- .gmm(g = obj, x = x, t0 = c(1, 0, 1, 0)) names(r$par) <- c("alpha", "beta", "delta", "mu") # Add Title and Description: if (is.null(title)) title = "Normal Inverse Gaussian Parameter Estimation" if (is.null(description)) description = description() # Rescale Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = NA } fit = list(estimate = r$par) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 51) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dnig(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), col = "steelblue") } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("NIG GMM Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Normal Inverse Gaussian Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .nigFit.mps <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, scale = TRUE, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a NIG using maximum product spacings # Example: # set.seed(4711); x = rnig(500); mps = .nigFit.mps(x)@fit$estimate; mps # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Parameter Estimation: obj <- function(x, y = x, trace) { if (abs(x[2]) >= x[1]) return(1e9) DH = diff(c(0, na.omit(.pnigC(sort(y), x[1], x[2], x[3], x[4])), 1)) f = -mean(log(DH[DH > 0]))*length(y) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } eps = 1e-10 BIG = 1000 r = nlminb(start = c(alpha, beta, delta, mu), objective = obj, lower = c(eps, -BIG, eps, -BIG), upper = BIG, y = x, trace = trace) names(r$par) <- c("alpha", "beta", "delta", "mu") # Standard Errors: hessian = tsHessian(x = r$par, fun = obj, y = x, trace = FALSE) colnames(hessian) = rownames(hessian) = names(r$par) varcov = solve(hessian) par.ses = sqrt(diag(varcov)) if (scale) par.ses = par.ses / c(SD, SD, 1/SD, 1/SD) # Add Title and Description: if (is.null(title)) title = "NIG mps Parameter Estimation" if (is.null(description)) description = description() # Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list( estimate = r$par, minimum = -r$objective, error = par.ses, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dnig(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), col = "steelblue") } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("NIG MPS Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Normal Inverse Gaussian Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } # ------------------------------------------------------------------------------ .nigFit.vmps <- function (x, alpha = 1, beta = 0, delta = 1, mu = 0, scale = TRUE, doplot = TRUE, add = FALSE, span = "auto", trace = TRUE, title = NULL,description = NULL, ...) { # A function implemented by Yohan Chalabi # Description: # Fits parameters of a NIG using maximum product spacings # Example: # set.seed(4711); x = rnig(500); vmps = .nigFit.vmps(x)@fit$estimate; vmps # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x/SD } # Settings: CALL = match.call() # Parameter Estimation: obj <- function(x, y = x, trace) { if (abs(x[2]) >= x[1]) return(1e+9) DH = diff(c(0, na.omit(.pnigC(sort(y), x[1], x[2], x[3], x[4])), 1)) f = log(var(DH[DH > 0])) if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x[1], x[2], x[3], x[4], "\n") } f } eps = 1e-10 BIG = 1000 r = nlminb( start = c(alpha, beta, delta, mu), objective = obj, lower = c(eps, -BIG, eps, -BIG), upper = BIG, y = x, trace = trace) names(r$par) <- c("alpha", "beta", "delta", "mu") # Standard Errors: hessian = tsHessian(x = r$par, fun = obj, y = x, trace = FALSE) colnames(hessian) = rownames(hessian) = names(r$par) varcov = solve(hessian) par.ses = sqrt(diag(varcov)) if (scale) par.ses = par.ses / c(SD, SD, 1/SD, 1/SD) # Add Title and Description: if (is.null(title)) title = "NIG varMPS Parameter Estimation" if (is.null(description)) description = description() # Result: if (scale) { r$par = r$par/c(SD, SD, 1/SD, 1/SD) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } fit = list( estimate = r$par, minimum = -r$objective, error = par.ses, code = r$convergence) # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dnig(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), col = "steelblue") } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("NIG varMPS Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } } # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Normal Inverse Gaussian Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } ################################################################################ fBasics/R/dist-ghFit.R0000644000176200001440000000711013202116742014147 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: GENERALIZED DISTRIBUTION: # ghFit Fits parameters of a generalized hyperbolic DF ################################################################################ ghFit <- function(x, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, ...) { # A function implemented by Diethelm Wuertz # Description: # Fits parameters of a generalized hyperbolic density # FUNCTION: # Transform: x.orig = x x = as.vector(x) if (scale) { SD = sd(x) x = x / SD } # Settings: CALL = match.call() # Log-likelihood Function: obj = function(x, y = x, trace){ if (NA %in% x) return(1e99) if (abs(x[2]) >= x[1]) return(1e99) f = -sum(dgh(y, x[1], x[2], x[3], x[4], x[5], log = TRUE)) # Print Iteration Path: if (trace) { cat("\n Objective Function Value: ", -f) cat("\n Parameter Estimates: ", x, "\n") } f } # Minimization: r = # Variable Transformation and Minimization: eps = 1e-10 BIG = 1000 f = obj(x = c(alpha, beta, delta, mu, lambda), y = x, trace = FALSE) r = nlminb(start = c(alpha, beta, delta, mu, lambda), objective = obj, lower = c(eps, -BIG, eps, -BIG, -BIG), upper = BIG, y = x, trace = trace) names(r$par) <- c("alpha", "beta", "delta", "mu", "lambda") # Result: if (scale) { r$par = r$par / c(SD, SD, 1/SD, 1/SD, 1) r$objective = obj(r$par, y = as.vector(x.orig), trace = trace) } # Optional Plot: if (doplot) { x = as.vector(x.orig) if (span == "auto") span = seq(min(x), max(x), length = 51) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] y.points = dnig(span, r$par[1], r$par[2], r$par[3], r$par[4]) ylim = log(c(min(y.points), max(y.points))) plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title("GH Parameter Estimation") lines(x = span, y = log(y.points), col = "steelblue") } # Add Title and Description: if (is.null(title)) title = "Generalized Hyperbolic Parameter Estimation" if (is.null(description)) description = description() # Fit: fit = list(estimate = r$par, minimum = -r$objective, code = r$convergence) # Return Value: new("fDISTFIT", call = as.call(CALL), model = "Generalized Hyperbolic Distribution", data = as.data.frame(x.orig), fit = fit, title = as.character(title), description = description() ) } ################################################################################ fBasics/R/matrix-inv.R0000644000176200001440000000247013202116742014247 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # LINEAR ALGEBRA: DESCRIPTION: # inv Returns the inverse of a matrix ################################################################################ inv <- function(x) { # A function implemented by Diethelm Wuertz # Description: # Returns the inverse of a matrix # FUNCTION: # Inverse: # ans = chol2inv(chol(x)) # or ... ans = base::solve(x) # Return Value: ans } ################################################################################ fBasics/R/dist-distPlot.R0000644000176200001440000000334113202116742014712 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received A copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ .distFitPlot <- function(fit, x, FUN = "dnig", main = "Parameter Estimation", span = "auto", add = FALSE, ...) { x = as.vector(x) if (span == "auto") span = seq(min(x), max(x), length = 501) z = density(x, n = 100, ...) x = z$x[z$y > 0] y = z$y[z$y > 0] # The Density function must accept multiple parameters # from the first parameter dFun = match.fun(FUN) y.points = dnig(span, fit$par) ylim = log(c(min(y.points), max(y.points))) if (add) { lines(x = span, y = log(y.points), col = "steelblue") } else { plot(x, log(y), xlim = c(span[1], span[length(span)]), ylim = ylim, type = "p", xlab = "x", ylab = "log f(x)", ...) title(main) lines(x = span, y = log(y.points), col = "steelblue") } } ################################################################################ fBasics/R/test-correlationTest.R0000644000176200001440000002404513202116742016311 0ustar liggesusers # This library is free software; you can redistribute it and/or # modify it under the terms of the GNU Library General Public # License as published by the Free Software Foundation; either # version 2 of the License, or (at your option) any later version. # # This library is distributed in the hope that it will be useful, # but WITHOUT ANY WARRANTY; without even the implied warranty of # MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the # GNU Library General Public License for more details. # # You should have received a copy of the GNU Library General # Public License along with this library; if not, write to the # Free Foundation, Inc., 59 Temple Place, Suite 330, Boston, # MA 02111-1307 USA ################################################################################ # FUNCTION: DESCRIPTION: # correlationTest Performs correlation tests on two samples # pearsonTest Pearson product moment correlation coefficient # kendallTest Kendall's tau correlation test # spearmanTest Spearman's rho correlation test ################################################################################ correlationTest <- function(x, y, method = c("pearson", "kendall", "spearman"), title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # Performs Correlation Tests # FUNCTION: # Test: method = match.arg(method) if (method[1] == "pearson") { ans = pearsonTest(x, y, title = title, description = description) } if (method[1] == "kendall") { ans = kendallTest(x, y, title = title, description = description) } if (method[1] == "spearman") { ans = spearmanTest(x, y, title = title, description = description) } # Return Value: ans } # ------------------------------------------------------------------------------ pearsonTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # A test for association between paired samples # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Note: # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) stopifnot(length(x) == length(y)) # Test: two.sided = cor.test(x = x, y = y, alternative = "two.sided", method = "pearson") less = cor.test(x = x, y = y, alternative = "less", method = "pearson") greater = cor.test(x = x, y = y, alternative = "greater", method = "pearson") # Sample Estimates: ESTIMATE = two.sided$estimate names(ESTIMATE) = "Correlation" test$estimate = ESTIMATE # Parameter DF = two.sided$parameter names(DF) = "Degrees of Freedom" test$parameter = DF # P Values: PVAL = c( two.sided$p.value, less$p.value, greater$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater") test$p.value = PVAL # Confidences Levels: if (!is.null(two.sided$conf.int)) { CONF.INT = cbind( a = two.sided$conf.int, b = less$conf.int, c = greater$conf.int) dimnames(CONF.INT)[[2]] = c( "Two-Sided", " Less", " Greater") test$conf.int = CONF.INT } # Statistic: STATISTIC = two.sided$statistic names(STATISTIC) = "t" test$statistic = STATISTIC # Add: if (is.null(title)) title = "Pearson's Correlation Test" if (is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ kendallTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # A test for association between paired samples # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Note: # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) stopifnot(length(x) == length(y)) # Test: two.sided = cor.test(x = x, y = y, alternative = "two.sided", method = "kendall") less = cor.test(x = x, y = y, alternative = "less", method = "kendall") greater = cor.test(x = x, y = y, alternative = "greater", method = "kendall") # Exact Test: if (class(version) != "Sversion") { two.sided.exact = cor.test(x = x, y = y, exact = TRUE, alternative = "two.sided", method = "kendall") less.exact = cor.test(x = x, y = y, exact = TRUE, alternative = "less", method = "kendall") greater.exact = cor.test(x = x, y = y, exact = TRUE, alternative = "greater", method = "kendall") } else { two.sided.exact = list() two.sided.exact$p.value = two.sided.exact$statistic = NA less.exact = list() less.exact$p.value = less.exact$statistic = NA greater.exact = list() greater.exact$p.value = greater.exact$statistic = NA } # Sample Estimates: ESTIMATE = two.sided$estimate names(ESTIMATE) = "tau" test$estimate = ESTIMATE # P Values: PVAL = c( two.sided$p.value, two.sided.exact$p.value, less$p.value, less.exact$p.value, greater$p.value, greater.exact$p.value) if (is.na(two.sided.exact$p.value)) { names(PVAL) = c( "Alternative Two-Sided", "Alternative Two-Sided | Exact", "Alternative Less", "Alternative Less | Exact", "Alternative Greater", "Alternative Greater | Exact") } else { names(PVAL) = c( "Alternative Two-Sided", "Alternative Two-Sided | Exact", "Alternative Less", "Alternative Less | Exact", "Alternative Greater", "Alternative Greater | Exact") } test$p.value = PVAL # Statistic: # STATISTIC = c( # two.sided$statistic, two.sided.exact$statistic, # less$statistic, less.exact$statistic, # greater$statistic, greater.exact$statistic) STATISTIC = c( two.sided$statistic, two.sided.exact$statistic) # names(STATISTIC) = c( # "z | Two-Sided", "T | Two-Sided | Exact", # "z | Less", "T | Less | Exact", # "z | Greater", "T | Greater | Exact") names(STATISTIC) = c( "z", "T | Exact") test$statistic = STATISTIC # Add: if (is.null(title)) title = "Kendall's tau Correlation Test" if (is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } # ------------------------------------------------------------------------------ spearmanTest <- function(x, y, title = NULL, description = NULL) { # A function implemented by Diethelm Wuertz # Description: # A test for association between paired samples # Arguments: # x - a numeric vector of data values. # description - a brief description of the porject of type # character. # title - a character string which allows for a project title. # Note: # # A function linked to "stats" # FUNCTION: # Call: call = match.call() # Test: test = list() # Data Set Name: DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME # Convert Type: x = as.vector(x) y = as.vector(y) stopifnot(length(x) == length(y)) # Test: two.sided = cor.test(x = x, y = y, alternative = "two.sided", method = "spearman") less = cor.test(x = x, y = y, alternative = "less", method = "spearman") greater = cor.test(x = x, y = y, alternative = "greater", method = "spearman") # Sample Estimates: ESTIMATE = two.sided$estimate names(ESTIMATE) = "rho" test$estimate = ESTIMATE # P Values: PVAL = c( two.sided$p.value, less$p.value, greater$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater") test$p.value = PVAL # Statistic: STATISTIC = two.sided$statistic names(STATISTIC) = "S" test$statistic = STATISTIC # Add: if (is.null(title)) title = "Spearman's rho Correlation Test" if (is.null(description)) description = date() # Return Value: new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } ################################################################################ fBasics/MD50000644000176200001440000003676413203550545012156 0ustar liggesusers0da1cabe97399ea912012f1d0c9e4899 *ChangeLog f8fac4e82cdc9fd46b599c6bde94f215 *DESCRIPTION 24f516750f221a247d481cd1b10c6bc6 *NAMESPACE b5841badb29a9efeca576915c5969166 *R/00fBasics-Package.R ffe2c1f5c776aa0853ea616d0719a38f *R/builtin-gelGmm.R ed986880f886f3e3bbbcd5cef64cda2b *R/builtin-glGld.R 67c8a58bb4eae446837a53870951568f *R/builtin-gmmGmm.R a6cbf934be32808c358fdeef098db076 *R/builtin-hypHyperbolicDist.R 0004a95d44ff7d50c7e04a010c58d55a *R/builtin-kweightsSandwhich.R a9c6cb84bd6f4aac47a78f44dd121485 *R/builtin-posdefCorpcor.R 72982e50ded9b99c3fc6dd906017f7b1 *R/builtin-ssdenGss.R 1d2cbcf379d68cb931140e978c6e9f94 *R/builtin-testNortest.R cf364809f14386d246f282ef3d1c520e *R/builtin-varpieA2R.R e4c6cf02ac6c5974914de2dd0ba199a6 *R/dist-distCheck.R 98b77cdd2244cf92216c6d183cccc5cd *R/dist-distErrors.R 29cf22f34be9c21f7a2ebe9f5c6023c0 *R/dist-distPlot.R a50a29657af68e89fa382f592d4e3b3b *R/dist-fDISTFIT.R 6117cfd87045323629b288581d84bb7e *R/dist-gh.R 8bf25f981240c32eb54129e8f1774d43 *R/dist-ghFit.R 4b8248201f626f64d6436e954300f779 *R/dist-ghMode.R 9758759d12bb80676ad1ba469e85a4a9 *R/dist-ghMoments.R 1f08ad838ef1602b5352443353cc3739 *R/dist-ghRobMoments.R c1be5ed90afc50a402d75aa5b712486a *R/dist-ght.R 352fc72e7d3f198ff376786fccc54a40 *R/dist-ghtFit.R f94c6bc9301cd38c1d7186203e4fd56a *R/dist-ghtMode.R 836d4c53bdf200f478e2ae428c867f98 *R/dist-ghtMoments.R 6c4d9d60f43e06d2c4bcec7606ef53dc *R/dist-ghtRobMoments.R 280dad3bc6d7049e7751f302b4c41c0c *R/dist-gld.R ee63f3a3d9ae3f751e06217ce4d10003 *R/dist-gldFit.R 011ec9a3a04a4a42f3d88025d5b24cff *R/dist-gldMode.R 138b771667b07ff8a2f915da4a930cd2 *R/dist-gldRobMoments.R 1af9968a58742daaa6ea85275522e077 *R/dist-hyp.R 0bc2c84fefe4da3d94f71b4846f766b0 *R/dist-hypFit.R 2015d5d29657dcad0afa6e863b2c9a41 *R/dist-hypMode.R bb2d0141d60f5f414b5fd0b07af17029 *R/dist-hypMoments.R ffdd76b3d1334731b8bff39a528268f3 *R/dist-hypRobMoments.R a5b941585f02cf1437acb7cfc0983537 *R/dist-nig.R 13e318d6844a5f79e34a6b138f1cb54b *R/dist-nigFit.R c23bbac742d44c085bc90a65d3bac27d *R/dist-nigMode.R b590436a31a81156b0142f21fd0189a0 *R/dist-nigMoments.R 20d3bbf173d6859888f7aa60e0a24ba0 *R/dist-nigRobMoments.R 9a50e82b3c8ff24540e005923a4a3265 *R/dist-norm.R c52c5515ea19f978f8b68311fb9ddd35 *R/dist-normFit.R cbc3d0a4e92ce7b44c8d17f54b4bb981 *R/dist-normRobMoments.R 231b1fe2b3ef6329f8be3116c34fd3d6 *R/dist-sgh.R 37e60252dc65afb05771c6d72e525816 *R/dist-sghFit.R de3c22a7df5d15ce659958f85e4528fe *R/dist-sght.R 22e33e429227136eabdad1e555450497 *R/dist-snig.R 66614d9beba7481023d18a7b234fb571 *R/dist-snigFit.R d206c14762b5b25c3f8e989f2a0d6b7f *R/dist-ssd.R 7321facfffa28afbb6c9583b22721c18 *R/dist-ssdFit.R e20e747e082f0a53ccc5dc97bc8cff12 *R/dist-stableFit.R 3ddeb452b4e2193ee1e37a4ba4784ed9 *R/dist-tFit.R 6310a3d541b0cba7e66aa6fae80f2aa2 *R/gui-HeavisideSlider.R b205ead2f9afe3c05cf2eb13ea507dcc *R/gui-ghSlider.R cbc1dfa6ffdf56cb9e76a2b31d64e8e8 *R/gui-hypSlider.R 42495b3ec667becf5b77b28b5a4dcdad *R/gui-nigSlider.R cbe245a07fd1e69eb4a0e8bcfa55f0ae *R/gui-returnSeries.R 44ebae33f22de3d79de7570a22099259 *R/gui-sliderMenu.R 85e5ddc55fade77ef2187de317deb5de *R/gui-stableSlider.R 0cc355beafa7fe51f0c35623ddb7402c *R/gui-stylizedFacts.R b37d712d1f6384ad1438bdc971af07dc *R/matrix-colVec.R 7562acbc92a05d4fd18f472e43917e4c *R/matrix-gridVector.R 7afca5e9563b5428b4550e0911cb642b *R/matrix-hilbert.R 29e9b037067e50152d37adae94f098ea *R/matrix-inv.R 133e5e0d1a678d04b2d66defdbe8b9e5 *R/matrix-kron.R 558bb6ccb294e205b7c6e1b782fac794 *R/matrix-norm.R e52ed1b2a1adfe256bc1f89bb9ae692a *R/matrix-pascal.R 86151308d9aeea94adce506f7c5eb7b6 *R/matrix-pdl.R 2f94fcf4c541b7fd4178f9737a7aeca8 *R/matrix-posDefinite.R e90d16a560eea3bf26274c9e5235595c *R/matrix-rk.R 6e14878a4530e016b8490979260222fb *R/matrix-tr.R ede2618da3560e7959bc4405072f472b *R/matrix-triang.R 5e4712c5ff5aa6f91f7e768870472411 *R/matrix-tslag.R f393c0143a8b87ff823e1949f0d5129e *R/matrix-vech.R bb6e21d9d2b783ff1c5661c8d9cf7f42 *R/plot-acfPlot.R 7f1473f275facd795c818a90bac1941a *R/plot-boxPlot.R 3ce562c8656d12c509d1b1a8528bdccf *R/plot-counts.R 22c7476ebac41552b32eb1768bb87352 *R/plot-histPlot.R f3bd5ea3ebae34d40142cffbd952f5e2 *R/plot-qqPlot.R 015f6c82c747eb243b68e5691027f093 *R/plot-scalinglawPlot.R 14f8b924429c53bf7befe32b284c4678 *R/plot-seriesPlot.R 8f96ad02901ab16399f1ae727311915f *R/plot-subPlot.R c2ee72fc50668d9aa7a75a68ef8a3fc7 *R/plot-subStars.R 53be74d03ac075fc2342baa18e5381e7 *R/plot-varpie.R fcf1b73e6095fc8c761aff1b0e5b7c64 *R/plot.R 37c86a634b613627a675d9fb87e70e7a *R/stats-basicStats.R 89156555079e93437a20c227b6085c9f *R/stats-interpAkima.R 1d6dfcc67c5a2146a0caf46d0c03ef97 *R/stats-interpKrige.R 0ae6a37590fe7ae916fdcec6c7c8d51f *R/stats-interpLinear.R 34bb0e99137555ed24d58104e00224b8 *R/stats-maxdd.R 3e811cb50eeabb3081ff6785a0f15242 *R/stats-rowStats.R 780d742fc94c891d2e4686cd0d0e5cb2 *R/stats-sampleLmoments.R 04b9dfc95e844845a4d32ba6ceb26916 *R/stats-sampleRobMoments.R 684aaf5d0113b59ea761d32d082f6a88 *R/test-correlationTest.R 913c0c5dcdd3c2955aad33b8012c8654 *R/test-fHTEST.R 868cf5dfaf29079d42fec7dc2b55c8bd *R/test-jbALM.R a0a6ffb1408161fced8d13daa02a5414 *R/test-jbLM.R d7f1ab56ff37cf7a4d3866b9c6f634c9 *R/test-jbTable.R 35e8e30c1601da53eae4c4cabfd91ad4 *R/test-ks2Test.R f1fcfd9190a65800f207f2f858975812 *R/test-locationTest.R 398a23610628587198e1b8741b4833bc *R/test-normalityTest.R e7734f1b41dd64375aa9b88b7b2b9fa9 *R/test-scaleTest.R a53d00b11324083b45977e12aa9aa3d5 *R/test-varianceTest.R 9caadcd15ee4bcdd10cdda8eed49773e *R/utils-Heaviside.R d4a0f6d4aa1c21be61ababfc7a446596 *R/utils-as.matrix.ts.R e2613d6b8811ab1839ca927f86647c0a *R/utils-baseMethods.R 373358ee9825da0e06c3252100ce3ba2 *R/utils-characterTable.R 61ea38c84d0b41c558a52b602ae66adc *R/utils-colIds.R d2c88f865e8b9d8cdcb98746ff49fd28 *R/utils-colorLocator.R 5be20bfd5a7c6fe70399f50ba2e8b5c2 *R/utils-colorPalettes.R 1ad6b853b24bcc87853214ceda8e837e *R/utils-colorRGB.R 8f6640f506d2cd42a8f6cdd766e3fb04 *R/utils-colorTable.R c87af125e323fe0a55f5e9631bdd631e *R/utils-decor.R 10840c90662a81cef6ca88837f09aa90 *R/utils-getS4.R 8f1fce2695c26fb68137032c22c83b2e *R/utils-hessian.R a4317b50047273b3aaa2837553ca411b *R/utils-interactivePlot.R 06e4d9d413f2d012f2d530a5b1308ea9 *R/utils-listDescription.R 1b4a2d83897f75fcd598cb570888e567 *R/utils-listFunctions.R 7c662794745ddd161b74d36eb176d34a *R/utils-listIndex.R 30e266228d89a6875055d93da85a7369 *R/utils-printControl.R 32f3f898e525ff7311d2adfd0158c57b *R/utils-randLCG.R c357583eaf2867c2169ba1cebaffce0a *R/utils-recessionLines.R 451a02fdd0dd4249abbe8f8399f4296e *R/utils-symbolTable.R c695119e203d0913f791a9fc5736269b *R/utils-unitrootNA.R 4060dc43980b3319fb64ff6de9ce9cd8 *R/zzz.R f32fab9414543f541655695cab8f18f6 *data/Capitalization.R 4b326acb0fcbf684bd71e3c206c99521 *data/DowJones30.csv fda23a724e2a413b84479b354343085e *data/HedgeFund.R e46f424af4c2b42aa36049096368374d *data/PensionFund.csv 04bb8e032fea892a94da523b3851d0b9 *data/SWXLP.csv 272418e0cb35c7b29a956524f512d154 *data/cars2.csv 63a08580cf247052d3e8c939e75e2928 *data/msft.dat.csv 56c8a40061447d94384293897e075216 *data/nyse.csv 307630033a572c55e705646b463153f7 *data/swissEconomy.R afc154010f073fc4c538c20c3327262a *data/usdthb.csv 0c421832d488f624a5beccfda671d3e8 *inst/unitTests/HeavisideSlider.R 6763e1b8ea6f19e99e1d9c55a5b19b71 *inst/unitTests/Makefile 89cb4d984e816d3e9757b715cab4cb81 *inst/unitTests/runTests.R de0f8863a9c90edb00db6a08235cb153 *inst/unitTests/runit.DistributionFits.R 0102fbf3733ee1d531346e67ddf03c54 *inst/unitTests/runit.Heaviside.R 3cc654e44e24e279a84a95ad8318074c *inst/unitTests/runit.HyperbolicDistribution.R cfb05fc99e5ff12dcacbbb3cd9eab96d *inst/unitTests/runit.JarqueBeraPValues.R cc9658c6f0941cfa4a5e777662c4119e *inst/unitTests/runit.NormalityTests.R 052a01156b8f414fd190745a3d38a712 *inst/unitTests/runit.ReturnSeriesBasics.R e31b7c372eeb9b0dedb040f9cfeab918 *inst/unitTests/runit.StylizedFacts.R 04059bd02ee724883db4ed97bcc8ac2c *inst/unitTests/runit.Sys.putenv.R a18ec7eb9365d08e58310b3d5f65d3f1 *inst/unitTests/runit.TwoSampleTests.R ffd0596f55e88d20aa30838bc189ae0c *inst/unitTests/runit.akimaInterp.R c850b34ec9bd1b34c961042323dc6846 *inst/unitTests/runit.as.matrix.ts.R a2dd466a4ff1016d53f5f9fe9c50d0e1 *inst/unitTests/runit.asPOSIXlt.R 1cbddb4d80672227e7682c6a8914578f *inst/unitTests/runit.baseMethods.R fbc8fcc1f3c147593d3563f37fa7c183 *inst/unitTests/runit.characterTable.R 3e7706b8ca9d2ec5d6b7368a60c10cdd *inst/unitTests/runit.colStats.R 96a6e8284e0face7ebfd67cba94d1dc2 *inst/unitTests/runit.colorLocator.R db48395eccfc337d5b72d93d45c32cdf *inst/unitTests/runit.colorPalette.R dfac6135cafee2c0b43cce9526aa426b *inst/unitTests/runit.colorTable.R 35c24e30a6038681f8dc33bfb1654723 *inst/unitTests/runit.decor.R 85b7eb4084d6870897f159be39608fef *inst/unitTests/runit.description.R f98f564ce76b6f95c11d09aa519dbf4d *inst/unitTests/runit.distCheck.R 4408e73db29d5696a13feaa05450b2c0 *inst/unitTests/runit.fHTEST.R 59d3f83d1738f91bc9370c340fa4c1a8 *inst/unitTests/runit.getS4.R 5f5e3b2185b158d1aaaf7cf8e200e82a *inst/unitTests/runit.gridVector.R 0cb9ac6798a2781ba6c6aff2b8cce6c2 *inst/unitTests/runit.interactivePlot.R f1288af1db8eaed3e9d77af7510fdc95 *inst/unitTests/runit.julian.R 7367ea2ca14be018d926e9d0c3aec6e9 *inst/unitTests/runit.krigeInterp.R d5020025a2bb136cd8466e527952a23e *inst/unitTests/runit.kurtosis.R 8ef5b524f61ff91113bc4c93c8747139 *inst/unitTests/runit.lcg.R 2bbbfd7c82215a2023f549f003b8b55e *inst/unitTests/runit.linearInterp.R 23ae1d0fc57dca6a7461a1f5bdc8ac30 *inst/unitTests/runit.listDescription.R 567a025db962aec9dc30fdf18d2a5268 *inst/unitTests/runit.listFunctions.R 3424d43652d1449383a468520e1bfc97 *inst/unitTests/runit.listIndex.R ded7f6d681b04c792dd7fa047e21e486 *inst/unitTests/runit.matrixAddon.R bdc95406e85f77930d3e62d78f8fd7d8 *inst/unitTests/runit.plot.R 92b57cc63c8d8dee8cb6641a4c387077 *inst/unitTests/runit.print.R 86743547753fd83bb1d17e3da6e615c4 *inst/unitTests/runit.rgb.R 34314fcbaf60cfa3d0c45293ce9fb79b *inst/unitTests/runit.rowStats.R 9730e5c0167058294c474c768c6e3957 *inst/unitTests/runit.skewness.R b4d9660bfd948709c2c6831c98954cfe *inst/unitTests/runit.sliderMenu.R 18d512459825fb6d09f231d703d17262 *inst/unitTests/runit.subPlot.R 18d512459825fb6d09f231d703d17262 *inst/unitTests/runit.subStars.R 6495ad3269a664dbf83b9fec28e3f7ae *inst/unitTests/runit.symbolTable.R 7a10a7e865d873328e8b2fcd7e994f37 *inst/unitTests/runit.unitrootNA.R 088ce150aea6acc86bd2fc282b31530e *man/00fBasics-package.Rd 84d73ddebf9abc22bf9b007a6e617b46 *man/baseMethods.Rd a6094cac5d396573c8ed4a255d413629 *man/data-examples.Rd dad370ad3feec1958c40fc9f62ab0a2a *man/dist-DistributionFits.Rd 4952a1a7477c4e0c6018fe5e877357d6 *man/dist-distCheck.Rd 64236ff6e82998fc3c3e075472e00ca8 *man/dist-gh.Rd 23c8404e3a8a4503747068c0012df2a0 *man/dist-ghFit.Rd 3879c4744dba5c7cac645288258d3ea8 *man/dist-ghMode.Rd 106ae8c3a1fc7012f1b9cbca6ae8d44e *man/dist-ghMoments.Rd a8817ef68f580676a5f00ea9b769ff90 *man/dist-ghRobMoments.Rd 11957987dd8d2e6363801ef104ad7af7 *man/dist-ghSlider.Rd e44cc0e1f587415211fb3e45014f2273 *man/dist-ght.Rd 5058faeeaf1286317e1ff4a671469f5f *man/dist-ghtFit.Rd 467dcb221a07f637fdfda6bd6f544c44 *man/dist-ghtMode.Rd b6d779d320ec921d00d432e004c29b2e *man/dist-ghtMoments.Rd 613539396bcef3bdd891d0a26471aa92 *man/dist-ghtRobMoments.Rd d3753a413fc6253957ba1494285a3009 *man/dist-gld.Rd 8f78a99a2816aee9e9b51077536277e8 *man/dist-gldFit.Rd e2d8f1b76eb4131a568eeb98bf4c522e *man/dist-gldMode.Rd a20a485cf24426a5a91b9f0d347705f3 *man/dist-gldRobMoments.Rd ccc6c6328bca6a51d9589fdc33d88670 *man/dist-hyp.Rd f50ccaff9bff81faf58750fe26bbc58a *man/dist-hypFit.Rd 49755a247813f20934255113b1bc8523 *man/dist-hypMode.Rd c2b607c622445e32162b54f07020f405 *man/dist-hypMoments.Rd 339253bd31ab9d8af9334854fe782293 *man/dist-hypRobMoments.Rd 7c8d1f55de5340e3538bf64f47489482 *man/dist-hypSlider.Rd e690a940c113011350a8b7cb259ebe2b *man/dist-nig.Rd 76392b1364663a76611c5a0b46757c0f *man/dist-nigFit.Rd 664308b52e4a906b4bde547307f1a8a5 *man/dist-nigMode.Rd 50c43d925e6ee25582ab1f0cda48a403 *man/dist-nigMoments.Rd 70da61e0e0d99eeecf45123ae9b3058d *man/dist-nigRobMoments.Rd 21ed4bbcf39fffb552e01927ab52de39 *man/dist-nigShapeTriangle.Rd 0179caba1df795d5339e7c443a12c424 *man/dist-nigSlider.Rd 0f441c63b928783f52f05e6bea808dd9 *man/dist-normRobMoments.Rd 7cf690ac0ab43ba130039bf019ff0cf4 *man/dist-sgh.Rd cdfc96b67cc6c75c3c6c8828bc8b97b8 *man/dist-sghFit.Rd f70e06310b305ec450072050d5a40468 *man/dist-sght.Rd 08431a697607057016adf76284cb31a2 *man/dist-snig.Rd 86c8f424fdf944ca69a880c24caad37c *man/dist-snigFit.Rd 75c578b3792c18bb0e63f1a19cb38505 *man/dist-ssd.Rd 315fc215e7dcc9d80517014cf7b93274 *man/dist-ssdFit.Rd 276536db46bb86f6d59e790316788650 *man/fBasics-deprecated.Rd 2bdb0b549be5de60c262c1ef6b0649f9 *man/matrix-colVec.Rd 1eda72553ee30643b3d1493089c4bfb3 *man/matrix-gridVector.Rd c291142800d241b4e9ba3b6010f2e77d *man/matrix-hilbert.Rd d23b83b079aee2d6486eb4cd3e5a5695 *man/matrix-inv.Rd 8e5e49f95869abcd8d34d0c984c36dd2 *man/matrix-kron.Rd dfbcd5147ee913bf4680d94d5cf4c813 *man/matrix-norm.Rd 7ee4b1d99dad7b0c9c204f042793eab3 *man/matrix-pascal.Rd 759e06d9c57da704c83ff2a4eb619f26 *man/matrix-pdl.Rd dd2597f6f0ee75b41557f0f256c8d423 *man/matrix-posDefinite.Rd 40fb884a90993fe2b28cd334a3e89d8a *man/matrix-rk.Rd 64fcfc2ba3fb83f289a5dd90f3449f67 *man/matrix-tr.Rd 2d3bf7e35374a2adc1929b53cfab8154 *man/matrix-triang.Rd 1fafa72f769b3a297eabedf4e5e20192 *man/matrix-tslag.Rd 93910483026828ced63949a22045f29c *man/matrix-vech.Rd b1afa3ba1ec92a6ed88fd72b6443016e *man/plot-acfPlot.Rd 7a2f3dd1f7025dcaee4d137fa283aa6d *man/plot-boxPlot.Rd 3df5fb37fef6ffa942c4dd05e7867649 *man/plot-histPlot.Rd 359c5d45bf8ae79f286086f50920f4e3 *man/plot-qqPlot.Rd 508af013a77b17c2099da9e536beee93 *man/plot-returnSeriesGUI.Rd c43e61280d097f59bcf599ba266376df *man/plot-scalinglawPlot.Rd ff0e78bf01cdb12a2024457b9b9293d4 *man/plot-seriesPlot.Rd 55b68f7292b19e3e1fb132ee8588a023 *man/stableSlider.Rd 7c3da32e0586e5377b038bc8bbb328f6 *man/stats-basicStats.Rd 2cbb94deaa4961487ded5a893fd92e7a *man/stats-interpAkima.Rd 9677f30617db777ca36507caf494c3e6 *man/stats-interpKrige.Rd 32dec54e0b009ea9209783441ca691d6 *man/stats-interpLinear.Rd 2fa0b773424b04e1b25d7c5805fa6855 *man/stats-maxdd.Rd 0d3b8f6272099cec5a6d8d3640402f72 *man/stats-rowStats.Rd 723c7041db6027ca20c0d884c9400b65 *man/stats-sampleLMoments.Rd a3bfba0cf67f616a83d04c3a61ba7f60 *man/stats-sampleRobMoments.Rd 26f5da8c7556e06e4cac68cd6618a9ac *man/test-correlationTest.Rd 68ba18cc4ae7adb98ade40e97ad7fd5c *man/test-fHTEST.Rd 6619f73af14579bed196cc15466edc50 *man/test-ks2Test.Rd 5b66eb5663f3dae41dbaade32b0a3b4d *man/test-locationTest.Rd 9c512efba3af6129eb6d8092d7ef6808 *man/test-normalityTests.Rd 73347e9052c83dc8cab1680f364e1205 *man/test-scaleTest.Rd 04608fb5dbf062dff84357b7f4132c1d *man/test-varianceTest.Rd a5f0bbe1f36e835219602e4abd71a2dc *man/utils-Heaviside.Rd f248ceb85e168f6d9db179a539b6e813 *man/utils-characterTable.Rd 7acab6d95ee7ef15cf53bd8b1fc5b97e *man/utils-colIds.Rd a44a484d84aece3fa908a9305abea16a *man/utils-colorLocator.Rd 8feefca38253825ab75485b3840461fc *man/utils-colorPalette.Rd a46398307966bfb209d153b4c29574fc *man/utils-colorTable.Rd 28a594ec7920420e0e0d09fc9cf07600 *man/utils-decor.Rd 9caddfa1aea06ec75aa61383899310d1 *man/utils-getS4.Rd 6f7e3a07ed48ac9e932dc86cb36bacf5 *man/utils-hessian.Rd 9985275f7630b95f84025419625074b4 *man/utils-interactivePlot.Rd 3a0698d165d719a2a5010cd5cf17d011 *man/utils-listDescription.Rd 2175101a14c1b7456e94ab704fad3a1b *man/utils-listFunctions.Rd c5d24e44dc4c42073c5b5786214c1dc3 *man/utils-listIndex.Rd a08d11fa6ccf9ea29d1d407c57010d6c *man/utils-printControl.Rd 15b03f23432558e8826d2dec56d47f52 *man/utils-randLCG.Rd b10d2eecc59ee07dd7ebb78142d2582b *man/utils-symbolTable.Rd 8290d2e9740414e315237f0d5d4024bb *src/Makevars 2841cdbbc20e8b5b98de0b6abc2e252f *src/gld.c 5a5101f57ae20ba3f930970289753826 *src/nig.c 46963bfeff05e6aa8353544b7627cbda *tests/doRUnit.R fBasics/DESCRIPTION0000644000176200001440000000211113203550545013327 0ustar liggesusersPackage: fBasics Title: Rmetrics - Markets and Basic Statistics Date: 2017-11-12 Version: 3042.89 Author: Diethelm Wuertz [aut], Tobias Setz [cre], Yohan Chalabi [ctb] Martin Maechler [ctb] Maintainer: Tobias Setz Description: Provides a collection of functions to explore and to investigate basic properties of financial returns and related quantities. The covered fields include techniques of explorative data analysis and the investigation of distributional properties, including parameter estimation and hypothesis testing. Even more there are several utility functions for data handling and management. Depends: R (>= 2.15.1), timeDate, timeSeries Imports: stats, grDevices, graphics, methods, utils, MASS, spatial, gss, stabledist ImportsNote: akima not in Imports because of non-GPL licence. Suggests: akima, RUnit, tcltk LazyData: yes License: GPL (>= 2) Encoding: UTF-8 URL: https://www.rmetrics.org NeedsCompilation: yes Packaged: 2017-11-17 06:26:29 UTC; Tobias Setz Repository: CRAN Date/Publication: 2017-11-17 12:09:09 UTC fBasics/ChangeLog0000644000176200001440000006234613202116740013405 0ustar liggesusers2013-04-30 chalabi * DESCRIPTION, NAMESPACE, R/builtin-ssdenGss.R, R/zzz.R, src/gss_a.f, src/gss_b.c: gss is now an import package 2012-09-21 chalabi * ChangeLog, DESCRIPTION: Updated ChangeLog and DESC files 2012-09-20 mmaechler * DESCRIPTION, NAMESPACE, R/dist-stable-deprecated.R, inst/unitTests/runit.DistributionFits.R, man/fBasics-deprecated.Rd: no longer re-export the [dpqr]stable() functions from "stabledist"; and more reasonable unitTests for those 2012-09-14 chalabi * ChangeLog, DESCRIPTION: updated DESC and ChangeLog * DESCRIPTION: updated version number * R/utils-Sys.putenv.R: Removed deprecated putenv patch 2012-08-22 chalabi * ChangeLog, DESCRIPTION: updated DESC and ChangeLog * DESCRIPTION, NAMESPACE, R/stats-interpAkima.R, R/stats-interpLinear.R: Removed code that was copied from akiam (0.5-1) to avoid external .Fortran calls to akima package. * DESCRIPTION: updated version number * ChangeLog: updated Changelog * DESCRIPTION: added reference to code from akima (0.5-1) package 2012-08-12 chalabi * DESCRIPTION: updated version number * NAMESPACE, R/test-normalityTest.R: shapiroTest calls now base R function shapiro.test * DESCRIPTION: added stats pkg in Depends 2012-03-21 chalabi * R/utils-getS4.R, man/utils-getS4.Rd: updated manual page and getArgs() 2012-03-20 chalabi * NAMESPACE, R/builtin-ssdenGss.R, src/gss.f, src/gss_a.f, src/gss_b.c: removed fixed warnings generated by fortran routine from gss package * DESCRIPTION: updated DESC 2012-03-19 chalabi * R/builtin-ssdenGss.R, R/gui-sliderMenu.R, R/gui-stableSlider.R, R/utils-listFunctions.R: fixed partial argument names 2012-02-16 mmaechler * NAMESPACE, R/builtin-ssdenGss.R, R/dist-nig.R, R/gui-sliderMenu.R, R/utils-colorLocator.R, man/utils-colorLocator.Rd: more cosmetic; notably first round of "partial argument match" fixes * src/nig.c: add #include .. (thanks to Jan Deleeuw) 2012-01-14 mmaechler * DESCRIPTION, NAMESPACE, R/utils-getS4.R, man/00fBasics-package.Rd, man/utils-getS4.Rd: do not export getCall() -- which conflicts with R >= 2.14, in that case * src/gld.c, src/nig.c: fix C code {stderr, exit} 2011-09-23 mmaechler * DESCRIPTION: remove deprecated "LazyLoad" entry 2011-08-02 chalabi * ChangeLog, DESCRIPTION: updated DESC and ChangeLog * R/utils-getS4.R, man/fBasics-deprecated.Rd, man/stableSlider.Rd, man/utils-getS4.Rd: fixed warnings with R CMD check 2011-06-22 mmaechler * NAMESPACE, R/dist-distCheck.R, R/utils-getS4.R, man/utils-getS4.Rd: getCall() -- adapt to future R 2.14.x ff 2011-06-22 chalabi * NAMESPACE: updated NAMESPACE * man/dist-distCheck.Rd, man/dist-ghRobMoments.Rd, man/dist-ghtRobMoments.Rd, man/dist-gldMode.Rd, man/dist-hypRobMoments.Rd, man/dist-nigRobMoments.Rd, man/dist-normRobMoments.Rd, man/dist-sght.Rd, man/fBasics-deprecated.Rd, man/stableSlider.Rd, man/utils-hessian.Rd: updated man pages with new functions * R/dist-hypRobMoments.R, R/dist-stable-deprecated.R, R/utils-colorRGB.R, R/utils-getS4.R: getSlot() is now a wrapper of slot() function 2011-05-04 chalabi * man/test-normalityTests.Rd: added credits to Paul Johnson for earlier funcions based on his Fortran code. 2011-02-03 mmaechler * DESCRIPTION, NAMESPACE, R/dist-distCheck.R, man/dist-distCheck.Rd: rename package "stable" to "stabledist" - as "stable" has existed for many years in Jim Lindsey`s off-CRAN collection 2011-01-31 mmaechler * DESCRIPTION: update Version ('stable' needs it for unit tests) * man/dist-distCheck.Rd: update: forgot new arg.s in usage * man/fBasics-deprecated.Rd: man for keep deprecated [dpqr]stable() * R/dist-stable-deprecated.R: keep "back compatibility" version of stable * R/dist-distCheck.R, man/dist-distCheck.Rd: (changes from a week ago:) "control" attributes only in the fBasics "deprecated" versions; add utils; start re-enabling the unit tests 2011-01-24 mmaechler * DESCRIPTION, NAMESPACE, R/dist-stable.R, R/dist-stableMode.R, R/gui-stableSlider.R, inst/unitTests/runit.StableDistribution.R, man/dist-stable.Rd, man/dist-stableMode.Rd, man/stableSlider.Rd: from fBasics, factor out a new "stable" package; with distributions, but not (yet?) stableFit() etc 2010-10-26 chalabi * NAMESPACE: updated NAMESPACE 2010-07-23 chalabi * inst/DocCopying.pdf: removed DocCopying.pdf license is already specified in DESCRIPTION file 2010-05-29 wuertz * R/utils-getS4.R, man/utils-getS4.Rd: man page updated * R/utils-getArgs.R: getArgs moved to getS4 * NAMESPACE, R/builtin-glGld.R, R/builtin-posdefCorpcor.R, R/builtin-testNortest.R, R/builtin-varpieA2R.R, R/dist-distCheck.R, R/dist-distErrors.R, R/dist-distPlot.R, R/dist-fDISTFIT.R, R/gui-HeavisideSlider.R, R/gui-ghSlider.R, R/gui-nigSlider.R, R/gui-returnSeries.R, R/utils-Sys.putenv.R, R/utils-getArgs.R, R/utils-getS4.R, R/utils-listDescription.R, R/utils-listFunctions.R, R/utils-listIndex.R, R/utils-printControl.R, R/utils-randLCG.R, R/utils-unitTest.R, man/utils-getS4.Rd: getArgs added, minor mods in some functions, namespace adapted 2010-03-24 chalabi * NAMESPACE, R/builtin-xlsGdata.R, R/read-download.R, R/read-lines.R, R/read-lynx.R, R/read-split.R, R/read-xls.R, inst/perl, man/read-download.Rd, man/read-lines.Rd, man/read-lynx.Rd, man/read-split.Rd, man/read-xls.Rd: moved new read.<> functions from fBasics to fImport 2010-03-09 dscott * man/test-correlationTest.Rd, man/test-fHTEST.Rd, man/test-ks2Test.Rd, man/test-locationTest.Rd, man/test-normalityTests.Rd, man/test-scaleTest.Rd, man/test-varianceTest.Rd: Fixed spelling mistakes * src/nig.c: changed XMAX for 64 bit compatiblitiy and removed unused headers 2010-03-02 wuertz * R/builtin-xlsGdata.R: xls byuiltin added 2010-02-23 wuertz * NAMESPACE: namespace adapted * NAMESPACE: namespace adapted * R/builtin-xlsGdata.R, R/read-download.R, R/read-lines.R, R/read-lynx.R, R/read-split.R, R/read-xls.R, inst/perl, inst/perl/IO, inst/perl/IO/AtomicFile.pm, inst/perl/IO/InnerFile.pm, inst/perl/IO/Lines.pm, inst/perl/IO/Scalar.pm, inst/perl/IO/Scalar.pm.html, inst/perl/IO/ScalarArray.pm, inst/perl/IO/Stringy.pm, inst/perl/IO/Wrap.pm, inst/perl/IO/WrapTie.pm, inst/perl/OLE, inst/perl/OLE/Storage_Lite.pm, inst/perl/Spreadsheet, inst/perl/Spreadsheet/ParseExcel, inst/perl/Spreadsheet/ParseExcel.pm, inst/perl/Spreadsheet/ParseExcel/Dump.pm, inst/perl/Spreadsheet/ParseExcel/FmtDefault.pm, inst/perl/Spreadsheet/ParseExcel/FmtJapan.pm, inst/perl/Spreadsheet/ParseExcel/FmtJapan2.pm, inst/perl/Spreadsheet/ParseExcel/FmtUnicode.pm, inst/perl/Spreadsheet/ParseExcel/SaveParser.pm, inst/perl/Spreadsheet/ParseExcel/Utility.pm, inst/perl/html-parser, inst/perl/html-parser/html-ascii.pl, inst/perl/html-parser/html-parser.html, inst/perl/html-parser/html-to-ascii.pl, inst/perl/html-parser/html-to-rfc.pl, inst/perl/html-parser/parse-html.pl, inst/perl/html-parser/rfc.pl, inst/perl/html-parser/tformat.pl, inst/perl/xls2csv.pl, man/00fBasics-package.Rd, man/read-download.Rd, man/read-lines.Rd, man/read-lynx.Rd, man/read-split.Rd, man/read-xls.Rd: read tools added for reading files from internet 2010-02-21 dscott * ChangeLog, NAMESPACE, R/builtin-glGld.R, R/dist-gld.R, R/dist-gldFit.R: Some fixes to gld functions 2010-02-09 chalabi * DESCRIPTION: updated version number 2010-02-08 chalabi * DESCRIPTION: updated DESC files * man/utils-colorLocator.Rd: update Rd files 2009-12-08 wuertz * DESCRIPTION: description file updated 2009-12-07 wuertz * man/00fBasics-package.Rd: text updated 2009-12-06 wuertz * DistributionsStatus: no longer needed * DESCRIPTION: description updated * DESCRIPTION, man/00fBasics-package.Rd: description file and manual package info updated * man/plot-interactivePlot.Rd, man/print.Rd, man/rand-lcg.Rd, man/returnSeriesGUI.Rd: obsolete man files removed * src/Makevars, src/gld.c, src/gss.f: src files added * R/builtin-posdefCorpcor.R, R/builtin-testNortest.R, R/builtin-varpieA2R.R, R/lines-recessionLines.R, R/list-listDescription.R, R/list-listFunctions.R, R/list-listIndex.R, R/print.R, R/rand-lcg.R, R/utils-listDescription.R, R/utils-listFunctions.R, R/utils-listIndex.R, R/utils-printControl.R, R/utils-randLCG.R, R/utils-recessionLines.R, man/00fBasics-package.Rd: builtin and util scripts added * R/test-correlationTest.R, R/test-fHTEST.R, R/test-jbALM.R, R/test-jbLM.R, R/test-jbTable.R, R/test-ks2Test.R, R/test-locationTest.R, R/test-scaleTest.R, R/test-varianceTest.R: tests updated * R/test-NormalityTests.R, R/test-normalTest.R, R/test-normalityTest.R: normality tests merged * man/00fUtilities-package.Rd, man/colorLocator.Rd, man/colorPalette.Rd, man/colorTable.Rd, man/dist-ssd.Rd, man/interp-akimaInterp.Rd, man/interp-krigeInterp.Rd, man/interp-linearInterp.Rd, man/listDescription.Rd, man/listFunctions.Rd, man/listIndex.Rd, man/plot-returnSeriesGUI.Rd, man/stats-interpAkima.Rd, man/stats-interpKrige.Rd, man/stats-interpLinear.Rd, man/utils-colorLocator.Rd, man/utils-colorPalette.Rd, man/utils-colorTable.Rd, man/utils-getS4.Rd, man/utils-interactivePlot.Rd, man/utils-listDescription.Rd, man/utils-listFunctions.Rd, man/utils-listIndex.Rd, man/utils-printControl.Rd, man/utils-randLCG.Rd: man pages updated * man/00fBasics-package.Rd, man/baseMethods.Rd: man updated * R/builtin-HyperbolicDist.R, R/builtin-gelGMM.R, R/builtin-gelGmm.R, R/builtin-gelGmm2.R, R/builtin-gld.R, R/builtin-gmmGMM.R, R/builtin-gmmGmm.R, R/builtin-gmmGmm2.R, R/builtin-gss.R, R/builtin-sandwichGMM.R, R/color-Locator.R, R/color-Palettes.R, R/color-RGB.R, R/color-Table.R, R/dist-ghFit.R, R/dist-ghMode.R, R/dist-nig.R, R/dist-ssd.R, R/dist-stableFit.R, R/interp-akimaInterp.R, R/interp-krigeInterp.R, R/interp-linearInterp.R, R/matrix-colVec.R, R/matrix-gridVector.R, R/matrix-inv.R, R/matrix-kron.R, R/matrix-norm.R, R/matrix-pascal.R, R/matrix-pdl.R, R/matrix-posDefinite.R, R/matrix-rk.R, R/matrix-tr.R, R/matrix-triang.R, R/matrix-tslag.R, R/matrix-vech.R, R/plot-boxPlot.R, R/plot-interactivePlot.R, R/plot-qqPlot.R, R/plot-seriesPlot.R, R/stats-basicStats.R, R/stats-interpAkima.R, R/stats-interpKrige.R, R/stats-interpLinear.R, R/stats-maxdd.R, R/stats-rowStats.R, R/utils-Heaviside.R, R/utils-colorLocator.R, R/utils-colorPalettes.R, R/utils-colorRGB.R, R/utils-colorTable.R, R/utils-decor.R, R/utils-getS4.R, R/utils-interactivePlot.R, R/utils-symbolTable.R, R/utils-unitrootNA.R: functions sorted and partly scripts renamed * R/builtin-gelGmm2.R, R/builtin-glGld.R, R/builtin-gmmGmm2.R, R/builtin-hypHyperbolicDist.R, R/builtin-kweightsSandwhich.R, R/builtin-ssdenGss.R: builtin functions renamed 2009-12-03 wuertz * NAMESPACE, R/dist-distErrors.R, R/dist-distPlot.R, R/dist-gh.R, R/dist-ghFit.R, R/dist-ghMode.R, R/dist-ghMoments.R, R/dist-ghRobMoments.R, R/dist-nigFit.R, man/00fBasics-package.Rd, man/dist-gh.Rd, man/dist-ghFit.Rd, man/dist-ghMode.Rd, man/dist-ghMoments.Rd, man/dist-ght.Rd, man/dist-ghtFit.Rd, man/dist-ghtMode.Rd, man/dist-ghtMoments.Rd, man/dist-hypMoments.Rd, man/dist-nigMoments.Rd, man/dist-ssd.Rd, man/dist-ssdFit.Rd, man/dist-stable.Rd, man/dist-stableMode.Rd: man pages, NAMESPACE updated and som minor new functionalities added * R/dist-ghMoments.R, R/dist-ghtMoments.R, R/dist-hypMoments.R, R/dist-nigMoments.R, R/lines-recessionLines.R: true moments added * R/dist-nigFit.R, R/utils-hessian.R: standard errors for nigFit added 2009-12-02 wuertz * DistributionsStatus, NAMESPACE, R/dist-ghMoments.R, R/dist-ght.R, R/dist-hypMoments.R, R/dist-nigMoments.R, R/dist-sght.R: further moment functions added * R/dist-ghMoments.R: gh central moments added 2009-12-01 wuertz * NAMESPACE, R/dist-gh.R, R/dist-ghMoments.R, R/dist-ght.R, R/dist-ghtMode.R, R/dist-gld.R, R/dist-hyp.R, R/dist-hypMoments.R, R/dist-hypRobMoments.R, R/dist-nig.R, R/dist-nigMoments.R, R/dist-norm.R, R/dist-normFit.R, R/dist-normRobMoments.R, R/dist-sgh.R, R/dist-sghFit.R, R/dist-snig.R, R/dist-ssd.R, R/dist-stable.R, inst/unitTests/runit.HyperbolicDistribution.R, man/dist-StableDistribution.Rd, man/dist-ght.Rd, man/dist-gld.Rd, man/dist-hyp.Rd, man/dist-stable.Rd: distribution functionality upgraded, some man pages are still missing 2009-11-24 wuertz * DistributionsStatus, NAMESPACE, R/dist-nFit.R, R/dist-normFit.R: nFit renamed to normFit 2009-11-23 wuertz * R/dist-nigFit.R: log(var... updated in nigFit * R/dist-gldFit.R, man/dist-gldFit.Rd: gld mps modified 2009-11-22 wuertz * R/dist-gldFit.R, man/dist-gld.Rd: gld fit and distribution updated * DistributionsStatus, NAMESPACE, R/dist-gldFit.R, R/dist-nigFit.R, man/dist-nigFit.Rd: Yohan's var(MPS) for the nig added * NAMESPACE, R/builtin-gss.R, R/dist-gld.R, R/dist-gldFit.R, R/dist-ssd.R, R/dist-ssdFit.R, R/plot-varpie.R: namespace updated 2009-11-21 wuertz * R/plot-acfPlot.R, R/plot-boxPlot.R, R/plot-counts.R, R/plot-histPlot.R, R/plot-interactivePlot.R, R/plot-scalinglawPlot.R, R/plot-seriesPlot.R, R/plot-subPlot.R, R/plot-subStars.R, R/plot-varpie.R, R/plot.R: cod beautified and descriptions added for plot functions * R/plot-qqPlot.R, man/plot-qqPlot.Rd: qq plot for GLD distribution added * DESCRIPTION: builtin packages and authors added * man/dist-nigMode.Rd: nigMode manual page added * man/dist-ghtMode.Rd, man/dist-nigMoments.Rd: manual page information added * R/builtin-HyperbolicDist.R, R/builtin-gelGMM.R, R/builtin-gld.R, R/builtin-gmmGMM.R, R/builtin-gss.R, R/builtin-sandwichGMM.R, R/dist-hyp.R: builtin function documentation improved * R/builtin-HyperbolicDist.R: code borrowed from David Scott no moved to script file builtin-HyperbolicDist * man/dist-gld.Rd: examples modified * R/dist-nigFit.R: nig mps fit objective function renamed * NAMESPACE: namespace updated * DistributionsStatus: file distribution status added * R/dist-ghFit.R, R/dist-ghMode.R, R/dist-ghMoments.R, R/dist-ght.R, R/dist-ghtFit.R, R/dist-ghtMode.R, R/dist-gldMode.R, R/dist-hyp.R, R/dist-hypFit.R, R/dist-hypMode.R, R/dist-nFit.R, R/dist-nig.R, R/dist-nigFit.R, R/dist-nigMode.R, R/dist-nigMoments.R, R/dist-nigRobMoments.R, R/dist-nigStats.R, R/dist-sgh.R, R/dist-sghFit.R, R/dist-snig.R, R/dist-snigFit.R, R/dist-ssdFit.R, R/dist-stable.R, R/dist-stableFit.R, R/dist-stableMode.R, R/dist-tFit.R: distribution Functions updated, status list added * R/builtin-gelGMM.R, R/builtin-gld.R, R/builtin-gmmGMM.R, R/builtin-gss.R, R/color-Locator.R, R/color-Palettes.R, R/color-RGB.R, R/color-Table.R, R/dist-distCheck.R, R/dist-fDISTFIT.R, R/dist-gh.R, R/dist-ghRobMoments.R, R/dist-ght.R, R/dist-ghtFit.R, R/dist-ghtRobMoments.R, R/dist-gld.R, R/dist-gldFit.R, R/dist-gldMode.R, R/dist-gldRobMoments.R, R/dist-hyp.R, R/dist-hypFit.R, R/dist-hypMode.R, R/dist-nFit.R, R/dist-nig.R, R/dist-nigFit.R, R/dist-nigMode.R, R/dist-nigRobMoments.R, R/dist-nigStats.R, R/dist-sgh.R, R/dist-sghFit.R, R/dist-snig.R, R/dist-snigFit.R, R/dist-ssd.R, R/dist-ssdFit.R, R/dist-stable.R, R/dist-tFit.R, R/gui-HeavisideSlider.R, R/gui-hypSlider.R, R/gui-nigSlider.R, R/gui-returnSeries.R, R/gui-sliderMenu.R, R/gui-stableSlider.R, R/gui-stylizedFacts.R, R/interp-akimaInterp.R, R/interp-krigeInterp.R, R/interp-linearInterp.R, R/list-listFunctions.R, R/list-listIndex.R, R/matrix-colVec.R, R/matrix-gridVector.R, R/matrix-hilbert.R, R/matrix-inv.R, R/matrix-kron.R, R/matrix-norm.R, R/matrix-pascal.R, R/matrix-pdl.R, R/matrix-posDefinite.R, R/matrix-rk.R, R/matrix-tr.R, R/matrix-triang.R, R/matrix-tslag.R, R/matrix-vech.R, R/plot-acfPlot.R, R/plot-boxPlot.R, R/plot-histPlot.R, R/plot-interactivePlot.R, R/plot-qqPlot.R, R/plot-scalinglawPlot.R, R/plot-seriesPlot.R, R/plot-subPlot.R, R/plot-subStars.R, R/plot.R, R/print.R, R/rand-lcg.R, R/stats-maxdd.R, R/stats-rowStats.R, R/stats-sampleLmoments.R, R/test-NormalityTests.R, R/test-correlationTest.R, R/test-fHTEST.R, R/test-jbALM.R, R/test-jbLM.R, R/test-jbTable.R, R/test-ks2Test.R, R/test-locationTest.R, R/test-normalTest.R, R/test-scaleTest.R, R/test-varianceTest.R, R/utils-Heaviside.R, R/utils-Sys.putenv.R, R/utils-as.matrix.ts.R, R/utils-baseMethods.R, R/utils-characterTable.R, R/utils-colIds.R, R/utils-getS4.R, R/utils-symbolTable.R, R/utils-unitTest.R, R/utils-unitrootNA.R: code (header) beautified script files * NAMESPACE: namespace updated * R/builtin-gld.R, R/builtin-gss.R, R/dist-gh.R, R/dist-ghFit.R, R/dist-ghMoments.R, R/dist-ghRobMoments.R, R/dist-ghtRobMoments.R, R/dist-gld.R, R/dist-gldFit.R, R/dist-gldMode.R, R/dist-gldRobMoments.R, R/dist-gldRobust.R, R/dist-nigRobMoments.R, R/dist-nigRobust.R, R/dist-ssd.R, R/dist-ssdFit.R, R/stats-robMoments.R, R/stats-sampleLmoments.R, R/stats-sampleRobMoments.R: gh, gld and ssden distributions (new and extensions) added, Lmoments, robust stuff added * man/utils-characterTable.Rd: man page added * man/correlationTest.Rd, man/dist-gldRobMoments.Rd, man/test-correlationTest.Rd: same scripts renamed * man/Heaviside.Rd, man/NormalityTests.Rd, man/acfPlot.Rd, man/akimaInterp.Rd, man/basicStats.Rd, man/boxPlot.Rd, man/characterTable.Rd, man/colIds.Rd, man/colVec.Rd, man/decor.Rd, man/dist-distCheck.Rd, man/dist-gld.Rd, man/dist-gldFit.Rd, man/dist-nigRobMoments.Rd, man/distCheck.Rd, man/fHTEST.Rd, man/getS4.Rd, man/gridVector.Rd, man/hilbert.Rd, man/histPlot.Rd, man/interactivePlot.Rd, man/interp-linearInterp.Rd, man/inv.Rd, man/krigeInterp.Rd, man/kron.Rd, man/ks2Test.Rd, man/lcg.Rd, man/linearInterp.Rd, man/locationTest.Rd, man/matrix-tr.Rd, man/matrix-vech.Rd, man/matrixNorm.Rd, man/maxdd.Rd, man/pascal.Rd, man/pdl.Rd, man/positiveDefinite.Rd, man/qqPlot.Rd, man/rand-lcg.Rd, man/rk.Rd, man/rowStats.Rd, man/scaleTest.Rd, man/scalinglawPlot.Rd, man/seriesPlot.Rd, man/symbolTable.Rd, man/test-fHTEST.Rd, man/tr.Rd, man/triang.Rd, man/tslag.Rd, man/utild-Heaviside.Rd, man/utild-colIds.Rd, man/utild-decor.Rd, man/utild-getS4.Rd, man/utils-Heaviside.Rd, man/utils-colIds.Rd, man/utils-decor.Rd, man/utils-getS4.Rd, man/varianceTest.Rd, man/vec.Rd: some scripts renamed * man/utild-Heaviside.Rd, man/utild-colIds.Rd, man/utild-decor.Rd, man/utild-getS4.Rd, man/utils-symbolTable.Rd: utils script renames * man/stats-basicStats.Rd, man/stats-maxdd.Rd, man/stats-rowStats.Rd, man/stats-sampleLMoments.Rd, man/stats-sampleRobMoments.Rd: stats scripts renames * man/plot-acfPlot.Rd, man/plot-boxPlot.Rd, man/plot-histPlot.Rd, man/plot-interactivePlot.Rd, man/plot-qqPlot.Rd, man/plot-scalinglawPlot.Rd, man/plot-seriesPlot.Rd: plot script renames * man/interp-akimaInterp.Rd, man/interp-krigeInterp.Rd: interp script renames * man/test-ks2Test.Rd, man/test-locationTest.Rd, man/test-normalityTests.Rd, man/test-scaleTest.Rd, man/test-varianceTest.Rd: test-script renames * man/matrix-colVec.Rd, man/matrix-gridVector.Rd, man/matrix-hilbert.Rd, man/matrix-inv.Rd, man/matrix-kron.Rd, man/matrix-norm.Rd, man/matrix-pascal.Rd, man/matrix-pdl.Rd, man/matrix-posDefinite.Rd, man/matrix-rk.Rd, man/matrix-triang.Rd, man/matrix-tslag.Rd: matrix script renames 2009-11-13 wuertz * NAMESPACE, R/stats-sampleLmoments.R: namespace Lmoments added * R/stats-sampleLmoments.R: function to compute sample-Lmoments added, not yet documented * NAMESPACE: namespace robust moments added * R/dist-nigRobust.R: NIG robust moments added, not yet documented * R/dist-gldRobust.R: GLD robust moments added, not yet documented * NAMESPACE, R/dist-gld.R: gld functions added, not yet documented * R/dist-nigFit.R: misprint removed * NAMESPACE, R/stats-robMoments.R: functions for robust sample moments added, not yet documented * R/dist-nigFit.R: fitting methods added for nig 2009-09-28 chalabi * DESCRIPTION: updated version number * ChangeLog, DESCRIPTION: updated DESCR and ChangeLog 2009-09-24 wuertz * R/dist-sgh.R, R/dist-snig.R: C implementation for NIG Distribution updated * man/00fBasics-package.Rd: text added to manual page 2009-09-11 wuertz * R/dist-nigFit.R, man/dist-nigFit.Rd: nigFit method argument added 2009-09-02 wuertz * R/dist-nigFit.R: maximum product spacings estimation added 2009-08-27 wuertz * src/nig.c: Bug in Kjersti Ass NIG Code fixed by Nikolai Eurich 2009-08-22 wuertz * NAMESPACE, R/dist-ghMoments.R, R/dist-nigFit.R: nig estimators added * R/builtin-gelGMM.R, R/builtin-gmmGMM.R: tabs replaced by spaces 2009-08-21 wuertz * R/dist-nigShapeTriangle.R, R/dist-nigStats.R: nig shape triangle added to stats script file * R/dist-nigStats.R: nig moments added * R/dist-nig.R: nig true moments added * NAMESPACE, R/dist-ghtMode.R, R/dist-nig.R, R/dist-nigMode.R, R/dist-stable.R, R/dist-stableMode.R: missing mode functions added * NAMESPACE: new NAMESPACE structure which should ease maintenance of packages. 2009-06-25 chalabi * DESCRIPTION, NAMESPACE: Merge branch 'devel-timeSeries' Conflicts: pkg/timeSeries/R/base-Extract.R pkg/timeSeries/R/timeSeries.R 2009-06-01 wuertz * NAMESPACE: nasmespace for recession lines updated * R/lines-recessionLines.R: function .recessionLines added 2009-05-18 wuertz * NAMESPACE, R/dist-stableFit.R, man/dist-DistributionFits.Rd: stable dist fit improved * man/as.matrix.ts.Rd.bak: .bak file removed * R/dist-stable.R, R/dist-stableFit.R, man/dist-DistributionFits.Rd: stable distribution nlminb added * R/plot-counts.R: a useful counts plot * R/plot-varpie.R: .varpiePlot, a useful plot for portfolio weights ... 2009-05-13 wuertz * R/list-listDescription.R: 2009-04-29 wuertz * NAMESPACE: NAMESPACE updated * R/dist-ghSlider.R, R/dist-hypSlider.R, R/dist-nigSlider.R, R/dist-stableSlider.R, R/gui-ghSlider.R, R/gui-hypSlider.R, R/gui-nigSlider.R, R/gui-stableSlider.R, R/list-listDescription.R, R/list-listFunctions.R, R/list-listIndex.R, R/listDescription.R, R/listFunctions.R, R/listIndex.R: gui and list functioms renamed in gui-foo and list-foo * R/Heaviside.R, R/HeavisideSlider.R, R/Sys.putenv.R, R/as.matrix.ts.R, R/baseMethods.R, R/basicStats.R, R/characterTable.R, R/colIds.R, R/colVec.R, R/decor.R, R/dist-distCheck.R, R/distCheck.R, R/getS4.R, R/gridVector.R, R/gui-HeavisideSlider.R, R/gui-returnSeries.R, R/gui-sliderMenu.R, R/gui-stylizedFacts.R, R/interactivePlot.R, R/jbALM.R, R/jbLM.R, R/jbTable.R, R/ks2Test.R, R/lcg.R, R/matrix-colVec.R, R/matrix-gridVector.R, R/matrix-tslag.R, R/maxdd.R, R/plot-interactivePlot.R, R/rand-lcg.R, R/returnSeriesGUI.R, R/rowStats.R, R/sliderMenu.R, R/stats-basicStats.R, R/stats-maxdd.R, R/stats-rowStats.R, R/stylizedFactsGUI.R, R/symbolTable.R, R/test-jbALM.R, R/test-jbLM.R, R/test-jbTable.R, R/test-ks2Test.R, R/tslag.R, R/unitTest.R, R/unitrootNA.R, R/utils-Heaviside.R, R/utils-Sys.putenv.R, R/utils-as.matrix.ts.R, R/utils-baseMethods.R, R/utils-characterTable.R, R/utils-colIds.R, R/utils-decor.R, R/utils-getS4.R, R/utils-symbolTable.R, R/utils-unitTest.R, R/utils-unitrootNA.R: utils and stats script renamed as stat-foo and utils-foo * R/akimaInterp.R, R/interp-akimaInterp.R, R/interp-krigeInterp.R, R/interp-linearInterp.R, R/krigeInterp.R, R/linearInterp.R, R/locationTest.R, R/test-locationTest.R: interpolation scripts renamed in interp-foo * R/color-Locator.R, R/color-Palettes.R, R/color-RGB.R, R/color-Table.R, R/colorLocator.R, R/colorPalette.R, R/colorTable.R, R/matrix-pdl.R, R/pdl.R, R/rgb.R: color script files renamed in color-foo * R/NormalityTests.R, R/correlationTest.R, R/dist-fDISTFIT.R, R/fDISTFIT.R, R/fHTEST.R, R/matrix-vech.R, R/normalTest.R, R/scaleTest.R, R/test-NormalityTests.R, R/test-correlationTest.R, R/test-fHTEST.R, R/test-normalTest.R, R/test-scaleTest.R, R/test-varianceTest.R, R/varianceTest.R, R/vec.R: test function scripts renamed in test-foo * R/hilbert.R, R/inv.R, R/kron.R, R/matrix-hilbert.R, R/matrix-inv.R, R/matrix-kron.R, R/matrix-norm.R, R/matrix-pascal.R, R/matrix-posDefinite.R, R/matrix-rk.R, R/matrix-tr.R, R/matrix-triang.R, R/matrixNorm.R, R/pascal.R, R/positiveDefinite.R, R/rk.R, R/tr.R, R/triang.R: matrix scripts renamed in matrix-foo.R to find them better * R/acfPlot.R, R/boxPlot.R, R/histPlot.R, R/qqPlot.R, R/scalinglawPlot.R, R/seriesPlot.R, R/subPlot.R, R/subStars.R: old plot files deleted * R/plot-acfPlot.R, R/plot-boxPlot.R, R/plot-histPlot.R, R/plot-qqPlot.R, R/plot-scalinglawPlot.R, R/plot-seriesPlot.R, R/plot-subPlot.R, R/plot-subStars.R: plot files renamed as plot-foo to find them better * R/builtin-gelGMM.R, R/builtin-gmmGMM.R, R/builtin-sandwichGMM.R: gmm builtin added for parameter estimation 2009-04-19 chalabi * DESCRIPTION: added explicit version number in Depends field for key packages 2009-04-02 chalabi * DESCRIPTION: more explicit depends and suggests field in DESC file. 2009-04-01 chalabi * DESCRIPTION: updated DESC file * R/qqPlot.R: 2009-02-09 wuertz * R/qqPlot.R: 2009-01-28 chalabi * DESCRIPTION: updated version number * DESCRIPTION: changed version number to match version on CRAN + 1 2009-01-12 chalabi * man/NormalityTests.Rd, man/correlationTest.Rd, man/fHTEST.Rd, man/ks2Test.Rd, man/locationTest.Rd, man/scaleTest.Rd, man/varianceTest.Rd: fixed warning with new Rd parser fBasics/man/0000755000176200001440000000000013203500423012367 5ustar liggesusersfBasics/man/matrix-tslag.Rd0000644000176200001440000000142113202116741015275 0ustar liggesusers\name{tslag} \alias{tslag} \title{Lagged or Leading Vector/Matrix} \description{ Creates a lagged or leading vector/matrix of selected order(s). } \usage{ tslag(x, k = 1, trim = FALSE) } \arguments{ \item{k}{ an integer value, the number of positions the new series is to lag or to lead the input series. } \item{x}{ a numeric vector or matrix, missing values are allowed. } \item{trim}{ a logical flag, if TRUE, the missing values at the beginning ans/or end of the returned series will be trimmed. The default value is FALSE. } } \seealso{ \code{\link{pdl}}. } \examples{ ## tslag - # } \keyword{math} fBasics/man/matrix-posDefinite.Rd0000644000176200001440000000146013202116740016436 0ustar liggesusers\name{positiveDefinite} \alias{positiveDefinite} \alias{isPositiveDefinite} \alias{makePositiveDefinite} \title{Positive Definite Matrixes} \description{ Checks if a matrix is positive definite and/or forces a matrix to be positive definite. } \usage{ isPositiveDefinite(x) makePositiveDefinite(x) } \arguments{ \item{x}{ a square numeric matrix. } } \details{ The function \code{isPositiveDefinite} checks if a square matrix is positive definite. The function \code{makePositiveDefinite} forces a matrix to be positive definite. } \author{ Korbinian Strimmer. } \examples{ ## isPositiveDefinite - # the 3x3 Pascal Matrix is positive define isPositiveDefinite(pascal(3)) } \keyword{math} fBasics/man/dist-hypMode.Rd0000644000176200001440000000467413202116741015244 0ustar liggesusers\name{hypMode} \alias{hypMode} \title{Hyperbolic Mode} \description{ Computes the mode of the hyperbolic function. } \usage{ hypMode(alpha = 1, beta = 0, delta = 1, mu = 0, pm = c(1, 2, 3, 4)) } \arguments{ \item{alpha, beta, delta, mu}{ shape parameter \code{alpha}; skewness parameter \code{beta}, \code{abs(beta)} is in the range (0, alpha); scale parameter \code{delta}, \code{delta} must be zero or positive; location parameter \code{mu}, by default 0. These is the meaning of the parameters in the first parameterization \code{pm=1} which is the default parameterization selection. In the second parameterization, \code{pm=2} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{zeta} and \code{rho}. In the third parameterization, \code{pm=3} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{xi} and \code{chi}. In the fourth parameterization, \code{pm=4} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{a.bar} and \code{b.bar}. } \item{pm}{ an integer value between \code{1} and \code{4} for the selection of the parameterization. The default takes the first parameterization. } } \value{ returns the mode in the appropriate parameterization for the hyperbolic distribution. A numeric value. } \references{ Atkinson, A.C. (1982); \emph{The simulation of generalized inverse Gaussian and hyperbolic random variables}, SIAM J. Sci. Stat. Comput. 3, 502--515. Barndorff-Nielsen O. (1977); \emph{Exponentially decreasing distributions for the logarithm of particle size}, Proc. Roy. Soc. Lond., A353, 401--419. Barndorff-Nielsen O., Blaesild, P. (1983); \emph{Hyperbolic distributions. In Encyclopedia of Statistical Sciences}, Eds., Johnson N.L., Kotz S. and Read C.B., Vol. 3, pp. 700--707. New York: Wiley. Raible S. (2000); \emph{Levy Processes in Finance: Theory, Numerics and Empirical Facts}, PhD Thesis, University of Freiburg, Germany, 161 pages. } \author{ David Scott for code implemented from \R's contributed package \code{HyperbolicDist}. } \examples{ ## hypMode - hypMode() } \keyword{distribution} fBasics/man/utils-colorLocator.Rd0000644000176200001440000000244613202116740016470 0ustar liggesusers\name{colorLocator} \alias{colorLocator} \alias{colorMatrix} \title{Color Selection} \description{ Displays \R's 657 named colors for selection and returns optionally \R's color names. } \usage{ colorLocator(locator = FALSE, cex.axis = 0.7) colorMatrix() } \arguments{ \item{locator}{logical, if true, \code{\link{locator}} is used for interactive selection of color names, default is \code{FALSE}.} \item{cex.axis}{size of axis labels.} } \value{ Color Locator: \code{colorsLocator()} generates a plot with R colors and, when \code{locator} is true, returns matrix with graph coordinates and names of colors selected. \code{colorsMatrix()} quietly returns the matrix of names. } \details{ Color Locator: The \code{colorLocator} function plots R's 657 named colors. If \code{locator=TRUE} then you can interactively point and click to select the colors for which you want names. To end selection, right click on the mouse and select 'Stop', then R returns the selected color names. The functions used here are wrappers to the functions provided by Tomas Aragon in the contributed R package. \code{epitools}. } \seealso{ \code{\link{colorPalette}}, \code{\link{colorTable}}. } \examples{ colorLocator() } \keyword{programming} fBasics/man/dist-ghtRobMoments.Rd0000644000176200001440000000340613202116740016416 0ustar liggesusers\name{ghtRobMoments} \alias{ghtRobMoments} \alias{ghtMED} \alias{ghtIQR} \alias{ghtSKEW} \alias{ghtKURT} \title{Robust Moments for the GHT} \description{ Computes the first four robust moments for the generalized hyperbolic Student-t. } \usage{ ghtMED(beta = 0.1, delta = 1, mu = 0, nu = 10) ghtIQR(beta = 0.1, delta = 1, mu = 0, nu = 10) ghtSKEW(beta = 0.1, delta = 1, mu = 0, nu = 10) ghtKURT(beta = 0.1, delta = 1, mu = 0, nu = 10) } \arguments{ \item{beta, delta, mu}{ numeric values. \code{beta} is the skewness parameter in the range \code{(0, alpha)}; \code{delta} is the scale parameter, must be zero or positive; \code{mu} is the location parameter, by default 0. These are the parameters in the first parameterization. } \item{nu}{ a numeric value, the number of degrees of freedom. Note, \code{alpha} takes the limit of \code{abs(beta)}, and \code{lambda=-nu/2}. } } \value{ All values for the \code{*ght} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Diethelm Wuertz. } \examples{ ## ghtMED - # Median: ghtMED(beta = 0.1, delta = 1, mu = 0, nu = 10) ## ghtIQR - # Inter-quartile Range: ghtIQR(beta = 0.1, delta = 1, mu = 0, nu = 10) ## ghtSKEW - # Robust Skewness: ghtSKEW(beta = 0.1, delta = 1, mu = 0, nu = 10) ## ghtKURT - # Robust Kurtosis: ghtKURT(beta = 0.1, delta = 1, mu = 0, nu = 10) } \keyword{distribution} fBasics/man/stats-basicStats.Rd0000644000176200001440000000230213202116740016113 0ustar liggesusers\name{BasicStatistics} \alias{basicStats} \title{Basic Time Series Statistics} \description{ Computes basic financial time series statististics. \cr List of Functions: \tabular{ll}{ \code{basicStats} \tab Computes an overview of basic statistical values.} } \usage{ basicStats(x, ci = 0.95) } \arguments{ \item{ci}{ confidence interval, a numeric value, by default 0.95, i.e. 95 percent. } \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } } \value{ \code{basicsStats} \cr returns a data frame with the following entries and row names: nobs, NAs, Minimum, Maximum , 1. Quartile, 3. Quartile, Mean, Median, Sum, SE Mean, LCL Mean, UCL Mean, Variance, Stdev, Skewness, Kurtosis. } \examples{ ## basicStats - # Simulated Monthly Return Data: tS = timeSeries(matrix(rnorm(12)), timeCalendar()) basicStats(tS) } \keyword{programming} fBasics/man/dist-sght.Rd0000644000176200001440000000463613202116740014601 0ustar liggesusers\name{sght} \alias{sght} \alias{dsght} \alias{psght} \alias{qsght} \alias{rsght} \title{Standardized generalized hyperbolic Student-t Distribution} \description{ Density, distribution function, quantile function and random generation for the standardized generalized hyperbolic distribution. } \usage{ dsght(x, beta = 0.1, delta = 1, mu = 0, nu = 10, log = FALSE) psght(q, beta = 0.1, delta = 1, mu = 0, nu = 10) qsght(p, beta = 0.1, delta = 1, mu = 0, nu = 10) rsght(n, beta = 0.1, delta = 1, mu = 0, nu = 10) } \arguments{ \item{beta, delta, mu}{ numeric values. \code{beta} is the skewness parameter in the range \code{(0, alpha)}; \code{delta} is the scale parameter, must be zero or positive; \code{mu} is the location parameter, by default 0. These are the parameters in the first parameterization. } \item{nu}{ a numeric value, the number of degrees of freedom. Note, \code{alpha} takes the limit of \code{abs(beta)}, and \code{lambda=-nu/2}. } \item{x, q}{ a numeric vector of quantiles. } \item{p}{ a numeric vector of probabilities. } \item{n}{ number of observations. } \item{log}{ a logical, if TRUE, probabilities \code{p} are given as \code{log(p)}. } } \value{ All values for the \code{*sght} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \author{ Diethelm Wuertz. } \examples{ ## rsght - set.seed(1953) r = rsght(5000, beta = 0.1, delta = 1, mu = 0, nu = 10) plot(r, type = "l", col = "steelblue", main = "gh: zeta=1 rho=0.5 lambda=1") ## dsght - # Plot empirical density and compare with true density: hist(r, n = 50, probability = TRUE, border = "white", col = "steelblue") x = seq(-5, 5, length = 501) lines(x, dsght(x, beta = 0.1, delta = 1, mu = 0, nu = 10)) ## psght - # Plot df and compare with true df: plot(sort(r), (1:5000/5000), main = "Probability", col = "steelblue") lines(x, psght(x, beta = 0.1, delta = 1, mu = 0, nu = 10)) ## qsght - # Compute Quantiles: round(qsght(psght(seq(-5, 5, 1), beta = 0.1, delta = 1, mu = 0, nu =10), beta = 0.1, delta = 1, mu = 0, nu = 10), 4) } \keyword{distribution} fBasics/man/plot-returnSeriesGUI.Rd0000644000176200001440000000166613202116740016706 0ustar liggesusers\name{ReturnSeriesGUI} \alias{returnSeriesGUI} \title{Return Series Plots} \description{ A graphical user interface to display finanical time series plots. \cr List of Functions: \tabular{ll}{ \code{returnSeriesGUI} \tab Opens a GUI for return series plots.} } \usage{ returnSeriesGUI(x) } \arguments{ \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } } \value{ \code{returnSeriesGUI} \cr For the \code{returnSeriesGUI} function, beside the graphical user interface no values are returned.\cr } \author{ Diethelm Wuertz for the Rmetrics \R-port. } \examples{ ## } \keyword{programming} fBasics/man/matrix-colVec.Rd0000644000176200001440000000126413202116740015402 0ustar liggesusers\name{colVec} \alias{colVec} \alias{rowVec} \title{Column and Row Vectors} \description{ Creates a column or row vector from a numeric vector. } \usage{ colVec(x) rowVec(x) } \arguments{ \item{x}{ a numeric vector. } } \details{ The functions \code{colVec} and \code{rowVec} transform a vector into a column and row vector, respectively. A column vector is a matrix object with one column, and a row vector is a matrix object with one row. } \examples{ ## Create a numeric Vector: x = rnorm(5) ## Column and Row Vectors: colVec(x) rowVec(x) } \keyword{math} fBasics/man/matrix-tr.Rd0000644000176200001440000000117713202116741014620 0ustar liggesusers\name{tr} \alias{tr} \title{Trace of a Matrix} \description{ Returns trace of a matrix. } \usage{ tr(x) } \arguments{ \item{x}{ a numeric matrix. } } \details{ The function \code{tr} computes the trace of a square matrix which is the sum of the diagonal elements of the matrix under consideration. } \references{ Golub, van Loan, (1996); \emph{Matrix Computations}, 3rd edition. Johns Hopkins University Press. } \examples{ ## Create Pascal Matrix: P = pascal(3) P ## Trace: tr(P) } \keyword{math} fBasics/man/utils-randLCG.Rd0000644000176200001440000000472013202116740015275 0ustar liggesusers\name{lcg} \alias{lcg} \alias{set.lcgseed} \alias{get.lcgseed} \alias{runif.lcg} \alias{rnorm.lcg} \alias{rt.lcg} \title{Generator for Portable Random Innovations} \description{ Functions to generate portable random innovations. The functions run under R and S-Plus and generate the same sequence of random numbers. Supported are uniform, normal and Student-t distributed random numbers. \cr The functions are: \tabular{ll}{ \code{set.lcgseed} \tab Set initial random seed, \cr \code{get.lcgseed} \tab Get the current valus of the random seed, \cr \code{runif.lcg} \tab Uniform linear congruational generator, \cr \code{rnorm.lcg} \tab Normal linear congruational generator, \cr \code{rt.lcg} \tab Student-t linear congruential generator. } } \usage{ set.lcgseed(seed = 4711) get.lcgseed() runif.lcg(n, min = 0, max = 1) rnorm.lcg(n, mean = 0, sd = 1) rt.lcg(n, df) } \arguments{ \item{df}{ number of degrees of freedom, a positive integer, maybe non-integer. } \item{mean, sd}{ means and standard deviation of the normal distributed innovations. } \item{min, max}{ lower and upper limits of the uniform distributed innovations. } \item{seed}{ an integer value, the random number seed. } \item{n}{ an integer, the number of random innovations to be generated. } } \details{ A simple portable random number generator for use in R and SPlus. We recommend to use this generator only for comparisons of calculations in R and Splus. The generator is a linear congruential generator with parameters \code{LCG(a=13445, c=0, m=2^31-1, X=0)}. It is a simple random number generator which passes the bitwise randomness test. } \value{ A vector of generated random innovations. The value of the current seed is stored in the variable \code{lcg.seed}. } \references{ Altman, N.S. (1988); \emph{Bitwise Behavior of Random Number Generators}, SIAM J. Sci. Stat. Comput., 9(5), September, 941--949. } \examples{ ## set.lcgseed - set.lcgseed(seed = 65890) ## runif.lcg - rnorm.lcg - rt.lcg - cbind(runif.lcg(10), rnorm.lcg(10), rt.lcg(10, df = 4)) ## get.lcgseed - get.lcgseed() ## Note, to overwrite rnorm, use # rnorm = rnorm.lcg # Going back to rnorm # rm(rnorm) } \keyword{programming} fBasics/man/fBasics-deprecated.Rd0000644000176200001440000000210013202116740016323 0ustar liggesusers% Part of the Rmetrics project, http://R-metrics.org/ % Copyright 2005-2011 Rmetrics Core Team % Distributed under GPL 2 or later \name{fBasics-deprecated} %------ NOTE: ../R/fBasics-deprecated.R must be synchronized with this! \alias{fBasics-deprecated} %% \alias{dstable} %% \alias{pstable} %% \alias{qstable} %% \alias{rstable} %% \alias{stableMode} \title{Deprecated Functions in Package fBasics} \description{ These functions are provided for compatibility with older versions of the package only, and may be defunct as soon as of the next release. There are none currently. \code{\link[stabledist]{dstable}} etc now are defunct, as they have been available from \pkg{stabledist} since early 2011. %% dstable(x, alpha, beta, gamma = 1, delta = 0, pm = 0) %% pstable(q, alpha, beta, gamma = 1, delta = 0, pm = 0) %% qstable(p, alpha, beta, gamma = 1, delta = 0, pm = 0) %% rstable(n, alpha, beta, gamma = 1, delta = 0, pm = 0) %% stableMode(alpha, beta) } %% \usage{ %% } %% \arguments{ %% } \seealso{ \code{\link{Deprecated}}, \code{\link{Defunct}} } \keyword{misc} fBasics/man/00fBasics-package.Rd0000644000176200001440000005525113202116740015775 0ustar liggesusers\name{fBasics-package} \alias{fBasics-package} \alias{fBasics} \docType{package} \title{Portfolio Modelling, Optimization and Backtesting} \description{ The Rmetrics "fBasics" package is a collection of functions to explore and to investigate basic properties of financial returns and related quantities. The covered fields include techniques of explorative data analysis and the investigation of distributional properties, including parameter estimation and hypothesis testing. Evenmore there are several utility functions for data handling and managemnet. } \details{ \preformatted{ Package: \tab fBasics\cr Type: \tab Package\cr Date: \tab 2014\cr License: \tab GPL Version 2 or later\cr Copyright: \tab (c) 1999-2014 Rmetrics Association\cr Repository: \tab R-FORGE\cr URL: \tab \url{https://www.rmetrics.org} } } \section{1 Introduction}{ The fBasics package contains \emph{basics tools} often required in computational finance and financial engineering. The topics are: basic statistics functions, financial return distributions, hypothesis testing, plotting routines, matrix computations and linear algebra, and some usefule utility functions. } \section{2 Basic Statistics Functions}{ \emph{Financial Return Statistics} % stats-basicStats.R \preformatted{ basicStats Returns a basic statistics summary } \emph{Distribution Function of Maximum Drawdowns} % stats-maxdd.R \preformatted{ dmaxdd Density function of mean Max-Drawdowns pmaxdd Probability function of mean Max-Drawdowns rmaxdd Random Variates of mean Max-Drawdowns maxddStats Expectation of Drawdowns for BM with drift } \emph{Calculation of Sample Moments} % stats-sampleLMoments.R | stats-sampleRobMoments.R \preformatted{ sampleLmoments Computes sample L-moments sampleMED Returns sample median sampleIQR returns sample inter quartal range sampleSKEW returns robust sample skewness sampleKURT returns robust sample kurtosis } \emph{Bivariate Interpolation:} % stats-interpAkima.R | stats-interpKrige.R | stats-interpLinear.R \preformatted{ akimaInterp Interpolates irregularly spaced points akimaInterpp Interpolates and smoothes pointwise krigeInterp Kriges irregularly spaced data points linearInterp Interpolates irregularly spaced points linearInterpp Interpolates linearly pointwise } \emph{Utility Statistics Functions:} \preformatted{ colStats Computes sample statistics by col colSums Computes sums of values in each col colMeans Computes means of values in each col colSds Computes standard deviation of each col colVars Computes sample variance by col colSkewness Computes sample skewness by col colKurtosis Computes sample kurtosis by col colMaxs Computes maximum values in each col colMins Computes minimum values in each col colProds Computes product of values in each col colQuantiles Computes product of values in each col } % stats-rowStats.R \preformatted{ rowStats Computes sample statistics by row rowSums Computes sums of values in each row rowMeans Computes means of values in each row rowSds Computes standard deviation of each row rowVars Computes sample variance by row rowSkewness Computes sample skewness by row rowKurtosis Computes sample kurtosis by row rowMaxs Computes maximum values in each row rowMins Computes minimum values in each row rowProds Computes product of values in each row rowQuantiles Computes product of values in each row } } \section{3 Financial Return Distributions}{ \emph{Generalized Hyperbolic Distribution:} % dist-gh.R | dist-ghFit.R | dist-ghMode.R | dist-ghMoments.R | % dist-ghRobMoments.R \preformatted{ dghReturns Density for the GH distribution pghreturns Probability for the GH distribution qghreturns Quantiles for the GH distribution rghreturns Random variates for the GH distribution ghFitFits Fits parameters of the GH distribution ghMode Computes mode of the GH distribution. ghMean Returns true mean of the GH distribution ghVar Returns true variance of the GH distribution ghSkew Returns true skewness of the GH distribution ghKurt Returns true kurtosis of the GH distribution ghMoments Returns true n-th moment of the GH distribution ghMED Returns true median of te GH distribution ghIQR Returns true inter quartal range of te GH ghSKEW Returns true robust skewness of te GH ghKURT Returns true robust kurtosis of te GH } \emph{Hyperbolic Distribution:} % dist-hyp.R | dist-hypFit.R | dist-hypMode.R | dist-hypMoments.R % dist-hypRobMoments.R \preformatted{ dhyp Returns density for the HYP distribution phyp Returns probability for the HYP distribution qhyp Returns quantiles for the HYP distribution rhyp Returns random variates for the HYP distribution hypFit Fits parameters of the HYP distribution hypMode Computes mode of the HYP distribution hypMean Returns true mean of the HYP distribution hypVar R Returns true variance of the HYP distribution hypSkew Returns true skewness of the HYP distribution hypKurt Returns true kurtosis of the HYP distribution hypMoments Returns true n-th moment of the HYP distribution hypMED Returns true median of the HYP distribution hypIQR Returns true inter quartal range of the HYP hypSKEW Returns true robust skewness of the HYP hypKURT Returns true robust kurtosis of the HYP } \emph{Normal Inverse Gaussian:} % dist-nig.R | dist-nigFit.R | dist-nigMode.R | dist-nigMoments.R % dist-nigRobMoments.R \preformatted{ dnig Returns density for the NIG distribution pnig Returns probability for the NIG distribution qnig Returns quantiles for the NIG distribution rnig Returns random variates for the NIG distribution .pnigC fast C Implementation of function pnig() .qnigC fast CImplementation of function qnig() nigFit Fits parameters of a NIG distribution .nigFit.mle Uses max Log-likelihood estimation .nigFit.gmm Uses generalized method of moments .nigFit.mps Maximum product spacings estimation .nigFit.vmps Minimum variance mps estimation nigMode Computes mode of the NIG distribution nigMean Returns true mean of the NIG distribution nigVar Returns true variance of the NIG distribution nigSkew Returns true skewness of the NIG distribution nigKurt Returns true kurtosis of the NIG distribution nigMoments Returns true n-th moment of the NIG distribution nigMED Returns true median of the NIG distribution nigIQR Returns true inter quartal range of the NIG nigSKEW Returns true robust skewness of the NIG nigKURT Returns true robust kurtosis of the NIG } \emph{Generalized Hyperbolic Student-t Distribution:} % dist-ght.R | dist-ghtFit.R | dist-ghtMode.R | dist-ghtMoments.R | % dist-ghtRobMoments.R \preformatted{ dght Returns density for the GHT distribution pght Returns probability for the GHT distribution qght Returns quantiles for the GHT distribution rght Returns random variates for the GHT distribution ghtFit Fits parameters of the GHT distribution ghtMode Computes mode of the GHT distribution ghtMean Returns true mean of the NIG distribution ghtVar Returns true variance of the GHT distribution ghtSkew Returns true skewness of the GHT distribution ghtKurt Returns true kurtosis of the GHT distribution ghtMoments Returns true n-th moment of the GHT distribution ghtMED Returns true median of the GHT distribution ghtIQR Returns true inter quartal range of the GHT ghtSKEW Returns true robust skewness of the GHT ghtKURT Returns true robust kurtosis of the GHT } \emph{Stable Distribution:} % dist-stable.R | dist-stableFit.R | dist-stableMode.R \preformatted{ dstable Returns density for the stable distribution pstable Returns probability for the stable distribution qstable Returns quantiles for the stable distribution rstable Returns random variates for the dtsble distribution stableFit Fits parameters of a the stable distribution .phiStable Creates contour table for McCulloch estimators .PhiStable Contour table created by function .phiStable() .qStableFit Estimates parameters by McCulloch's approach .mleStableFit Estimates stable parameters by MLE approach .stablePlot Plots results of stable parameter estimates stableMode Computes mode of the stable distribution } \emph{Generalized Lambda Distribution:} % dist-gld.R | dist-gldFit.R | dist-gldMode.R | % dist-gldRobMoments.R \preformatted{ dgld Returns density for the GLD distribution pgld Returns probability for the GLD distribution qgld Returns quantiles for the GLD distribution rgld Returns random variates for the GLD distribution gldFit Fits parameters of the GLD distribution .gldFit.mle fits GLD using maximum log-likelihood .gldFit.mps fits GLD using maximum product spacings .gldFit.gof fits GLD using Goodness of Fit statistics % .ksGLDKolmogorov-Smirnov Statistics % .cvmGLDCramer-vonMise Statistics % .adGLDAnderson-Darling Statistics .gldFit.hist fits GLD using a histogram fit .gldFit.rob fits GLD using robust moments fit gldMode Computes mode of the GLD distribution. gldMED Returns true median of the GLD distribution gldIQR Returns true inter quartal range of the GLD gldSKEW Returns true robust skewness of the GLD gldKURT Returns true robust kurtosis of the GLD } \emph{Spline Smoothed Distribution:} % dist-ssd.R | dist-ssdFit.R \preformatted{ dssd Returns spline smoothed density function pssd Returns spline smoothed probability function qssd Returns spline smoothed quantile function rssd Returns spline smoothed random variates. ssdFit Fits parameters for a spline smoothed distribution } } \section{4 Hypthesis Testing}{ \emph{One Sample Nornality Tests:} % test-normalTest.R \preformatted{ ksnormTest One sample Kolmogorov-Smirnov normality test shapiroTest Shapiro-Wilk normality test jarqueberaTest Jarque-Bera normality test normalTest Normality tests S-Plus compatible call dagoTest D'Agostino normality test adTest Anderson-Darling normality test cvmTest Cramer-von Mises normality test lillieTest Lilliefors (KS) normality test pchiTest Pearson chi-square normality test sfTest Shapiro-Francia normality test jbTest Finite sample adjusted JB LM and ALM test } \emph{One Sample Location, Scale and variance Tests:} % test-locationTest.R | test-scaleTest.R | test-variance Test.R \preformatted{ locationTest Performs locations tests on two samples .tTest Unpaired t test for differences in mean .kw2Test Kruskal-Wallis test for differences in locations scaleTest Performs scale tests on two samples .ansariTest Ansari-Bradley test for differences in scale .moodTest Mood test for differences in scale varianceTest Performs variance tests on two samples .varfTest F test for differences in variances .bartlett2Test Bartlett's test for differences in variances .fligner2Test Fligner-Killeen test for differences in variances } \emph{Two Sample Tests:} % test-ks2Test.R \preformatted{ ks2Test Performs a two sample Kolmogorov-Smirnov test correlationTest Performs correlation tests on two samples pearsonTest Pearson product moment correlation coefficient kendallTest Kendall's tau correlation test spearmanTest Spearman's rho correlation test } \emph{Test Utilities:} % test-fHTEST.R \preformatted{ 'fHTEST' S4 Class Representation show.fHTEST S4 Print Method .jbALM Jarque Bera Augmented Lagrange Multiplier Data .jbLM Jarque-Bera Lagrange Multiplier Data .jbTable Finite sample p values for the Jarque Bera test .jbPlot Plots probabilities .pjb Returns probabilities for JB given quantiles .qjb Returns quantiles for JB given probabilities } } \section{5 Plotting Routines}{ \emph{Financial Time Series Plots:} % plot-seriesPlot.R \preformatted{ seriesPlot Dispalys a time series plot cumulatedPlot Displays cumulated series give returns returnPlot Displays returns given cumulated series drawdownPlot Displays drawdown series from returns } \emph{Correlation Plots:} % plot-acfPlot.R \preformatted{ acfPlot Displays tailored ACF plot pacfPlot Displays tailored partial ACF plot teffectPlot Displays the Taylor effect lacfPlot Displays lagged autocorrelations } \emph{Distribution Plots:} % plot-histPlot.R | plot-qqPlot.R plot-boxPlot.R \preformatted{ histPlot Returns tailored histogram plot densityPlot Returns tailored density plot logDensityPlot Returns tailored log density plot boxPlot Returns side-by-side standard box plot boxPercentile Plotreturns box-percentile plot qqnormPlot Returns normal quantile-quantile plot qqnigPlot Returns NIG quantile-quantile plot qqghtPlot Rreturns GHT quantile-quantile plot qqgldPlot Returns GLD quantile-quantile plot } \emph{ Time Series Aggregation Plots:} % plot-scalinglawPlot.R \preformatted{ scalinglawPlot Displays scaling law behavior } } \section{5. Matrix Computations and Linear Algebra}{ \emph{Elementar Matrix Operation Addons:} % matrix-kron.R | matrix-vech.R | matrix-pdl.R | matrix-tslag.R \preformatted{ kron Returns the Kronecker product vec Stacks a matrix as column vector vech Stacks a lower triangle matrix pdl Returns regressor matrix for polynomial lags tslag Returns Lagged/leading vector/matrix } \emph{Linear Algebra Addons:} % matrix-inv.R | matrix-norm.R | matrix-rk.R | matrix-tr.R \preformatted{ inv Returns the inverse of a matrix norm Returns the norm of a matrix rk Returns the rank of a matrix tr Returns the trace of a matrix } \emph{General Matrix Utility Addons:} % matrix-posDefinite.R | matrix-colVec.R | matrix-gridVector.R | % matrix-triang.R \preformatted{ isPositiveDefinite Checks if a matrix is positive definite makePositiveDefinite Forces a matrix to be positive definite colVec Creates a column vector from a data vector rowVec Creates a row vector from a data vector gridVector Creates from two vectors rectangular grid triang Extracs lower tridiagonal part from a matrix Triang Extracs upper tridiagonal part from a matrix } \emph{Selected Matrix Examples:} % matrix-hilbert.R | matrix-pascal.R \preformatted{ hilbert Creates a Hilbert matrix pascal Creates a Pascal matrix } } \section{6 Utility Functions}{ \emph{Color Utilities:} % utils-colorLocator.R | utils-colorTable.R | utils-colorPalette.R \preformatted{ colorLocator Plots Rs 657 named colors for selection colorMatrix Returns matrix of R's color names. colorTable Table of Color Codes and Plot Colors itself rainbowPalette Contiguous rainbow color palette heatPalette Contiguous heat color palette terrainPalette Contiguous terrain color palette topoPalette Contiguous topo color palette cmPalette Contiguous cm color palette greyPalette R's gamma-corrected gray palette timPalette Tim's Matlab like color palette rampPalette Color ramp palettes seqPalette Sequential color brewer palettes divPalette Diverging color brewer palettes qualiPalette Qualified color brewer palettes focusPalette Red, green blue focus palettes monoPalette Red, green blue mono palettes } \emph{Graphics Utilities:} % utils-symbolTable.R | utils-characterTable.R | utils-decor.R | % utils-interactivePlot.R \preformatted{ symbolTable Shows a table of plot symbols characterTable Shows a table of character codes decor Adds horizontal grid and L shaped box hgrid Adds horizontal grid lines vgrid Adds vertical grid lines boxL Adds L-shaped box box Adds unterlined box .xrug Adds rugs on x axis .yrug Adds rugs on y axis copyright Adds copyright notice interactivePlot Plots several graphs interactively } \emph{Special Function Utilities:} % utils-heaviside.R | utils-hessian.R \preformatted{ Heaviside Computes Heaviside unit step function Sign Another signum function Delta Computes delta function Boxcar Computes boxcar function Ramp Computes ramp function tsHessian Computes Two Sided Hessian matrix } \emph{Other Utilities:} % utils-unitrootNA.R | utils-getS4.R \preformatted{ .unirootNA Computes zero of a function without error exit getModel Extracts the model slot from a S4 object getTitle Extracts the title slot from a S4 object getDescription Extracts the description slot getSlot Extracts a specified slot from a S4 object } } \section{About Builtin Functions}{ Builtin functions are borrowed from contributed R packages and other sources. There are several reasons why we have modified and copied code from other sources and included in this package. * The builtin code is not available on Debian, so that Linux users have no easy acces to this code. * The original code conflicts with other code from this package or conflicts with Rmetrics design objectives. * We only need a very small piece of functionality from the original package which may depend on other packages which are not needed. * The package from which we builtin the code is under current development, so that the functions often change and thus leads to unexpectect behavior in the Rmetrics packages. * The package may be incompatible since it uses other time date and time series classes than the 'timDate' and 'timeSeries' objects and methods from Rmetrics. We put the code in script files named \emph{builtin-funPackage.R} where "fun" denotes the (optional) major function name, and "Package" the name of the contributed package from which we copied the original code. Builtin functions include: \preformatted{ gelGmm gll function from gmm package gmmGMM gmm function from gmm package kweightsSandwhich kweights from sandwhich package glGld gl functions from gld package ssdenGss ssden from the gss package hypHyperbolicDist hyp from HyperbolicDist package } } \section{Compiled Fortran and C Code:}{ \preformatted{ gld.c source code from gld package nig.c source code from Kersti Aas gss.f source code fromsandwhich package } } \section{About Rmetrics:}{ The \code{fBasics} Rmetrics package is written for educational support in teaching "Computational Finance and Financial Engineering" and licensed under the GPL. } \keyword{package} fBasics/man/test-scaleTest.Rd0000644000176200001440000000737313202116740015600 0ustar liggesusers\name{scaleTest} \alias{scaleTest} \title{Two Sample Scale Tests} \description{ Tests if two series differ in their distributional scale parameter. } \usage{ scaleTest(x, y, method = c("ansari", "mood"), title = NULL, description = NULL) } \arguments{ \item{x, y}{ numeric vectors of data values. } \item{method}{ a character string naming which test should be applied. } \item{title}{ an optional title string, if not specified the inputs data name is deparsed. } \item{description}{ optional description string, or a vector of character strings. } } \value{ In contrast to R's output report from S3 objects of class \code{"htest"} a different output report is produced. The classical tests presented here return an S4 object of class \code{"fHTEST"}. The object contains the following slots: \item{@call}{ the function call. } \item{@data}{ the data as specified by the input argument(s). } \item{@test}{ a list whose elements contain the results from the statistical test. The information provided is similar to a list object of class \code{"htest"}. } \item{@title}{ a character string with the name of the test. This can be overwritten specifying a user defined input argument. } \item{@description}{ a character string with an optional user defined description. By default just the current date when the test was applied will be returned. } The slot \code{@test} returns an object of class \code{"list"} containing (at least) the following elements: \item{statistic}{ the value(s) of the test statistic. } \item{p.value}{ the p-value(s) of the test. } \item{parameters}{ a numeric value or vector of parameters. } \item{estimate}{ a numeric value or vector of sample estimates. } \item{conf.int}{ a numeric two row vector or matrix of 95% confidence levels. } \item{method}{ a character string indicating what type of test was performed. } \item{data.name}{ a character string giving the name(s) of the data. } } \details{ The \code{method="ansari"} performs the Ansari--Bradley two--sample test for a difference in scale parameters. The test returns for any sizes of the series \code{x} and \code{y} the exact p value together with its asymptotic limit. The \code{method="mood"}, is another test which performs a two--sample test for a difference in scale parameters. The underlying model is that the two samples are drawn from \emph{f(x-l)} and \emph{f((x-l)/s)/s}, respectively, where \emph{l} is a common location parameter and \emph{s} is a scale parameter. The null hypothesis is \emph{s=1}. } \note{ Some of the test implementations are selected from \R's \code{ctest} package. } \references{ Conover, W. J. (1971); \emph{Practical nonparametric statistics}, New York: John Wiley & Sons. Lehmann E.L. (1986); \emph{Testing Statistical Hypotheses}, John Wiley and Sons, New York. Moore, D.S. (1986); \emph{Tests of the chi-squared type}, In: D'Agostino, R.B. and Stephens, M.A., eds., Goodness-of-Fit Techniques, Marcel Dekker, New York. } \author{ R-core team for hypothesis tests implemented from \R's package \code{ctest}. } \examples{ ## rnorm - # Generate Series: x = rnorm(50) y = rnorm(50) ## scaleTest - scaleTest(x, y, "ansari") scaleTest(x, y, "mood") } \keyword{htest} fBasics/man/utils-colorTable.Rd0000644000176200001440000000121413202116741016105 0ustar liggesusers\name{colorTable} \alias{colorTable} \title{Table of Colors} \description{ Displays a Table of color codes and plots the colors themselves. } \usage{ colorTable(cex = 0.7) } \arguments{ \item{cex}{ a numeric value, determines the character size in the color plot, the default size is 0.7. } } \value{ \code{colorTable} returns a table of plot plot colors with the associated color numbers. } \seealso{ \code{link{characterTable}}, \code{link{symbolTable}}. } \examples{ ## Color Table: colorTable() } \keyword{programming} fBasics/man/stats-sampleLMoments.Rd0000644000176200001440000000225713202116740016764 0ustar liggesusers\name{sampleRobMoments} \alias{sampleRobMoments} \alias{sampleMED} \alias{sampleIQR} \alias{sampleSKEW} \alias{sampleKURT} \title{Robust Moments for the GLD} \description{ Computes the first four robust moments for the Normal Inverse Gaussian Distribution. } \usage{ sampleMED(x) sampleIQR(x) sampleSKEW(x) sampleKURT(x) } \arguments{ \item{x}{ are numeric vector, the sample values. } } \value{ All values for the \code{*sample} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Diethelm Wuertz. } \examples{ ## Sample: x = rt(100, 4) ## sampleMED - # Median: sampleMED(x) ## sampleIQR - # Inter-quartile Range: sampleIQR(x) ## sampleSKEW - # Robust Skewness: sampleSKEW(x) ## sampleKURT - # Robust Kurtosis: sampleKURT(x) } \keyword{distribution} fBasics/man/dist-DistributionFits.Rd0000644000176200001440000001072613202116740017136 0ustar liggesusers\name{DistributionFits} \alias{DistributionFits} \alias{fDISTFIT} \alias{fDISTFIT-class} \alias{show,fDISTFIT-method} \alias{nFit} \alias{tFit} \alias{stableFit} \alias{print.fDISTFIT} \title{Parameter Fit of a Distribution} \description{ A collection and description of moment and maximum likelihood estimators to fit the parameters of a distribution. \cr The functions are: \tabular{ll}{ \code{nFit} \tab MLE parameter fit for a normal distribution, \cr \code{tFit} \tab MLE parameter fit for a Student t-distribution, \cr \code{stableFit} \tab MLE and Quantile Method stable parameter fit. } } \usage{ nFit(x, doplot = TRUE, span = "auto", title = NULL, description = NULL, \dots) tFit(x, df = 4, doplot = TRUE, span = "auto", trace = FALSE, title = NULL, description = NULL, \dots) stableFit(x, alpha = 1.75, beta = 0, gamma = 1, delta = 0, type = c("q", "mle"), doplot = TRUE, control = list(), trace = FALSE, title = NULL, description = NULL) \S4method{show}{fDISTFIT}(object) } \arguments{ \item{control}{ [stableFit] - \cr a list of control parameters, see function \code{nlminb}. } \item{alpha, beta, gamma, delta}{ [stable] - \cr The parameters are \code{alpha}, \code{beta}, \code{gamma}, and \code{delta}:\cr value of the index parameter \code{alpha} with \code{alpha = (0,2]}; skewness parameter \code{beta}, in the range [-1, 1]; scale parameter \code{gamma}; and shift parameter \code{delta}. } \item{description}{ a character string which allows for a brief description. } \item{df}{ the number of degrees of freedom for the Student distribution, \code{df > 2}, maybe non-integer. By default a value of 4 is assumed. } \item{object}{ [show] - \cr an S4 class object as returned from the fitting functions. } \item{doplot}{ a logical flag. Should a plot be displayed? } \item{span}{ x-coordinates for the plot, by default 100 values automatically selected and ranging between the 0.001, and 0.999 quantiles. Alternatively, you can specify the range by an expression like \code{span=seq(min, max, times = n)}, where, \code{min} and \code{max} are the left and right endpoints of the range, and \code{n} gives the number of the intermediate points. } \item{title}{ a character string which allows for a project title. } \item{trace}{ a logical flag. Should the parameter estimation process be traced? } \item{type}{ a character string which allows to select the method for parameter estimation: \code{"mle"}, the maximum log likelihood approach, or \code{"qm"}, McCulloch's quantile method. } \item{x}{ a numeric vector. } \item{\dots}{ parameters to be parsed. } } \value{ The functions \code{tFit}, \code{hypFit} and \code{nigFit} return a list with the following components: \item{estimate}{ the point at which the maximum value of the log liklihood function is obtained. } \item{minimum}{ the value of the estimated maximum, i.e. the value of the log liklihood function. } \item{code}{ an integer indicating why the optimization process terminated. } \item{gradient}{ the gradient at the estimated maximum. } Remark: The parameter estimation for the stable distribution via the maximum Log-Likelihood approach may take a quite long time. } \details{ \bold{Stable Parameter Estimation:} Estimation techniques based on the quantiles of an empirical sample were first suggested by Fama and Roll [1971]. However their technique was limited to symmetric distributions and suffered from a small asymptotic bias. McCulloch [1986] developed a technique that uses five quantiles from a sample to estimate \code{alpha} and \code{beta} without asymptotic bias. Unfortunately, the estimators provided by McCulloch have restriction \code{alpha>0.6}. } \examples{ ## nFit - # Simulate random normal variates N(0.5, 2.0): set.seed(1953) s = rnorm(n = 1000, 0.5, 2) ## nigFit - # Fit Parameters: nFit(s, doplot = TRUE) } \keyword{distribution} fBasics/man/utils-printControl.Rd0000644000176200001440000000120113202116741016510 0ustar liggesusers\name{print} \alias{print} \alias{print.control} \title{Print Control} \description{ Unlists and prints a control object. } \usage{ \method{print}{control}(x, \dots) } \arguments{ \item{x}{ the object to be printed. } \item{\dots}{ arguments to be passed. } } \value{ \code{print.control} prints control. } \examples{ ## print - control = list(n = 211, seed = 54, name = "generator") print(control) class(control) = "control" print(control) } \keyword{programming} fBasics/man/test-ks2Test.Rd0000644000176200001440000000570713202116740015207 0ustar liggesusers\name{ks2Test} \alias{ks2Test} \title{Two Sample Kolmogorov--Smirnov Test} \description{ Tests if two series are distributional equivalent. } \usage{ ks2Test(x, y, title = NULL, description = NULL) } \arguments{ \item{x, y}{ numeric vectors of data values. } \item{title}{ an optional title string, if not specified the inputs data name is deparsed. } \item{description}{ optional description string, or a vector of character strings. } } \value{ In contrast to R's output report from S3 objects of class \code{"htest"} a different output report is produced. The classical tests presented here return an S4 object of class \code{"fHTEST"}. The object contains the following slots: \item{@call}{ the function call. } \item{@data}{ the data as specified by the input argument(s). } \item{@test}{ a list whose elements contain the results from the statistical test. The information provided is similar to a list object of class \code{"htest"}. } \item{@title}{ a character string with the name of the test. This can be overwritten specifying a user defined input argument. } \item{@description}{ a character string with an optional user defined description. By default just the current date when the test was applied will be returned. } The slot \code{@test} returns an object of class \code{"list"} containing (at least) the following elements: \item{statistic}{ the value(s) of the test statistic. } \item{p.value}{ the p-value(s) of the test. } \item{parameters}{ a numeric value or vector of parameters. } \item{estimate}{ a numeric value or vector of sample estimates. } \item{conf.int}{ a numeric two row vector or matrix of 95% confidence levels. } \item{method}{ a character string indicating what type of test was performed. } \item{data.name}{ a character string giving the name(s) of the data. } } \details{ The test \code{ks2Test} performs a Kolmogorov--Smirnov two sample test that the two data samples \code{x} and \code{y} come from the same distribution, not necessarily a normal distribution. That means that it is not specified what that common distribution is. } \references{ Conover, W. J. (1971); \emph{Practical nonparametric statistics}, New York: John Wiley & Sons. Lehmann E.L. (1986); \emph{Testing Statistical Hypotheses}, John Wiley and Sons, New York. } \author{ R-core team for hypothesis tests implemented from \R's package \code{ctest}. } \examples{ ## rnorm - # Generate Series: x = rnorm(50) y = rnorm(50) ## ks2Test - ks2Test(x, y) } \keyword{htest} fBasics/man/dist-hypMoments.Rd0000644000176200001440000000334413202116740015772 0ustar liggesusers\name{hypMoments} \alias{hypMoments} \alias{hypMean} \alias{hypVar} \alias{hypSkew} \alias{hypKurt} \alias{hypMoments} \title{Hyperbolic Distribution Moments} \description{ Calculates moments of the hyperbbolic distribution function } \usage{ hypMean(alpha=1, beta=0, delta=1, mu=0) hypVar(alpha=1, beta=0, delta=1, mu=0) hypSkew(alpha=1, beta=0, delta=1, mu=0) hypKurt(alpha=1, beta=0, delta=1, mu=0) hypMoments(order, type = c("raw", "central", "mu"), alpha=1, beta=0, delta=1, mu=0) } \arguments{ \item{alpha, beta, delta, mu}{ numeric values. \code{alpha} is the first shape parameter; \code{beta} is the second shape parameter in the range \code{(0, alpha)}; \code{delta} is the scale parameter, must be zero or positive; \code{mu} is the location parameter, by default 0. } \item{order}{ an integer value, the order of the moment. } \item{type}{ a character value, \code{"raw"} returns the moments about zero, \code{"central"} returns the central moments about the mean, and \code{"mu"} returns the moments about the location parameter \code{mu}. } } \value{ a numerical value. } \references{ Scott, D. J., Wuertz, D. and Tran, T. T. (2008) \emph{Moments of the Generalized Hyperbolic Distribution}. Preprint. } \author{ Diethelm Wuertz. } \examples{ ## hypMean - hypMean(alpha=1.1, beta=0.1, delta=0.8, mu=-0.3) ## ghKurt - hypKurt(alpha=1.1, beta=0.1, delta=0.8, mu=-0.3) ## hypMoments - hypMoments(4, alpha=1.1, beta=0.1, delta=0.8, mu=-0.3) hypMoments(4, "central", alpha=1.1, beta=0.1, delta=0.8, mu=-0.3) } \keyword{distribution} fBasics/man/matrix-vech.Rd0000644000176200001440000000162013202116740015110 0ustar liggesusers\name{vec} \alias{vec} \alias{vech} \title{Stacking Vectors and Matrixes} \description{ Stacks either a lower triangle matrix or a matrix. } \usage{ vec(x) vech(x) } \arguments{ \item{x}{ a numeric matrix. } } \details{ The function \code{vec} implements the operator that stacks a matrix as a column vector, to be more precise in a matrix with one column. vec(X) = (X11, X21, ..., XN1, X12, X22, ..., XNN). The function \code{vech} implements the operator that stacks the lower triangle of a NxN matrix as an N(N+1)/2x1 vector: vech(X) =(X11, X21, X22, X31, ..., XNN), to be more precise in a matrix with one row. } \examples{ ## Create Pascal Matrix: P = pascal(3) ## Stack a matrix vec(P) ## Stack the lower triangle vech(P) } \keyword{math} fBasics/man/test-normalityTests.Rd0000644000176200001440000002424213202116740016704 0ustar liggesusers\name{NormalityTests} \alias{NormalityTests} \alias{normalTest} \alias{ksnormTest} \alias{shapiroTest} \alias{jarqueberaTest} \alias{dagoTest} \alias{jbTest} % from nortest: \alias{adTest} \alias{cvmTest} \alias{lillieTest} \alias{pchiTest} \alias{sfTest} \title{Normality Tests} \description{ A collection and description of functions of one sample tests for testing normality of financial return series. \cr The functions for testing normality are: \tabular{ll}{ \code{ksnormTest} \tab Kolmogorov-Smirnov normality test, \cr \code{shapiroTest} \tab Shapiro-Wilk's test for normality, \cr \code{jarqueberaTest} \tab Jarque--Bera test for normality, \cr \code{dagoTest} \tab D'Agostino normality test. } Functions for high precision Jarque Bera LM and ALM tests: \tabular{ll}{ \code{jbTest} \tab Performs finite sample adjusted JB LM and ALM test. } Additional functions for testing normality from the 'nortest' package: \tabular{ll}{ \code{adTest} \tab Anderson--Darling normality test, \cr \code{cvmTest} \tab Cramer--von Mises normality test, \cr \code{lillieTest} \tab Lilliefors (Kolmogorov-Smirnov) normality test, \cr \code{pchiTest} \tab Pearson chi--square normality test, \cr \code{sfTest} \tab Shapiro--Francia normality test. } For SPlus/Finmetrics Compatibility: \tabular{ll}{ \code{normalTest} \tab test suite for some normality tests. } } \usage{ ksnormTest(x, title = NULL, description = NULL) jbTest(x, title = NULL, description = NULL) shapiroTest(x, title = NULL, description = NULL) normalTest(x, method = c("sw", "jb"), na.rm = FALSE) jarqueberaTest(x, title = NULL, description = NULL) dagoTest(x, title = NULL, description = NULL) adTest(x, title = NULL, description = NULL) cvmTest(x, title = NULL, description = NULL) lillieTest(x, title = NULL, description = NULL) pchiTest(x, title = NULL, description = NULL) sfTest(x, title = NULL, description = NULL) } \arguments{ \item{description}{ optional description string, or a vector of character strings. } \item{method}{ [normalTest] - \cr indicates four different methods for the normality test, \code{"ks"} for the Kolmogorov-Smirnov one--sample test, \code{"sw"} for the Shapiro-Wilk test, \code{"jb"} for the Jarque-Bera Test, and \code{"da"} for the D'Agostino Test. The default value is \code{"ks"}. } \item{na.rm}{ [normalTest] - \cr a logical value. Should missing values removed before computing the tests? The default value is \code{FALSE}. } \item{title}{ an optional title string, if not specified the inputs data name is deparsed. } \item{x}{ a numeric vector of data values or a S4 object of class \code{timeSeries}. } } \value{ In contrast to R's output report from S3 objects of class \code{"htest"} a different output report is produced. The tests here return an S4 object of class \code{"fHTEST"}. The object contains the following slots: \item{@call}{ the function call. } \item{@data}{ the data as specified by the input argument(s). } \item{@test}{ a list whose elements contain the results from the statistical test. The information provided is similar to a list object of class \code{"htest"}. } \item{@title}{ a character string with the name of the test. This can be overwritten specifying a user defined input argument. } \item{@description}{ a character string with an optional user defined description. By default just the current date when the test was applied will be returned. } The slot \code{@test} returns an object of class \code{"list"} containing the following (otionally empty) elements: \item{statistic}{ the value(s) of the test statistic. } \item{p.value}{ the p-value(s) of the test. } \item{parameters}{ a numeric value or vector of parameters. } \item{estimate}{ a numeric value or vector of sample estimates. } \item{conf.int}{ a numeric two row vector or matrix of 95% confidence levels. } \item{method}{ a character string indicating what type of test was performed. } \item{data.name}{ a character string giving the name(s) of the data. } The meaning of the elements of the \code{@test} slot is the following: \code{ksnormTest} \cr returns the values for the 'D' statistic and p-values for the three alternatives 'two-sided, 'less' and 'greater'. \code{shapiroTest} \cr returns the values for the 'W' statistic and the p-value. \code{jarqueberaTest}\cr \code{jbTest} \cr returns the values for the 'Chi-squared' statistic with 2 degrees of freedom, and the asymptotic p-value. \code{jbTest} is the finite sample version of the Jarque Bera Lagrange multiplier, LM, and adjusted Lagrange multiplier test, ALM. \code{dagoTest} \cr returns the values for the 'Chi-squared', the 'Z3' (Skewness) and 'Z4' (Kurtosis) statistic together with the corresponding p values. \code{adTest} \cr returns the value for the 'A' statistic and the p-value. \code{cvmTest} \cr returns the value for the 'W' statistic and the p-value. \code{lillieTest} \cr returns the value for the 'D' statistic and the p-value. \code{pchiTest} \cr returns the value for the 'P' statistic and the p-values for the adjusted and not adjusted test cases. In addition the number of classes is printed, taking the default value due to Moore (1986) computed from the expression \code{n.classes = ceiling(2 * (n^(2/5)))}, where \code{n} is the number of observations. \code{sfTest} \cr returns the value for the 'W' statistic and the p-value. } \details{ The hypothesis tests may be of interest for many financial and economic applications, especially for the investigation of univariate time series returns. \cr \bold{Normal Tests:} \cr\cr Several tests for testing if the records from a data set are normally distributed are available. The input to all these functions may be just a vector \code{x} or a univariate time series object \code{x} of class \code{timeSeries}. First there exists a wrapper function which allows to call one from two normal tests either the Shapiro--Wilks test or the Jarque--Bera test. This wrapper was introduced for compatibility with S-Plus' FinMetrics package. Also available are the Kolmogorov--Smirnov one sample test and the D'Agostino normality test. The remaining five normal tests are the Anderson--Darling test, the Cramer--von Mises test, the Lilliefors (Kolmogorov--Smirnov) test, the Pearson chi--square test, and the Shapiro--Francia test. They are calling functions from R's contributed package \code{nortest}. The difference to the original test functions implemented in R and from contributed R packages is that the Rmetrics functions accept time series objects as input and give a more detailed output report. The Anderson-Darling test is used to test if a sample of data came from a population with a specific distribution, here the normal distribution. The \code{adTest} goodness-of-fit test can be considered as a modification of the Kolmogorov--Smirnov test which gives more weight to the tails than does the \code{ksnormTest}. } \note{ Some of the test implementations are selected from R's \code{ctest} and \code{nortest} packages. } \references{ Anderson T.W., Darling D.A. (1954); \emph{A Test of Goodness of Fit}, JASA 49:765--69. Conover, W. J. (1971); \emph{Practical nonparametric statistics}, New York: John Wiley & Sons. D'Agostino R.B., Pearson E.S. (1973); \emph{Tests for Departure from Normality}, Biometrika 60, 613--22. D'Agostino R.B., Rosman B. (1974); \emph{The Power of Geary's Test of Normality}, Biometrika 61, 181--84. Durbin J. (1961); \emph{Some Methods of Constructing Exact Tests}, Biometrika 48, 41--55. Durbin,J. (1973); \emph{Distribution Theory Based on the Sample Distribution Function}, SIAM, Philadelphia. Geary R.C. (1947); \emph{Testing for Normality}; Biometrika 36, 68--97. Lehmann E.L. (1986); \emph{Testing Statistical Hypotheses}, John Wiley and Sons, New York. Linnet K. (1988); \emph{Testing Normality of Transformed Data}, Applied Statistics 32, 180--186. Moore, D.S. (1986); \emph{Tests of the chi-squared type}, In: D'Agostino, R.B. and Stephens, M.A., eds., Goodness-of-Fit Techniques, Marcel Dekker, New York. Shapiro S.S., Francia R.S. (1972); \emph{An Approximate Analysis of Variance Test for Normality}, JASA 67, 215--216. Shapiro S.S., Wilk M.B., Chen V. (1968); \emph{A Comparative Study of Various Tests for Normality}, JASA 63, 1343--72. Thode H.C. (2002); \emph{Testing for Normality}, Marcel Dekker, New York. Weiss M.S. (1978); \emph{Modification of the Kolmogorov-Smirnov Statistic for Use with Correlated Data}, JASA 73, 872--75. Wuertz D., Katzgraber H.G. (2005); \emph{Precise finite-sample quantiles of the Jarque-Bera adjusted Lagrange multiplier test}, ETHZ Preprint. } \author{ R-core team for the tests from \R's ctest package,\cr Adrian Trapletti for the runs test from \R's tseries package,\cr Juergen Gross for the normal tests from \R's nortest package,\cr James Filliben for the Fortran program producing the runs report,\cr Diethelm Wuertz and Helmut Katzgraber for the finite sample JB tests, \cr Diethelm Wuertz for the Rmetrics \R-port. \cr Earlier versions of theses functions were based on Fortran code of Paul Johnson. } \examples{ ## Series: x = rnorm(100) ## ksnormTests - # Kolmogorov - Smirnov One-Sampel Test ksnormTest(x) ## shapiroTest - Shapiro-Wilk Test shapiroTest(x) ## jarqueberaTest - # Jarque - Bera Test # jarqueberaTest(x) # jbTest(x) } \keyword{htest} fBasics/man/utils-listIndex.Rd0000644000176200001440000000125013202116741015762 0ustar liggesusers\name{listIndex} \alias{listIndex} \title{Index File Listing} \description{ Lists the content of an index file. } \usage{ listIndex(package, character.only = FALSE) } \arguments{ \item{package}{ a literal character string or a character string denoting the name of the package to be listed. } \item{character.only}{ a logical indicating whether 'package' can be assumed to be character strings. } } \value{ prints the index file. } \seealso{ \code{\link{listDescription}}, \code{\link{listIndex}}. } \examples{ ## listIndex - listIndex("fBasics") } \keyword{programming} fBasics/man/matrix-inv.Rd0000644000176200001440000000133213202116740014757 0ustar liggesusers\name{inv} \alias{inv} \title{The Inverse of a Matrix} \description{ Returns the inverse of a matrix. } \usage{ inv(x) } \arguments{ \item{x}{ a numeric matrix. } } \note{ The function \code{inv} is a synonyme to the function \code{solve}. } \value{ returns the inverse matrix. } \references{ Golub, van Loan, (1996); \emph{Matrix Computations}, 3rd edition. Johns Hopkins University Press. } \examples{ ## Create Pascal Matrix: P = pascal(5) P ## Compute the Inverse Matrix: inv(P) ## Check: inv(P) %*% P ## Alternatives: chol2inv(chol(P)) solve(P) } \keyword{math} fBasics/man/matrix-pdl.Rd0000644000176200001440000000145413202116740014747 0ustar liggesusers\name{pdl} \alias{pdl} \title{Polynomial Distributed Lags} \description{ Returns a regressor matrix for polynomial distributed lags. } \usage{ pdl(x, d = 2, q = 3, trim = FALSE) } \arguments{ \item{x}{ a numeric vector. } \item{d}{ an integer specifying the order of the polynomial. } \item{q}{ an integer specifying the number of lags to use in creating polynomial distributed lags. This must be greater than d. } \item{trim}{ a logical flag; if TRUE, the missing values at the beginning of the returned matrix will be trimmed. } } \seealso{ \code{\link{tslag}}. } \examples{ ## pdl - # } \keyword{math} fBasics/man/dist-sgh.Rd0000644000176200001440000000431413202116741014407 0ustar liggesusers\name{sgh} \alias{sgh} \alias{dsgh} \alias{psgh} \alias{qsgh} \alias{rsgh} \title{Standardized Generalized Hyperbolic Distribution} \description{ Density, distribution function, quantile function and random generation for the standardized generalized hyperbolic distribution. } \usage{ dsgh(x, zeta = 1, rho = 0, lambda = 1, log = FALSE) psgh(q, zeta = 1, rho = 0, lambda = 1) qsgh(p, zeta = 1, rho = 0, lambda = 1) rsgh(n, zeta = 1, rho = 0, lambda = 1) } \arguments{ \item{zeta, rho, lambda}{ shape parameter \code{zeta} is positive, skewness parameter \code{rho} is in the range (-1, 1). } \item{log}{ a logical flag by default \code{FALSE}. If TRUE, log values are returned. } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{x, q}{ a numeric vector of quantiles. } } \value{ All values for the \code{*sgh} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \details{ The generator \code{rsgh} is based on the GH algorithm given by Scott (2004). } \author{ Diethelm Wuertz. } \examples{ ## rsgh - set.seed(1953) r = rsgh(5000, zeta = 1, rho = 0.5, lambda = 1) plot(r, type = "l", col = "steelblue", main = "gh: zeta=1 rho=0.5 lambda=1") ## dsgh - # Plot empirical density and compare with true density: hist(r, n = 50, probability = TRUE, border = "white", col = "steelblue", ylim = c(0, 0.6)) x = seq(-5, 5, length = 501) lines(x, dsgh(x, zeta = 1, rho = 0.5, lambda = 1)) ## psgh - # Plot df and compare with true df: plot(sort(r), (1:5000/5000), main = "Probability", col = "steelblue") lines(x, psgh(x, zeta = 1, rho = 0.5, lambda = 1)) ## qsgh - # Compute Quantiles: round(qsgh(psgh(seq(-5, 5, 1), zeta = 1, rho = 0.5), zeta = 1, rho = 0.5), 4) } \keyword{distribution} fBasics/man/matrix-pascal.Rd0000644000176200001440000000224113202116740015426 0ustar liggesusers\name{pascal} \alias{pascal} \title{Pascal Matrix} \description{ Creates a Pascal matrix. } \usage{ pascal(n) } \arguments{ \item{n}{ an integer value, the dimension of the square matrix. } } \details{ The function \code{pascal} generates a Pascal matrix of order \code{n} which is a symmetric, positive, definite matrix with integer entries made up from Pascal's triangle. The determinant of a Pascal matrix is 1. The inverse of a Pascal matrix has integer entries. If \code{lambda} is an eigenvalue of a Pascal matrix, then \code{1/lambda} is also an eigenvalue of the matrix. Pascal matrices are ill-conditioned. } \references{ Call G.S., Velleman D.J., (1993); \emph{Pascal's matrices}, American Mathematical Monthly 100, 372--376. Edelman A., Strang G., (2004); \emph{Pascal Matrices}, American Mathematical Monthly 111, 361--385. } \examples{ ## Create Pascal Matrix: P = pascal(5) P ## Determinant det(pascal(5)) det(pascal(10)) det(pascal(15)) det(pascal(20)) } \keyword{math} fBasics/man/utils-colorPalette.Rd0000644000176200001440000002153313202116740016461 0ustar liggesusers\name{colorPalette} \alias{colorPalette} \alias{rainbowPalette} \alias{heatPalette} \alias{terrainPalette} \alias{topoPalette} \alias{cmPalette} \alias{greyPalette} \alias{timPalette} \alias{rampPalette} \alias{seqPalette} \alias{divPalette} \alias{qualiPalette} \alias{focusPalette} \alias{monoPalette} \title{Color Palettes} \description{ Functions to create color palettes. \cr The functions are: \tabular{ll}{ \code{rainbowPalette} \tab Contiguous rainbow color palette, \cr \code{heatPalette} \tab Contiguous heat color palette, \cr \code{terrainPalette} \tab Contiguous terrain color palette, \cr \code{topoPalette} \tab Contiguous topo color palette, \cr \code{cmPalette} \tab Contiguous cm color palette, \cr \code{greyPalette} \tab R's gamma-corrected gray palette, \cr \code{timPalette} \tab Tim's Matlab like color palette, \cr \code{rampPalette} \tab Color ramp palettes, \cr \code{seqPalette} \tab Sequential color brewer palettes, \cr \code{divPalette} \tab Diverging color brewer palettes, \cr \code{qualiPalette} \tab Qualified color brewer palettes, \cr \code{focusPalette} \tab Red, green blue focus palettes, \cr \code{monoPalette} \tab Red, green blue mono palettes. } } \usage{ rainbowPalette(n = 64, \dots) heatPalette(n = 64, \dots) terrainPalette(n = 64, \dots) topoPalette(n = 64, \dots) cmPalette(n = 64, \dots) greyPalette(n = 64, \dots) timPalette(n = 64) rampPalette(n, name = c("blue2red", "green2red", "blue2green", "purple2green", "blue2yellow", "cyan2magenta")) seqPalette(n, name = c( "Blues", "BuGn", "BuPu", "GnBu", "Greens", "Greys", "Oranges", "OrRd", "PuBu", "PuBuGn", "PuRd", "Purples", "RdPu", "Reds", "YlGn", "YlGnBu", "YlOrBr", "YlOrRd")) divPalette(n, name = c( "BrBG", "PiYG", "PRGn", "PuOr", "RdBu", "RdGy", "RdYlBu", "RdYlGn", "Spectral")) qualiPalette(n, name = c( "Accent", "Dark2", "Paired", "Pastel1", "Pastel2", "Set1", "Set2", "Set3")) focusPalette(n, name = c("redfocus", "greenfocus", "bluefocus")) monoPalette(n, name = c("redmono", "greenmono", "bluemono")) } \arguments{ \item{n}{ an integer, giving the number of greys or colors to be constructed. } \item{name}{ a character string, the name of the color set. } \item{\dots}{ arguments to be passed, see the details section } } \value{ returns a character string of color strings. } \details{ All Rmetrics' color sets are named as \code{fooPalette} where the prefix \code{foo} denotes the name of the underlying color set. \cr \bold{R's Contiguous Color Palettes:}\cr \cr Palettes for \code{n} contiguous colors are implemented in the \code{grDevices} package. To be conform with Rmetrics' naming convention for color palettes we have build a wrapper around the underlying functions. These are the \code{rainbowPalette}, \code{heatPalette}, \code{terrainPalette}, \code{topoPalette}, and the \code{cmPalette}. Conceptually, all of these functions actually use (parts of) a line cut out of the 3-dimensional color space, parametrized by the function \code{hsv(h,s,v,gamma)}, where \code{gamma=1} for the \code{fooPalette} function, and hence, equispaced hues in RGB space tend to cluster at the red, green and blue primaries. Some applications such as contouring require a palette of colors which do not wrap around to give a final color close to the starting one. To pass additional arguments to the underlying functions we refer to consult \code{help(rainbow)}. With rainbow, the parameters start and end can be used to specify particular subranges of hues. Synonyme function calls are \code{rainbow}, \code{heat.colors},\code{terrain.colors}, \code{topo.colors}, and the \code{cm.colors}. \cr \bold{R's Gamma-Corrected Gray Palette:}\cr \cr The function \code{grayPalette} chooses a series of \code{n} gamma-corrected gray levels. The range of the gray levels can be optionally monitored through the \code{\dots} arguments, for details \code{help(gray.colors)}, which is a synonyme function call in the \code{grDevices} package. \cr \bold{Tim's Matlab like Color Palette:}\cr \cr The function \code{timPalette} creates a color set ranging from blue to red, and passes through the colors cyan, yellow, and orange. It comes from the Matlab software, originally used in fluid dynamics simulations. The function here is a copy from R's contributed package \code{fields} doing a spline interpolation on \code{n=64} color points. \cr \bold{Color Ramp Palettes:}\cr \cr The function \code{rampPalette} creates several color ramps. The function is implemented from Tim Keitt's contributed R package \code{colorRamps}. Supported through the argument \code{name} are the following color ramps: \code{"blue2red"}, \code{"green2red"}, \code{"blue2green"}, \code{"purple2green"}, \code{"blue2yellow"}, \code{"cyan2magenta"}. \cr \bold{Color Brewer Palettes:}\cr \cr The functions \code{seqPalette}, \code{divPalette}, and \code{qualiPalette} create color sets according to R's contributed \code{RColorBrewer} package. The first letter in the function name denotes the type of the color set: "s" for sequential palettes, 'd" for diverging palettes, and "q" for qualitative palettes. \cr \emph{Sequential palettes} are suited to ordered data that progress from low to high. Lightness steps dominate the look of these schemes, with light colors for low data values to dark colors for high data values. The sequential palettes names are: Blues, BuGn, BuPu, GnBu, Greens, Greys, Oranges, OrRd, PuBu, PuBuGn, PuRd, Purples, RdPu, Reds, YlGn, YlGnBu, YlOrBr, YlOrRd. \cr \emph{Diverging palettes} put equal emphasis on mid-range critical values and extremes at both ends of the data range. The critical class or break in the middle of the legend is emphasized with light colors and low and high extremes are emphasized with dark colors that have contrasting hues. The diverging palettes names are: BrBG, PiYG, PRGn, PuOr, RdBu, RdGy, RdYlBu, RdYlGn, Spectral. \cr \emph{Qualitative palettes} do not imply magnitude differences between legend classes, and hues are used to create the primary visual differences between classes. Qualitative schemes are best suited to representing nominal or categorical data. The qualitative palettes names are: Accent, Dark2, Paired, Pastel1, Pastel2, Set1, Set2, Set3. \cr In contrast to the original color brewer palettes, the palettes here are created by spline interpolation from the color variation with the most different values, i.e for the sequential palettes these are 9 values, for the diverging palettes these are 11 values, and for the qualitative palettes these are between 8 and 12 values dependeing on the color set. \cr \bold{Graph Color Palettes:}\cr \cr The function \code{perfanPalette} creates color sets inspired by R's cotributed package \code{Performance Analytics}. These color palettes have been designed to create readable, comparable line and bar graphs with specific objectives. \cr \emph{Focused Color Palettes:} Color sets designed to provide focus to the data graphed as the first element. This palette is best used when there is clearly an important data set for the viewer to focus on, with the remaining data being secondary, tertiary, etc. Later elements graphed in diminishing values of gray. \cr \emph{Monchrome Color Palettes:} These include color sets for monochrome color displays. } \note{ The palettes are wrapper functions provided in several contributed R packages. These include: Cynthia Brewer and Mark Harrower for the brewer palettes, \cr Peter Carl and Brian G. Peterson for the "PerformanceAnalytics" package, \cr Tim Keitt for the "colorRamps" package, \cr Ross Ihaka for the "colorspace" package, \cr Tomas Aragon for the "epitools" package, \cr Doug Nychka for the "fields" package, \cr Erich Neuwirth for the "RColorBrewer" package. \cr Additional undocumented hidden functions: \tabular{ll}{ % RGB CONVERTER: \code{.asRGB} \tab Converts any R color to RGB (red/green/blue), \cr % CONVERSION HEXIMAL/DECIMAL: \code{.chcode} \tab Changes from one to another number system, \cr \code{.hex.to.dec} \tab Converts heximal numbers do decimal numbers, \cr \code{.dec.to.hex} \tab Converts decimal numbers do heximal numbers.} } \examples{ ## GreyPalette: greyPalette() } \keyword{programming} fBasics/man/test-locationTest.Rd0000644000176200001440000000710413202116741016312 0ustar liggesusers\name{locationTest} \alias{locationTest} \title{Two Sample Location Tests} \description{ Tests if two series differ in their distributional location parameter. } \usage{ locationTest(x, y, method = c("t", "kw2"), title = NULL, description = NULL) } \arguments{ \item{x, y}{ numeric vectors of data values. } \item{method}{ a character string naming which test should be applied. } \item{title}{ an optional title string, if not specified the inputs data name is deparsed. } \item{description}{ optional description string, or a vector of character strings. } } \value{ In contrast to R's output report from S3 objects of class \code{"htest"} a different output report is produced. The classical tests presented here return an S4 object of class \code{"fHTEST"}. The object contains the following slots: \item{@call}{ the function call. } \item{@data}{ the data as specified by the input argument(s). } \item{@test}{ a list whose elements contain the results from the statistical test. The information provided is similar to a list object of class \code{"htest"}. } \item{@title}{ a character string with the name of the test. This can be overwritten specifying a user defined input argument. } \item{@description}{ a character string with an optional user defined description. By default just the current date when the test was applied will be returned. } The slot \code{@test} returns an object of class \code{"list"} containing (at least) the following elements: \item{statistic}{ the value(s) of the test statistic. } \item{p.value}{ the p-value(s) of the test. } \item{parameters}{ a numeric value or vector of parameters. } \item{estimate}{ a numeric value or vector of sample estimates. } \item{conf.int}{ a numeric two row vector or matrix of 95% confidence levels. } \item{method}{ a character string indicating what type of test was performed. } \item{data.name}{ a character string giving the name(s) of the data. } } \details{ The \code{method="t"} can be used to determine if the two sample means are equal for unpaired data sets. Two variants are used, assuming equal or unequal variances. The \code{method="kw2"} performs a Kruskal-Wallis rank sum test of the null hypothesis that the central tendencies or medians of two samples are the same. The alternative is that they differ. Note, that it is not assumed that the two samples are drawn from the same distribution. It is also worth to know that the test assumes that the variables under consideration have underlying continuous distributions. } \note{ Some of the test implementations are selected from \R's \code{ctest} package. } \references{ Conover, W. J. (1971); \emph{Practical nonparametric statistics}, New York: John Wiley & Sons. Lehmann E.L. (1986); \emph{Testing Statistical Hypotheses}, John Wiley and Sons, New York. } \author{ R-core team for hypothesis tests implemented from \R's package \code{ctest}. } \examples{ ## rnorm - # Generate Series: x = rnorm(50) y = rnorm(50) ## locationTest - locationTest(x, y, "t") locationTest(x, y, "kw2") } \keyword{htest} fBasics/man/matrix-triang.Rd0000644000176200001440000000360713202116741015457 0ustar liggesusers\name{triang} \alias{triang} \alias{Triang} \title{Upper and Lower Triangular Matrixes} \description{ Extracs the pper or lower tridiagonal part from a matrix. } \usage{ triang(x) Triang(x) } \arguments{ \item{x}{ a numeric matrix. } } \details{ The functions \code{triang} and \code{Triang} allow to transform a square matrix to a lower or upper triangular form. A triangular matrix is either an upper triangular matrix or lower triangular matrix. For the first case all matrix elements \code{a[i,j]} of matrix \code{A} are zero for \code{i>j}, whereas in the second case we have just the opposite situation. A lower triangular matrix is sometimes also called left triangular. In fact, triangular matrices are so useful that much computational linear algebra begins with factoring or decomposing a general matrix or matrices into triangular form. Some matrix factorization methods are the Cholesky factorization and the LU-factorization. Even including the factorization step, enough later operations are typically avoided to yield an overall time savings. Triangular matrices have the following properties: the inverse of a triangular matrix is a triangular matrix, the product of two triangular matrices is a triangular matrix, the determinant of a triangular matrix is the product of the diagonal elements, the eigenvalues of a triangular matrix are the diagonal elements. } \references{ Higham, N.J., (2002); \emph{Accuracy and Stability of Numerical Algorithms}, 2nd ed., SIAM. Golub, van Loan, (1996); \emph{Matrix Computations}, 3rd edition. Johns Hopkins University Press. } \examples{ ## Create Pascal Matrix: P = pascal(3) P ## Create lower triangle matrix L = triang(P) L } \keyword{math} fBasics/man/dist-nig.Rd0000644000176200001440000000635613202116740014412 0ustar liggesusers\name{nig} \alias{nig} \alias{dnig} \alias{pnig} \alias{qnig} \alias{rnig} \title{Normal Inverse Gaussian Distribution} \description{ Density, distribution function, quantile function and random generation for the normal inverse Gaussian distribution. } \usage{ dnig(x, alpha = 1, beta = 0, delta = 1, mu = 0, log = FALSE) pnig(q, alpha = 1, beta = 0, delta = 1, mu = 0) qnig(p, alpha = 1, beta = 0, delta = 1, mu = 0) rnig(n, alpha = 1, beta = 0, delta = 1, mu = 0) } \arguments{ \item{alpha, beta, delta, mu}{ shape parameter \code{alpha}; skewness parameter \code{beta}, \code{abs(beta)} is in the range (0, alpha); scale parameter \code{delta}, \code{delta} must be zero or positive; location parameter \code{mu}, by default 0. These are the parameters in the first parameterization. } \item{log}{ a logical flag by default \code{FALSE}. Should labels and a main title drawn to the plot? } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{x, q}{ a numeric vector of quantiles. } } \value{ All values for the \code{*nig} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \details{ The random deviates are calculated with the method described by Raible (2000). } \author{ David Scott for code implemented from \R's contributed package \code{HyperbolicDist}. } \references{ Atkinson, A.C. (1982); \emph{The simulation of generalized inverse Gaussian and hyperbolic random variables}, SIAM J. Sci. Stat. Comput. 3, 502--515. Barndorff-Nielsen O. (1977); \emph{Exponentially decreasing distributions for the logarithm of particle size}, Proc. Roy. Soc. Lond., A353, 401--419. Barndorff-Nielsen O., Blaesild, P. (1983); \emph{Hyperbolic distributions. In Encyclopedia of Statistical Sciences}, Eds., Johnson N.L., Kotz S. and Read C.B., Vol. 3, pp. 700--707. New York: Wiley. Raible S. (2000); \emph{Levy Processes in Finance: Theory, Numerics and Empirical Facts}, PhD Thesis, University of Freiburg, Germany, 161 pages. } \examples{ ## nig - set.seed(1953) r = rnig(5000, alpha = 1, beta = 0.3, delta = 1) plot(r, type = "l", col = "steelblue", main = "nig: alpha=1 beta=0.3 delta=1") ## nig - # Plot empirical density and compare with true density: hist(r, n = 25, probability = TRUE, border = "white", col = "steelblue") x = seq(-5, 5, 0.25) lines(x, dnig(x, alpha = 1, beta = 0.3, delta = 1)) ## nig - # Plot df and compare with true df: plot(sort(r), (1:5000/5000), main = "Probability", col = "steelblue") lines(x, pnig(x, alpha = 1, beta = 0.3, delta = 1)) ## nig - # Compute Quantiles: qnig(pnig(seq(-5, 5, 1), alpha = 1, beta = 0.3, delta = 1), alpha = 1, beta = 0.3, delta = 1) } \keyword{distribution} fBasics/man/dist-ghFit.Rd0000644000176200001440000000735413202116740014675 0ustar liggesusers\name{ghFit} \alias{ghFit} \title{GH Distribution Fit} \description{ Estimates the distrinbutional parameters for a generalized hyperbolic distribution. } \usage{ ghFit(x, alpha = 1, beta = 0, delta = 1, mu = 0, lambda = -1/2, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, \dots) } \arguments{ \item{x}{ a numeric vector. } \item{alpha, beta, delta, mu, lambda}{ The parameters are \code{alpha}, \code{beta}, \code{delta}, \code{mu}, and and \code{lambda}:\cr shape parameter \code{alpha}; skewness parameter \code{beta}, \code{abs(beta)} is in the range (0, alpha); scale parameter \code{delta}, \code{delta} must be zero or positive; location parameter \code{mu}, by default 0; and lambda parameter \code{lambda}, by default -1/2. } \item{scale}{ a logical flag, by default \code{TRUE}. Should the time series be scaled by its standard deviation to achieve a more stable optimization? } \item{doplot}{ a logical flag. Should a plot be displayed? } \item{span}{ x-coordinates for the plot, by default 100 values automatically selected and ranging between the 0.001, and 0.999 quantiles. Alternatively, you can specify the range by an expression like \code{span=seq(min, max, times = n)}, where, \code{min} and \code{max} are the left and right endpoints of the range, and \code{n} gives the number of the intermediate points. } \item{trace}{ a logical flag. Should the parameter estimation process be traced? } \item{title}{ a character string which allows for a project title. } \item{description}{ a character string which allows for a brief description. } \item{\dots}{ parameters to be parsed. } } \value{ returns a list with the following components: \item{estimate}{ the point at which the maximum value of the log liklihood function is obtained. } \item{minimum}{ the value of the estimated maximum, i.e. the value of the log liklihood function. } \item{code}{ an integer indicating why the optimization process terminated.\cr 1: relative gradient is close to zero, current iterate is probably solution; \cr 2: successive iterates within tolerance, current iterate is probably solution; \cr 3: last global step failed to locate a point lower than \code{estimate}. Either \code{estimate} is an approximate local minimum of the function or \code{steptol} is too small; \cr 4: iteration limit exceeded; \cr 5: maximum step size \code{stepmax} exceeded five consecutive times. Either the function is unbounded below, becomes asymptotic to a finite value from above in some direction or \code{stepmax} is too small. } \item{gradient}{ the gradient at the estimated maximum. } \item{steps}{ number of function calls. } } \details{ The function \code{\link{nlm}} is used to minimize the "negative" maximum log-likelihood function. \code{nlm} carries out a minimization using a Newton-type algorithm. } \examples{ ## ghFit - # Simulate Random Variates: set.seed(1953) s = rgh(n = 1000, alpha = 1.5, beta = 0.3, delta = 0.5, mu = -1.0) ## ghFit - # Fit Parameters: ghFit(s, alpha = 1, beta = 0, delta = 1, mu = mean(s), doplot = TRUE) } \keyword{distribution} fBasics/man/dist-nigRobMoments.Rd0000644000176200001440000000304213202116741016406 0ustar liggesusers\name{nigRobMoments} \alias{nigRobMoments} \alias{nigMED} \alias{nigIQR} \alias{nigSKEW} \alias{nigKURT} \title{Robust Moments for the NIG} \description{ Computes the first four robust moments for the Normal Inverse Gaussian Distribution. } \usage{ nigMED(alpha = 1, beta = 0, delta = 1, mu = 0) nigIQR(alpha = 1, beta = 0, delta = 1, mu = 0) nigSKEW(alpha = 1, beta = 0, delta = 1, mu = 0) nigKURT(alpha = 1, beta = 0, delta = 1, mu = 0) } \arguments{ \item{alpha, beta, delta, mu}{ are numeric values where \code{alpha} is the location parameter, \code{beta} is the location parameter, \code{delta} is the first shape parameter, and \code{mu} is the second shape parameter. } } \value{ All values for the \code{*nig} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Diethelm Wuertz. } \examples{ ## nigMED - # Median: nigMED(alpha = 1, beta = 0, delta = 1, mu = 0) ## nigIQR - # Inter-quartile Range: nigIQR(alpha = 1, beta = 0, delta = 1, mu = 0) ## nigSKEW - # Robust Skewness: nigSKEW(alpha = 1, beta = 0, delta = 1, mu = 0) ## nigKURT - # Robust Kurtosis: nigKURT(alpha = 1, beta = 0, delta = 1, mu = 0) } \keyword{distribution} fBasics/man/utils-Heaviside.Rd0000644000176200001440000000446213202116740015727 0ustar liggesusers\name{Heaviside} \alias{Heaviside} \alias{Sign} \alias{Delta} \alias{Boxcar} \alias{Ramp} \title{Haviside and Related Functions} \description{ Functions which compute the Heaviside and related functions. These include the sign function, the delta function, the boxcar function, and the ramp function. \cr The functions are: \tabular{ll}{ \code{Heaviside} \tab Computes Heaviside unit step function, \cr \code{Sign} \tab Just another signum function, \cr \code{Delta} \tab Computes delta function, \cr \code{Boxcar} \tab Computes boxcar function, \cr \code{Ramp} \tab Computes ramp function. } } \usage{ Heaviside(x, a = 0) Sign(x, a = 0) Delta(x, a = 0) Boxcar(x, a = 0.5) Ramp(x, a = 0) } \arguments{ \item{a}{ a numeric value, the location of the break.\cr } \item{x}{ a numeric vector. } } \details{ The Heaviside step function \code{Heaviside} is 1 for \code{x>a}, \code{1/2} for \code{x=a}, and \code{0} for \code{xa}, \code{0} for \code{x=a}, and \code{-1} for \code{x infinity samples = 1000 # Range of expected Drawdons xlim = c(0, 5)*sqrt(horizon) # Plot Histogram of Simulated Max Drawdowns: r = rmaxdd(n = samples, mean = 0, sd = 1, horizon = horizon) hist(x = r, n = 40, probability = TRUE, xlim = xlim, col = "steelblue4", border = "white", main = "Max. Drawdown Density") points(r, rep(0, samples), pch = 20, col = "orange", cex = 0.7) ## dmaxdd - x = seq(0, xlim[2], length = 200) d = dmaxdd(x = x, sd = 1, horizon = horizon, N = 1000) lines(x, d, lwd = 2) ## pmaxdd - # Count Frequencies of Drawdowns Greater or Equal to "h": n = 50 x = seq(0, xlim[2], length = n) g = rep(0, times = n) for (i in 1:n) g[i] = length (r[r > x[i]]) / samples plot(x, g, type ="h", lwd = 3, xlab = "q", main = "Max. Drawdown Probability") # Compare with True Probability "G_D(h)": x = seq(0, xlim[2], length = 5*n) p = pmaxdd(q = x, sd = 1, horizon = horizon, N = 5000) lines(x, p, lwd = 2, col="steelblue4") ## maxddStats - # Compute expectation Value E[D]: maxddStats(mean = -0.5, sd = 1, horizon = 10^(1:4)) maxddStats(mean = 0.0, sd = 1, horizon = 10^(1:4)) maxddStats(mean = 0.5, sd = 1, horizon = 10^(1:4)) } \keyword{distribution} fBasics/man/stableSlider.Rd0000644000176200001440000000134113202116741015277 0ustar liggesusers\name{StableSlider} \title{Slider GUI for Stable Distribution} \alias{stableSlider} \description{ The \code{stableSlider()} function provides interactive displays of density and probabilities of stable distributions. } \usage{ stableSlider(col= "steelblue", col.med = "gray30") } \arguments{ \item{col, col.med}{optional arguments for the slider.} } \value{ The \code{stableSlider()} function displays densities and probabilities of the skew stable distribution, for educational purposes. } \author{ Diethelm Wuertz for the Rmetrics \R-port. } \references{ see those in \code{\link[stabledist]{dstable}}, in package \pkg{stabledist}. } \examples{ if(dev.interactive()) stableSlider() } \keyword{distribution} fBasics/man/matrix-kron.Rd0000644000176200001440000000146313202116740015141 0ustar liggesusers\name{kron} \alias{kron} \title{Kronecker Product} \description{ Returns the Kronecker product. } \usage{ kron(x, y) } \arguments{ \item{x, y}{ two numeric matrixes. } } \details{ The \emph{Kronecker product} can be computed using the operator \code{\%x\%} or alternatively using the function \code{kron} for SPlus compatibility. } \note{ \code{kron} is a synonyme to \code{\%x\%}. } \references{ Golub, van Loan, (1996); \emph{Matrix Computations}, 3rd edition. Johns Hopkins University Press. } \examples{ ## Create Pascal Matrix: P = pascal(3) P ## Return the Kronecker Product kron(P, diag(3)) P %x% diag(3) } \keyword{math} fBasics/man/plot-scalinglawPlot.Rd0000644000176200001440000000527013202116741016626 0ustar liggesusers\name{ScalingLawPlot} \alias{scalinglawPlot} \alias{scalinglawPlot} \title{Scaling Law Bahaviour} \description{ Evaluates the scaling exponent of a financial return series and plots the scaling law. } \usage{ scalinglawPlot(x, span = ceiling(log(length(x)/252)/log(2)), doplot = TRUE, labels = TRUE, trace = TRUE, \dots) } \arguments{ \item{doplot}{ a logical value. Should a plot be displayed? } \item{labels}{ a logical value. Whether or not x- and y-axes should be automatically labeled and a default main title should be added to the plot. By default \code{TRUE}. } \item{span}{ an integer value, determines for the \code{qqgaussPlot} the plot range, by default 5, and for the \code{scalingPlot} a reasonable number of of points for the scaling range, by default daily data with 252 business days per year are assumed. } \item{trace}{ a logical value. Should the computation be traced? } \item{x}{ an uni- or multivariate return series of class \code{timeSeries} or any other object which can be transformed by the function \code{as.timeSeries()} into an object of class \code{timeSeries}. } \item{\dots}{ arguments to be passed. } } \value{ returns a list with the following components: \code{Intercept}, \code{Exponent} the scaling exponent, and \code{InverseExponent} its inverse value. } \details{ \bold{Scaling Behavior:} \cr\cr The function \code{scalingPlot} plots the scaling law of financial time series under aggregation and returns an estimate for the scaling exponent. The scaling behavior is a very striking effect of the foreign exchange market and also other markets expressing a regular structure for the volatility. Considering the average absolute return over individual data periods one finds a scaling power law which relates the mean volatility over given time intervals to the size of these intervals. The power law is in many cases valid over several orders of magnitude in time. Its exponent usually deviates significantly from a Gaussian random walk model which implies 1/2. } \references{ Taylor S.J. (1986); \emph{Modeling Financial Time Series}, John Wiley and Sons, Chichester. } \author{ Diethelm Wuertz for the Rmetrics \R-port. } \examples{ ## data - SPI <- LPP2005REC[, "SPI"] plot(SPI, type = "l", col = "steelblue", main = "SP500") abline(h = 0, col = "grey") ## teffectPlot - # Scaling Law Effect: scalinglawPlot(SPI) } \keyword{hplot} fBasics/man/plot-seriesPlot.Rd0000644000176200001440000001020113202116741015762 0ustar liggesusers\name{TimeSeriesPlots} \alias{seriesPlot} \alias{returnPlot} \alias{cumulatedPlot} \alias{drawdownPlot} \title{Financial Time Series Plots} \description{ Returns an index/price, a return, or a drawdown plot. \cr List of Functions: \tabular{ll}{ \code{seriesPlot} \tab Returns a tailored return series plot, \cr \code{cumulatedPlot} \tab Displays a cumulated series given the returns, \cr \code{returnPlot} \tab Displays returns given the cumulated series, \cr \code{drawdownPlot} \tab Displays drawdowns given the return series.} } \usage{ seriesPlot(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, \dots) cumulatedPlot(x, index = 100, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, \dots) returnPlot(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, \dots) drawdownPlot(x, labels = TRUE, type = "l", col = "steelblue", title = TRUE, grid = TRUE, box = TRUE, rug = TRUE, \dots) } \arguments{ \item{box}{ a logical flag, should a box be added to the plot? By default \code{TRUE}. } \item{col}{ the color for the series. In the univariate case use just a color name like the default, \code{col="steelblue"}, in the multivariate case we recommend to select the colors from a color palette, e.g. \code{col=heat.colors(ncol(x))}. } \item{grid}{ a logical flag, should a grid be added to the plot? By default \code{TRUE}. } \item{index}{ a numeric value, by default 100. The function cumulates column by colum the returns and multiplies the result with the index value: \code{index*exp(colCumsums(x))}. } \item{labels}{ a logical flag, should the plot be returned with default labels and decorated in an automated way? By default \code{TRUE}. } \item{rug}{ a logical flag, by default TRUE. Should a rug representation of the data added to the plot? } \item{title}{ a logical flag, by default TRUE. Should a default title added to the plot? } \item{type}{ what type of plot should be drawn? By default we use a line plot, \code{type="l"}. An alternative plot style which produces nice figures is for example \code{type="h"}. } \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } \item{\dots}{ optional arguments to be passed. } } \details{ The plot functions can be used to plot univariate and multivariate time series of class \code{timeSeries}. The graphical parameters \code{type} and \code{col} can be set by the values specified through the argument list. In the case of multivariate time series \code{col} can be specified by the values returned by a color palette. Automated titles including main title, x- and y-lables, grid lines, box style and rug represenatations cann be selected by setting these arguments to \code{TRUE} which is the default. If the title flag is unset, then the main title, x-, and y-labels are empty strings. This allows to set user defined labels with the function \code{title} after the plot is drawn. Beside \code{type}, \code{col}, \code{main}, \code{xlab} and \code{ylab}, all other \code{par} arguments can be passed to the \code{plot} function. If the \code{labels} flag is unset to \code{FALSE}, then no decorations will be added tothe plot, and the plot can be fully decorated by the user. } \value{ displays a time series plot. } \examples{ ## seriesPlot - tS <- as.timeSeries(data(LPP2005REC)) seriesPlot(tS) } \keyword{programming} fBasics/man/data-examples.Rd0000644000176200001440000001142213202116741015410 0ustar liggesusers\name{fBasicsData} \alias{fBasicsData} \alias{Capitalization} \alias{cars2} \alias{DowJones30} \alias{HedgeFund} \alias{msft.dat} \alias{nyse} \alias{PensionFund} \alias{swissEconomy} \alias{SWXLP} \alias{usdthb} %%% These should be removed \alias{.HedgeFund1} \alias{.HedgeFund2} %-------------------------------------------------------------- \title{fBsiscs Data Sets} \description{ The following data sets are part of this package: \tabular{ll}{ \code{Capitalization} \tab Market capitalization of domestic companies, \cr \code{cars2} \tab Data for various car models, \cr \code{DowJones30} \tab Down Jones 30 stocks, \cr \code{HedgeFund} \tab Hennessee Hedge Fund Indices, \cr \code{msft.dat} \tab Daily Microsoft OHLC prices and volume, \cr \code{nyse} \tab NYSE composite Index, \cr \code{PensionFund} \tab Swiss Pension Fund LPP-2005, \cr \code{swissEconomy} \tab Swiss Economic Data, \cr \code{SWXLP} \tab Swiss Pension Fund LPP-2000, \cr \code{usdthb} \tab Tick data of USD to THB. } } %-------------------------------------------------------------- \details{ \bold{Capitalization:}\cr \code{Capitalization} contains market capitalization of domestic companies from 2003 - 2008 in USD millions. \bold{cars2:}\cr \code{cars2} contains the price, country, reliability, mileage, type, weight, engine displacement and net horsepower of various car models. \bold{DowJones30:}\cr \code{DowJones30} contains daily observations from the Dow Jones 30 Index series. Each of the thirty columns represents the closing price of a stock in the Index. \bold{HedgeFund:}\cr \code{HedgeFund} contains monthly percentual returns of various hedge fund strategies from Hennessee Group LLC. \bold{msft.dat:}\cr \code{msft.dat} contains daily prices (open, high, low and close) and volumes for the Microsoft stocks. \bold{nyse:}\cr \code{nyse} contains daily records of the NYSE Composite Index. \bold{PensionFund:}\cr \code{PensionFund} is a daily data set of the Swiss pension fund benchmark LPP-2005. The data set ranges from 2005-11-01 to 2007-04-11. The columns are named: SBI, SPI, SII, LMI, MPI, ALT, LPP25, LPP40, LPP60 \bold{swissEconomy:}\cr \code{swissEconomy} contains the GDP per capita, exports, imports, interest rates, inflation, unemployment and population for the years 1964 - 1999 for Switzerland. \bold{SWXLP:}\cr \code{SWXLP} is a daily data set of the Swiss pension fund benchmark LPP-2000. The data set ranges from 2000-01-03 to 2007-05-08. The columns are named: SBI, SPI, SII, LP25, LP40, LP60. \bold{usdthb:}\cr \code{usdthb} Tick data of US Dollar (USD) in Thailand Bhat (THB) colleted from Reuters. Format: YYYYMMDDhhmm. Column variables: delay time, contributer, bid and ask prices, and quality flag. It covers the Asia FX crisis in June 1997. } %-------------------------------------------------------------- \references{ \bold{Capitalization:}\cr \emph{World Federation of Stock Exchanges}, http://www.world-exchanges.org/statistics. \bold{cars2:}\cr Derived from the car90 dataset within the rpart package. The car90 dataset is based on the car.all dataset in S-PLUS. Original data comes from: April 1990, \emph{Consumer Reports Magazine}, pages 235-255, 281-285 and 287-288. % Package rpart (dataset: car90) % This is derived (with permission) from the data set car.all % in S-PLUS, but with some further clean up of variable names and definitions. % http://ftp.yzu.edu.tw/CRAN/doc/contrib/Lam-IntroductionToR_LHL.pdf % http://www.uni-muenster.de/ZIV.BennoSueselbeck/s-html/helpfiles/car.all.html \bold{DowJones30}\cr http://www.yahoo.com. \bold{HedgeFund:}\cr http://www.hennesseegroup.com/indices/returns/year/2005.html. \bold{msft.dat:}\cr http://www.yahoo.com. \bold{nyse:}\cr http://www.nyse.com. \bold{PensionFund:}\cr SBI, SPI, SII: SIX (Swiss Exchange Zurich); LPP25, LPP40, LPP60: Banque Pictet Geneva; LMI, MPI, ALT: Recalculated from the indices and benchmarks \bold{swissEconomy:}\cr http://www.oecd.org/ and http://www.imf.org/. \bold{SWXLP:}\cr SBI, SPI, SII: SIX (Swiss Exchange Zurich); LPP25, LPP40, LPP60: Banque Pictet Geneva \bold{usdthb:}\cr Reuters Select Feed Terminal (1997). % \bold{Example:}\cr % McCullough B.D., Renfro C.G. (1998); % \emph{Benchmarks and Software Standards: A Case Study of GARCH Procedures}, % Journal of Economic and Social Measurement 25, 59--71. } %-------------------------------------------------------------- \examples{ ## Plot DowJones30 Example Data Set series <- as.timeSeries(DowJones30) head(series) plot(series[,1:6], type = "l") } \keyword{datasets} fBasics/man/dist-hyp.Rd0000644000176200001440000001036013202116741014424 0ustar liggesusers\name{hyp} \alias{hyp} \alias{dhyp} \alias{phyp} \alias{qhyp} \alias{rhyp} \title{Hyperbolic Distribution} \description{ Density, distribution function, quantile function and random generation for the hyperbolic distribution. } \usage{ dhyp(x, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), log = FALSE) phyp(q, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), \dots) qhyp(p, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4"), \dots) rhyp(n, alpha = 1, beta = 0, delta = 1, mu = 0, pm = c("1", "2", "3", "4")) } \arguments{ \item{alpha, beta, delta, mu}{ shape parameter \code{alpha}; skewness parameter \code{beta}, \code{abs(beta)} is in the range (0, alpha); scale parameter \code{delta}, \code{delta} must be zero or positive; location parameter \code{mu}, by default 0. These is the meaning of the parameters in the first parameterization \code{pm=1} which is the default parameterization selection. In the second parameterization, \code{pm=2} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{zeta} and \code{rho}. In the third parameterization, \code{pm=3} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{xi} and \code{chi}. In the fourth parameterization, \code{pm=4} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{a.bar} and \code{b.bar}. } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{pm}{ an integer value between \code{1} and \code{4} for the selection of the parameterization. The default takes the first parameterization. } \item{x, q}{ a numeric vector of quantiles. } \item{log}{ a logical, if TRUE, probabilities \code{p} are given as \code{log(p)}. } \item{\dots}{ arguments to be passed to the function \code{integrate}. } } \value{ All values for the \code{*hyp} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \details{ The generator \code{rhyp} is based on the HYP algorithm given by Atkinson (1982). } \author{ David Scott for code implemented from \R's contributed package \code{HyperbolicDist}. } \references{ Atkinson, A.C. (1982); \emph{The simulation of generalized inverse Gaussian and hyperbolic random variables}, SIAM J. Sci. Stat. Comput. 3, 502--515. Barndorff-Nielsen O. (1977); \emph{Exponentially decreasing distributions for the logarithm of particle size}, Proc. Roy. Soc. Lond., A353, 401--419. Barndorff-Nielsen O., Blaesild, P. (1983); \emph{Hyperbolic distributions. In Encyclopedia of Statistical Sciences}, Eds., Johnson N.L., Kotz S. and Read C.B., Vol. 3, pp. 700--707. New York: Wiley. Raible S. (2000); \emph{Levy Processes in Finance: Theory, Numerics and Empirical Facts}, PhD Thesis, University of Freiburg, Germany, 161 pages. } \examples{ ## hyp - set.seed(1953) r = rhyp(5000, alpha = 1, beta = 0.3, delta = 1) plot(r, type = "l", col = "steelblue", main = "hyp: alpha=1 beta=0.3 delta=1") ## hyp - # Plot empirical density and compare with true density: hist(r, n = 25, probability = TRUE, border = "white", col = "steelblue") x = seq(-5, 5, 0.25) lines(x, dhyp(x, alpha = 1, beta = 0.3, delta = 1)) ## hyp - # Plot df and compare with true df: plot(sort(r), (1:5000/5000), main = "Probability", col = "steelblue") lines(x, phyp(x, alpha = 1, beta = 0.3, delta = 1)) ## hyp - # Compute Quantiles: qhyp(phyp(seq(-5, 5, 1), alpha = 1, beta = 0.3, delta = 1), alpha = 1, beta = 0.3, delta = 1) } \keyword{distribution} fBasics/man/dist-sghFit.Rd0000644000176200001440000000671513202116741015061 0ustar liggesusers\name{sghFit} \alias{sghFit} \title{Standardized GH Distribution Fit} \description{ Estimates the distrinbutional parameters for a standardized generalized hyperbolic distribution. } \usage{ sghFit(x, zeta = 1, rho = 0, lambda = 1, include.lambda = TRUE, scale = TRUE, doplot = TRUE, span = "auto", trace = TRUE, title = NULL, description = NULL, \dots) } \arguments{ \item{x}{ a numeric vector. } \item{zeta, rho, lambda}{ shape parameter \code{zeta} is positive, skewness parameter \code{rho} is in the range (-1, 1). and index parameter \code{lambda}, by default 1. } \item{include.lambda}{ a logical flag, by default \code{TRUE}. Should the index parameter \code{lambda} included in the parameter estimate? } \item{scale}{ a logical flag, by default \code{TRUE}. Should the time series be scaled by its standard deviation to achieve a more stable optimization? } \item{doplot}{ a logical flag. Should a plot be displayed? } \item{span}{ x-coordinates for the plot, by default 100 values automatically selected and ranging between the 0.001, and 0.999 quantiles. Alternatively, you can specify the range by an expression like \code{span=seq(min, max, times = n)}, where, \code{min} and \code{max} are the left and right endpoints of the range, and \code{n} gives the number of the intermediate points. } \item{trace}{ a logical flag. Should the parameter estimation process be traced? } \item{title}{ a character string which allows for a project title. } \item{description}{ a character string which allows for a brief description. } \item{\dots}{ parameters to be parsed. } } \value{ returns a list with the following components: \item{estimate}{ the point at which the maximum value of the log liklihood function is obtained. } \item{minimum}{ the value of the estimated maximum, i.e. the value of the log liklihood function. } \item{code}{ an integer indicating why the optimization process terminated.\cr 1: relative gradient is close to zero, current iterate is probably solution; \cr 2: successive iterates within tolerance, current iterate is probably solution; \cr 3: last global step failed to locate a point lower than \code{estimate}. Either \code{estimate} is an approximate local minimum of the function or \code{steptol} is too small; \cr 4: iteration limit exceeded; \cr 5: maximum step size \code{stepmax} exceeded five consecutive times. Either the function is unbounded below, becomes asymptotic to a finite value from above in some direction or \code{stepmax} is too small. } \item{gradient}{ the gradient at the estimated maximum. } \item{steps}{ number of function calls. } } \examples{ ## sghFit - # Simulate Random Variates: set.seed(1953) s = rsgh(n = 2000, zeta = 0.7, rho = 0.5, lambda = 0) ## sghFit - # Fit Parameters: sghFit(s, zeta = 1, rho = 0, lambda = 1, include.lambda = TRUE, doplot = TRUE) } \keyword{distribution} fBasics/man/dist-ssd.Rd0000644000176200001440000000350713202116741014422 0ustar liggesusers\name{ssd} \alias{ssd} \alias{dssd} \alias{pssd} \alias{qssd} \alias{rssd} \title{Spline Smoothed Distribution} \description{ Density, distribution function, quantile function and random generation from smoothing spline estimates. } \usage{ dssd(x, param, log = FALSE) pssd(q, param) qssd(p, param) rssd(n, param) } \arguments{ \item{param}{ an object as returned by the function \code{ssdFit}.. } \item{log}{ a logical flag by default \code{FALSE}. Should labels and a main title drawn to the plot? } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{x, q}{ a numeric vector of quantiles. } } \value{ All values for the \code{*ssd} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \author{ Diethelm Wuertz, Chong Gu for the underlying \code{gss} package. } \references{ Gu, C. (2002), \emph{Smoothing Spline ANOVA Models}, New York Springer--Verlag. Gu, C. and Wang, J. (2003), \emph{Penalized likelihood density estimation: Direct cross-validation and scalable approximation}, Statistica Sinica, 13, 811--826. } \examples{ ## ssdFit - set.seed(1953) r = rnorm(500) hist(r, breaks = "FD", probability = TRUE, col = "steelblue", border = "white") ## ssdFit - param = ssdFit(r) ## dssd - u = seq(min(r), max(r), len = 301) v = dssd(u, param) lines(u, v, col = "orange", lwd = 2) } \keyword{distribution} fBasics/man/dist-gld.Rd0000644000176200001440000000504613202116740014376 0ustar liggesusers\name{gld} \alias{gld} \alias{dgld} \alias{pgld} \alias{qgld} \alias{rgld} \title{Generalized Lambda Distribution} \description{ Density, distribution function, quantile function and random generation for the generalized lambda distribution. } \usage{ dgld(x, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8, log = FALSE) pgld(q, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) qgld(p, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) rgld(n, lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) } \arguments{ \item{lambda1, lambda2, lambda3, lambda4}{ are numeric values where \code{lambda1} is the location parameter, \code{lambda2} is the location parameter, \code{lambda3} is the first shape parameter, and \code{lambda4} is the second shape parameter. } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{x, q}{ a numeric vector of quantiles. } \item{log}{ a logical, if TRUE, probabilities \code{p} are given as \code{log(p)}. } } \value{ All values for the \code{*gld} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Chong Gu for code implemented from \R's contributed package \code{gld}. } \examples{ ## rgld - set.seed(1953) r = rgld(500, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) plot(r, type = "l", col = "steelblue", main = "gld: lambda1=0 lambda2=-1 lambda3/4=-1/8") ## dgld - # Plot empirical density and compare with true density: hist(r, n = 25, probability = TRUE, border = "white", col = "steelblue") x = seq(-5, 5, 0.25) lines(x, dgld(x, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8)) ## pgld - # Plot df and compare with true df: plot(sort(r), ((1:500)-0.5)/500, main = "Probability", col = "steelblue") lines(x, pgld(x, lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8)) ## qgld - # Compute Quantiles: qgld(pgld(seq(-5, 5, 1), lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8), lambda1=0, lambda2=-1, lambda3=-1/8, lambda4=-1/8) } \keyword{distribution} fBasics/man/matrix-gridVector.Rd0000644000176200001440000000132413202116740016274 0ustar liggesusers\name{gridVector} \alias{gridVector} \title{Grid Vector Coordinates} \description{ Creates from two vectors rectangular grid coordinates.. } \usage{ gridVector(x, y = NULL)} \arguments{ \item{x, y}{ two numeric vectors of length m and n which span the rectangular grid of size m times n. If \code{y} takes the default value, \code{NULL}, then \code{y=x}. } } \value{ returns a list with two entries named \code{$X} and \code{$Y}, giving the coordinates which span the bivariate grid. } \seealso{ \code{\link{expand.grid}}. } \examples{ ## gridVector - gridVector((0:10)/10) gridVector((0:10)/10, (0:10)/10) } \keyword{hplot} fBasics/man/dist-hypRobMoments.Rd0000644000176200001440000000422113202116740016430 0ustar liggesusers\name{hypRobMoments} \alias{hypRobMoments} \alias{hypMED} \alias{hypIQR} \alias{hypSKEW} \alias{hypKURT} \title{Robust Moments for the HYP} \description{ Computes the first four robust moments for the hyperbolic distribution. } \usage{ hypMED(alpha = 1, beta = 0, delta = 1, mu = 0) hypIQR(alpha = 1, beta = 0, delta = 1, mu = 0) hypSKEW(alpha = 1, beta = 0, delta = 1, mu = 0) hypKURT(alpha = 1, beta = 0, delta = 1, mu = 0) } \arguments{ \item{alpha, beta, delta, mu}{ shape parameter \code{alpha}; skewness parameter \code{beta}, \code{abs(beta)} is in the range (0, alpha); scale parameter \code{delta}, \code{delta} must be zero or positive; location parameter \code{mu}, by default 0. These is the meaning of the parameters in the first parameterization \code{pm=1} which is the default parameterization selection. In the second parameterization, \code{pm=2} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{zeta} and \code{rho}. In the third parameterization, \code{pm=3} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{xi} and \code{chi}. In the fourth parameterization, \code{pm=4} \code{alpha} and \code{beta} take the meaning of the shape parameters (usually named) \code{a.bar} and \code{b.bar}. } } \value{ All values for the \code{*hyp} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Diethelm Wuertz. } \examples{ ## hypMED - # Median: hypMED(alpha = 1, beta = 0, delta = 1, mu = 0) ## hypIQR - # Inter-quartile Range: hypIQR(alpha = 1, beta = 0, delta = 1, mu = 0) ## hypSKEW - # Robust Skewness: hypSKEW(alpha = 1, beta = 0, delta = 1, mu = 0) ## hypKURT - # Robust Kurtosis: hypKURT(alpha = 1, beta = 0, delta = 1, mu = 0) } \keyword{distribution} fBasics/man/dist-ghtMoments.Rd0000644000176200001440000000366113202116741015757 0ustar liggesusers\name{ghtMoments} \alias{ghtMoments} \alias{ghtMean} \alias{ghtVar} \alias{ghtSkew} \alias{ghtKurt} \alias{ghtMoments} \title{Generalized Hyperbolic Student-t Moments} \description{ Calculates moments of the generalized hyperbbolic Student-t distribution function. } \usage{ ghtMean(beta=0.1, delta=1, mu=0, nu=10) ghtVar(beta=0.1, delta=1, mu=0, nu=10) ghtSkew(beta=0.1, delta=1, mu=0, nu=10) ghtKurt(beta=0.1, delta=1, mu=0, nu=10) ghtMoments(order, type = c("raw", "central", "mu"), beta=0.1, delta=1, mu=0, nu=10) } \arguments{ \item{beta, delta, mu}{ numeric values. \code{beta} is the skewness parameter in the range \code{(0, alpha)}; \code{delta} is the scale parameter, must be zero or positive; \code{mu} is the location parameter, by default 0. These are the parameters in the first parameterization. } \item{nu}{ a numeric value, the number of degrees of freedom. Note, \code{alpha} takes the limit of \code{abs(beta)}, and \code{lambda=-nu/2}. } \item{order}{ an integer value, the order of the moment. } \item{type}{ a character value, \code{"raw"} returns the moments about zero, \code{"central"} returns the central moments about the mean, and \code{"mu"} returns the moments about the location parameter \code{mu}. } } \value{ a numerical value. } \references{ Scott, D.J., Wuertz, D. and Tran, T.T. (2008) \emph{Moments of the Generalized Hyperbolic Distribution}. Preprint. } \author{ Diethelm Wuertz. } \examples{ ## ghtMean - ghtMean(beta=0.2, delta=1.2, mu=-0.5, nu=4) ## ghtKurt - ghtKurt(beta=0.2, delta=1.2, mu=-0.5, nu=4) ## ghtMoments - ghtMoments(4, beta=0.2, delta=1.2, mu=-0.5, nu=4) ghtMoments(4, "central", beta=0.2, delta=1.2, mu=-0.5, nu=4) } \keyword{distribution} fBasics/man/dist-ghSlider.Rd0000644000176200001440000000103113202116740015357 0ustar liggesusers\name{ghSlider} \alias{ghSlider} \title{Generalized Hyperbolic Distribution Slider} \description{ Displays interactively the dependence of the generalized hyperbolic distribution on its parameters. } \usage{ ghSlider() } \value{ a tcl/tk based graphical user interface. This is a nice display for educational purposes to investigate the densities and probabilities of the generalized hyperbolic distribution. } \examples{ ## ghSlider - # ghSlider() } \keyword{distribution} fBasics/man/matrix-norm.Rd0000644000176200001440000000422013202116740015135 0ustar liggesusers\name{norm} \alias{norm2} \title{Matrix Norm} \description{ Returns the norm of a matrix. } \usage{ norm2(x, p = 2) } \arguments{ \item{x}{ a numeric matrix. } \item{p}{ an integer value, \code{1}, \code{2} or \code{Inf}. \code{p=1} - The maximum absolute column sum norm which is defined as the maximum of the sum of the absolute valued elements of columns of the matrix. \code{p=2} - The spectral norm is "the norm" of a matrix \code{X}. This value is computed as the square root of the maximum eigenvalue of \code{CX} where \code{C} is the conjugate transpose. \code{p=Inf} - The maximum absolute row sum norm is defined as the maximum of the sum of the absolute valued elements of rows of the matrix. } } \value{ returns the value of the norm of the matrix. } \details{ The function \code{norm2} computes the norm of a matrix. Three choices are possible: \code{p=1} - The maximum absolute column sum norm which is defined as the maximum of the sum of the absolute valued elements of columns of the matrix. \code{p=2} - The spectral norm is "the norm" of a matrix \code{X}. This value is computed as the square root of the maximum eigenvalue of \code{CX} where \code{C} is the conjugate transpose. \code{p=Inf} - The maximum absolute row sum norm is defined as the maximum of the sum of the absolute valued elements of rows of the matrix. Note, the function \code{fBasics::norm()} has become obsolete, since \code{base::norm()} has become available in the R base environment. To avoid conflicts with \code{norm()} we have renamed in the fBasics package as \code{norm2}. } \references{ Golub, van Loan, (1996); \emph{Matrix Computations}, 3rd edition. Johns Hopkins University Press. } \examples{ ## Create Pascal Matrix: P <- pascal(5) P ## Return the Norm of the Matrix: norm2(P) } \keyword{math} fBasics/man/plot-qqPlot.Rd0000644000176200001440000000646313202116741015130 0ustar liggesusers\name{QuantileQuantilePlots} \alias{qqnormPlot} \alias{qqnigPlot} \alias{qqghtPlot} \alias{qqgldPlot} \title{Quantile-Quantile Plots} \description{ Returns quantile-quantile plots for the normal, the normal inverse Gaussian, the generalized hyperbolic Student-t and the generalized lambda distribution. \cr List of Functions: \tabular{ll}{ \code{qqnormPlot} \tab Returns a tailored Normal quantile-quantile plot, \cr \code{qqnigPlot} \tab Returns a tailored NIG quantile-quantile plot, \cr \code{qqghtPlot} \tab Returns a tailored GHT quantile-quantile plot, \cr \code{qqgldPlot} \tab Returns a tailored GLD quantile-quantile plot.} } \usage{ qqnormPlot(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, \dots) qqnigPlot(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, \dots) qqghtPlot(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, \dots) qqgldPlot(x, labels = TRUE, col = "steelblue", pch = 19, title = TRUE, mtext = TRUE, grid = FALSE, rug = TRUE, scale = TRUE, \dots) } \arguments{ \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } \item{labels}{ a logical flag, should the plot be returned with default labels and decorated in an automated way? By default \code{TRUE}. } \item{col}{ the color for the series. In the univariate case use just a color name like the default, \code{col="steelblue"}, in the multivariate case we recommend to select the colors from a color palette, e.g. \code{col=heat.colors(ncol(x))}. } \item{pch}{ an integer value, by default 19. Which plot character should be used in the plot? } \item{title}{ a logical flag, by default TRUE. Should a default title added to the plot? } \item{mtext}{ a logical flag, by default TRUE. Should a marginal text be printed on the third site of the graph? } \item{grid}{ a logical flag, should a grid be added to the plot? By default \code{TRUE}. To plot a horizontal lines only use \code{grid="h"} and for vertical lines use \code{grid="h"}, respectively. } \item{rug}{ a logical flag, by default TRUE. Should a rug representation of the data added to the plot? } \item{scale}{ a logical flag, by default TRUE. Should the time series be scaled for the investigation? } \item{\dots}{ optional arguments to be passed. } } \value{ displays a quantile-quantile plot. } \author{ Diethelm Wuertz for the Rmetrics \R-port. } \examples{ ## data - SPI <- LPP2005REC[, "SPI"] plot(SPI, type = "l", col = "steelblue", main = "SP500") abline(h = 0, col = "grey") ## qqPlot - qqnormPlot(SPI) } \keyword{programming} fBasics/man/stats-interpKrige.Rd0000644000176200001440000000360513202134462016306 0ustar liggesusers\name{krigeInterp} \title{Bivariate Krige Interpolation} \alias{krigeInterp} \description{ Bivariate Krige Interpolation. } \usage{ krigeInterp(x, y = NULL, z = NULL, gridPoints = 21, xo = seq(min(x), max(x), length = gridPoints), yo = seq(min(y), max(y), length = gridPoints), extrap = FALSE, polDegree = 6) } \arguments{ \item{x, y, z}{ the arguments \code{x} and \code{y} are two numeric vectors of grid pounts, and \code{z} is a numeric matrix or any other rectangular object which can be transformed by the function \code{as.matrix} into a matrix object. } \item{gridPoints}{ an integer value specifying the number of grid points in \code{x} and \code{y} direction. } \item{xo, yo}{ two numeric vectors of data points spanning the grid. } \item{extrap}{ a logical, if \code{TRUE} then the data points are extrapolated. } \item{polDegree}{ the polynomial krige degree, an integer ranging between 1 and 6. } } \note{ The function \code{krigeInterp()} requires the \R package \pkg{spatial}. } \value{ \code{krigeInterp} returns a list with at least three entries, \code{x}, \code{y} and \code{z}. Note, that the returned values, can be directly used by the \code{\link{persp}} and \code{\link{contour}} 3D plotting methods. } \seealso{ \code{\link{akimaInterp}}, \code{\link{linearInterp}}. } \examples{\donttest{ ## The akima library is not auto-installed because of a different licence. ## krigeInterp - Kriging: set.seed(1953) x = runif(999) - 0.5 y = runif(999) - 0.5 z = cos(2*pi*(x^2+y^2)) ans = krigeInterp(x, y, z, extrap = FALSE) persp(ans, theta = -40, phi = 30, col = "steelblue", xlab = "x", ylab = "y", zlab = "z") contour(ans) } } \keyword{programming} fBasics/man/plot-histPlot.Rd0000644000176200001440000000571313202116741015453 0ustar liggesusers\name{HistogramPlot} \alias{histPlot} \alias{densityPlot} \alias{logDensityPlot} \title{Histogram and Density Plots} \description{ Returns a histogram, a density, or a logarithmic density plot. \cr List of Functions: \tabular{ll}{ \code{histPlot} \tab Returns a tailored histogram plot, \cr \code{densityPlot} \tab Returns a tailored kernel density estimate plot, \cr \code{logDensityPlot} \tab Returns a tailored log kernel density estimate plot.} } \usage{ histPlot(x, labels = TRUE, col = "steelblue", fit = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, \dots) densityPlot(x, labels = TRUE, col = "steelblue", fit = TRUE, hist = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, \dots) logDensityPlot(x, labels = TRUE, col = "steelblue", robust = TRUE, title = TRUE, grid = TRUE, rug = TRUE, skip = FALSE, \dots) } \arguments{ \item{col}{ the color for the series. In the univariate case use just a color name like the default, \code{col="steelblue"}, in the multivariate case we recommend to select the colors from a color palette, e.g. \code{col=heat.colors(ncol(x))}. } \item{fit}{ a logical flag, should a fit added to the Plot? } \item{grid}{ a logical flag, should a grid be added to the plot? By default \code{TRUE}. To plot a horizontal lines only use \code{grid="h"} and for vertical lines use \code{grid="h"}, respectively. } \item{hist}{ a logical flag, by default TRUE. Should a histogram to be underlaid to the plot? } \item{labels}{ a logical flag, should the plot be returned with default labels and decorated in an automated way? By default \code{TRUE}. } \item{rug}{ a logical flag, by default TRUE. Should a rug representation of the data added to the plot? } \item{skip}{ a logical flag, should zeros be skipped in the return Series? } \item{robust}{ a logical flag, by default TRUE. Should a robust fit added to the plot? } \item{title}{ a logical flag, by default TRUE. Should a default title added to the plot? } \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } \item{\dots}{ optional arguments to be passed. } } \value{ displays a time series plot. } \examples{ ## data - SPI <- LPP2005REC[, "SPI"] plot(SPI, type = "l", col = "steelblue", main = "SP500") abline(h = 0, col = "grey") ## histPlot - histPlot(SPI) ## densityPlot - densityPlot(SPI) } \keyword{programming} fBasics/man/utils-hessian.Rd0000644000176200001440000000072113202116741015453 0ustar liggesusers\name{tsHessian} \alias{tsHessian} \title{Two sided approximated Hessian} \description{ Computes two sided (TS) approximated Hessian. } \usage{ tsHessian(x, fun, ...) } \arguments{ \item{x}{arugment to be passed to function} \item{fun}{function} \item{\dots}{additional paramters to be passed to function} } \author{ A function borrowed from Kevin Sheppard's Matlab garch toolbox as implemented by Alexios Ghalanos in his \pkg{rgarch} package } fBasics/man/dist-ght.Rd0000644000176200001440000000464713202116741014421 0ustar liggesusers\name{ght} \alias{dght} \alias{pght} \alias{qght} \alias{rght} \title{Generalized Hyperbolic Student-t} \description{ Density, distribution function, quantile function and random generation for the hyperbolic distribution. } \usage{ dght(x, beta = 0.1, delta = 1, mu = 0, nu = 10, log = FALSE) pght(q, beta = 0.1, delta = 1, mu = 0, nu = 10) qght(p, beta = 0.1, delta = 1, mu = 0, nu = 10) rght(n, beta = 0.1, delta = 1, mu = 0, nu = 10) } \arguments{ \item{beta, delta, mu}{ numeric values. \code{beta} is the skewness parameter in the range \code{(0, alpha)}; \code{delta} is the scale parameter, must be zero or positive; \code{mu} is the location parameter, by default 0. These are the parameters in the first parameterization. } \item{nu}{ a numeric value, the number of degrees of freedom. Note, \code{alpha} takes the limit of \code{abs(beta)}, and \code{lambda=-nu/2}. } \item{x, q}{ a numeric vector of quantiles. } \item{p}{ a numeric vector of probabilities. } \item{n}{ number of observations. } \item{log}{ a logical, if TRUE, probabilities \code{p} are given as \code{log(p)}. } } \value{ All values for the \code{*ght} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \references{ Atkinson, A.C. (1982); \emph{The simulation of generalized inverse Gaussian and hyperbolic random variables}, SIAM J. Sci. Stat. Comput. 3, 502--515. Barndorff-Nielsen O. (1977); \emph{Exponentially decreasing distributions for the logarithm of particle size}, Proc. Roy. Soc. Lond., A353, 401--419. Barndorff-Nielsen O., Blaesild, P. (1983); \emph{Hyperbolic distributions. In Encyclopedia of Statistical Sciences}, Eds., Johnson N.L., Kotz S. and Read C.B., Vol. 3, pp. 700--707. New York: Wiley. Raible S. (2000); \emph{Levy Processes in Finance: Theory, Numerics and Empirical Facts}, PhD Thesis, University of Freiburg, Germany, 161 pages. } \examples{ ## ght - # } \keyword{distribution} fBasics/man/dist-ssdFit.Rd0000644000176200001440000000226213202116741015062 0ustar liggesusers\name{ssdFit} \alias{ssdFit} \title{Fit Density Using Smoothing Splines } \description{ Estimates the parameters of a density function using smoothing splines. } \usage{ ssdFit(x) } \arguments{ \item{x}{ a numeric vector. } } \value{ The function \code{ssdFit}, \code{hypFit} returns an object of class \code{ssden}. The returned object can be used to evaluate density, probabilities and quantiles. } \author{ Diethelm Wuertz, Chong Gu for the underlying \code{gss} package. } \references{ Gu, C. (2002), \emph{Smoothing Spline ANOVA Models}, New York Springer--Verlag. Gu, C. and Wang, J. (2003), \emph{Penalized likelihood density estimation: Direct cross-validation and scalable approximation}, Statistica Sinica, 13, 811--826. } \examples{ ## ssdFit - set.seed(1953) r = rnorm(500) hist(r, breaks = "FD", probability = TRUE, col = "steelblue", border = "white") ## ssdFit - param = ssdFit(r) ## dssd - u = seq(min(r), max(r), len = 301) v = dssd(u, param) lines(u, v, col = "orange", lwd = 2) } \keyword{distribution} fBasics/man/plot-boxPlot.Rd0000644000176200001440000000303513202116740015266 0ustar liggesusers\name{BoxPlot} \alias{boxPlot} \alias{boxPercentilePlot} \title{Time Series Box Plots} \description{ Returns a box or a box percentile plot. \cr List of Functions: \tabular{ll}{ \code{boxPlot} \tab Returns a side-by-side standard box plot, \cr \code{boxPercentilePlot} \tab Returns a side-by-side box-percentile plot.} } \usage{ boxPlot(x, col = "steelblue", title = TRUE, \dots) boxPercentilePlot(x, col = "steelblue", title = TRUE, \dots) } \arguments{ \item{col}{ the color for the series. In the univariate case use just a color name like the default, \code{col="steelblue"}, in the multivariate case we recommend to select the colors from a color palette, e.g. \code{col=heat.colors(ncol(x))}. } \item{title}{ a logical flag, by default TRUE. Should a default title added to the plot? } \item{x}{ an object of class \code{"timeSeries"} or any other object which can be transformed by the function \code{as.timeSeries} into an object of class \code{timeSeries}. The latter case, other then \code{timeSeries} objects, is more or less untested. } \item{\dots}{ optional arguments to be passed. } } \value{ displays a time series plot. } \examples{ ## data - LPP <- LPP2005REC[, 1:6] plot(LPP, type = "l", col = "steelblue", main = "SP500") abline(h = 0, col = "grey") ## boxPlot - boxPlot(LPP) } \keyword{programming} fBasics/man/dist-distCheck.Rd0000644000176200001440000000173313202116741015531 0ustar liggesusers\name{distCheck} \alias{distCheck} \title{Distribution Check} \description{ Tests properties of an \R implementation of a distribution, i.e. of all four of its \dQuote{dpqr} functions. } \usage{ distCheck(fun = "norm", n = 1000, robust = TRUE, subdivisions = 100, \dots) } \arguments{ \item{fun}{a character string denoting the name of the distribution.} \item{n}{an integer specifying the number of random variates to be generated.} \item{robust}{logical flag, should robust estimates be used? By default \code{TRUE}.} \item{subdivisions}{integer specifying the numbers of subdivisions in integration.} \item{\dots}{the distributional parameters.} } \examples{ distCheck("norm", mean = 1, sd = 1) distCheck("lnorm", meanlog = 0.5, sdlog = 2, robust=FALSE) ## here, true E(X) = exp(mu + 1/2 sigma^2) = exp(.5 + 2) = exp(2.5) = 12.182 ## and Var(X) = exp(2*mu + sigma^2)*(exp(sigma^2) - 1) = 7954.67 } \keyword{distribution} fBasics/man/test-varianceTest.Rd0000644000176200001440000000776113202116740016302 0ustar liggesusers\name{varianceTest} \alias{varianceTest} \title{Two Sample Variance Tests} \description{ Tests if two series differ in their distributional variance parameter. } \usage{ varianceTest(x, y, method = c("varf", "bartlett", "fligner"), title = NULL, description = NULL) } \arguments{ \item{x, y}{ numeric vectors of data values. } \item{method}{ a character string naming which test should be applied. } \item{title}{ an optional title string, if not specified the inputs data name is deparsed. } \item{description}{ optional description string, or a vector of character strings. } } \value{ In contrast to R's output report from S3 objects of class \code{"htest"} a different output report is produced. The classical tests presented here return an S4 object of class \code{"fHTEST"}. The object contains the following slots: \item{@call}{ the function call. } \item{@data}{ the data as specified by the input argument(s). } \item{@test}{ a list whose elements contain the results from the statistical test. The information provided is similar to a list object of class \code{"htest"}. } \item{@title}{ a character string with the name of the test. This can be overwritten specifying a user defined input argument. } \item{@description}{ a character string with an optional user defined description. By default just the current date when the test was applied will be returned. } The slot \code{@test} returns an object of class \code{"list"} containing (at least) the following elements: \item{statistic}{ the value(s) of the test statistic. } \item{p.value}{ the p-value(s) of the test. } \item{parameters}{ a numeric value or vector of parameters. } \item{estimate}{ a numeric value or vector of sample estimates. } \item{conf.int}{ a numeric two row vector or matrix of 95% confidence levels. } \item{method}{ a character string indicating what type of test was performed. } \item{data.name}{ a character string giving the name(s) of the data. } } \details{ The \code{method="varf"} can be used to compare variances of two normal samples performing an F test. The null hypothesis is that the ratio of the variances of the populations from which they were drawn is equal to one. The \code{method="bartlett"} performs the Bartlett test of the null hypothesis that the variances in each of the samples are the same. This fact of equal variances across samples is also called \emph{homogeneity of variances}. Note, that Bartlett's test is sensitive to departures from normality. That is, if the samples come from non-normal distributions, then Bartlett's test may simply be testing for non-normality. The Levene test (not yet implemented) is an alternative to the Bartlett test that is less sensitive to departures from normality. The \code{method="fligner"} performs the Fligner-Killeen test of the null that the variances in each of the two samples are the same. } \note{ Some of the test implementations are selected from \R's \code{ctest} package. } \references{ Conover, W. J. (1971); \emph{Practical nonparametric statistics}, New York: John Wiley & Sons. Lehmann E.L. (1986); \emph{Testing Statistical Hypotheses}, John Wiley and Sons, New York. } \author{ R-core team for hypothesis tests implemented from \R's package \code{ctest}. } \examples{ ## rnorm - # Generate Series: x = rnorm(50) y = rnorm(50) ## varianceTest - varianceTest(x, y, "varf") varianceTest(x, y, "bartlett") varianceTest(x, y, "fligner") } \keyword{htest} fBasics/man/dist-gldRobMoments.Rd0000644000176200001440000000336213202116741016404 0ustar liggesusers\name{gldRobMoments} \alias{gldRobMoments} \alias{gldMED} \alias{gldIQR} \alias{gldSKEW} \alias{gldKURT} \title{Robust Moments for the GLD} \description{ Computes the first four robust moments for the Generalized Lambda Distribution. } \usage{ gldMED(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) gldIQR(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) gldSKEW(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) gldKURT(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) } \arguments{ \item{lambda1, lambda2, lambda3, lambda4}{ are numeric values where \code{lambda1} is the location parameter, \code{lambda2} is the location parameter, \code{lambda3} is the first shape parameter, and \code{lambda4} is the second shape parameter. } } \value{ All values for the \code{*gld} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } %\references{ % go here ... %} \author{ Diethelm Wuertz. } \examples{ ## gldMED - # Median: gldMED(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) ## gldIQR - # Inter-quartile Range: gldIQR(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) ## gldSKEW - # Robust Skewness: gldSKEW(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) ## gldKURT - # Robust Kurtosis: gldKURT(lambda1 = 0, lambda2 = -1, lambda3 = -1/8, lambda4 = -1/8) } \keyword{distribution} fBasics/man/stats-interpAkima.Rd0000644000176200001440000001013013202134431016252 0ustar liggesusers\name{akimaInterp} \title{Bivariate Spline Interpolation} \alias{akimaInterp} \alias{akimaInterpp} \description{ Interpolates bivariate data sets using Akima spline interpolation. } \usage{ akimaInterp(x, y = NULL, z = NULL, gridPoints = 21, xo = seq(min(x), max(x), length = gridPoints), yo = seq(min(y), max(y), length = gridPoints), extrap = FALSE) akimaInterpp(x, y = NULL, z = NULL, xo, yo, extrap = FALSE) } \arguments{ \item{x, y, z}{ for \code{akimaInterp} the arguments \code{x} and \code{y} are two numeric vectors of grid pounts, and \code{z} is a numeric matrix or any other rectangular object which can be transformed by the function \code{as.matrix} into a matrix object. For \code{akimaInterpp} we consider either three numeric vectors of equal length or if \code{y} and \code{z} are NULL, a list with entries \code{x}, \code{y}, \code{z}, or named data frame with \code{x} in the first, \code{y} in the second, and \code{z} in the third column. } \item{gridPoints}{ an integer value specifying the number of grid points in \code{x} and \code{y} direction. } \item{xo, yo}{ for \code{akimaInterp} two numeric vectors of data points spanning the grid, and for \code{akimaInterpp} two numeric vectors of data points building pairs for pointwise interpolation. } \item{extrap}{ a logical, if \code{TRUE} then the data points are extrapolated. } } \details{ Two options are available gridded and pointwise interpolation. \code{akimaInterp} is a function wrapper to the \code{interp} function provided by the contributed R package \code{akima}. The Fortran code of the Akima spline interpolation routine was written by H. Akima. Linear surface fitting and krige surface fitting are provided by the functions \code{linearInterp} and \code{krigeInterp}. } \note{ IMPORTANT: The contributed package \pkg{akima} is not in the dependence list of the DESCRIPTION file due to license conditions. The user has to install this package from CRAN on his own responsibility, please check the license conditions. } \value{ \describe{ \item{akimaInterp}{ returns a list with at least three entries, \code{x}, \code{y} and \code{z}. Note, that the returned values, can be directly used by the \code{persp} and \code{contour} 3D plotting methods. } \item{akimaInterpp}{ returns a data.frame with columns \code{"x"}, \code{"y"}, and \code{"z"}. } } } \seealso{ \code{\link{linearInterp}}, \code{\link{krigeInterp}}. } \references{ Akima H., 1978, \emph{A Method of Bivariate Interpolation and Smooth Surface Fitting for Irregularly Distributed Data Points}, ACM Transactions on Mathematical Software 4, 149-164. Akima H., 1996, \emph{Algorithm 761: Scattered-Data Surface Fitting that has the Accuracy of a Cubic Polynomial}, ACM Transactions on Mathematical Software 22, 362-371. } \examples{\donttest{ ## The akima library is not auto-installed because of a different licence. ## Does not run for r-solaris-x86 ## akimaInterp -- Akima Interpolation: if (requireNamespace("akima")) { set.seed(1953) x <- runif(999) - 0.5 y <- runif(999) - 0.5 z <- cos(2*pi*(x^2+y^2)) ans <- akimaInterp(x, y, z, gridPoints = 41, extrap = FALSE) persp(ans, theta = -40, phi = 30, col = "steelblue", xlab = "x", ylab = "y", zlab = "z") contour(ans) } ## Use spatial as alternative on r-solaris-x86 ## spatialInterp - Generate Kriged Grid Data: if (requireNamespace("spatial")) { RNGkind(kind = "Marsaglia-Multicarry", normal.kind = "Inversion") set.seed(4711, kind = "Marsaglia-Multicarry") x <- runif(999)-0.5 y <- runif(999)-0.5 z <- cos(2*pi*(x^2+y^2)) ans <- krigeInterp(x, y, z, extrap = FALSE) persp(ans) title(main = "Kriging") contour(ans) title(main = "Kriging") } } } \keyword{programming} fBasics/man/dist-snig.Rd0000644000176200001440000000414213202116740014564 0ustar liggesusers\name{snig} \alias{snig} \alias{dsnig} \alias{psnig} \alias{qsnig} \alias{rsnig} \title{Standardized Normal Inverse Gaussian Distribution} \description{ Density, distribution function, quantile function and random generation for the standardized normal inverse Gaussian distribution. } \usage{ dsnig(x, zeta = 1, rho = 0, log = FALSE) psnig(q, zeta = 1, rho = 0) qsnig(p, zeta = 1, rho = 0) rsnig(n, zeta = 1, rho = 0) } \arguments{ \item{zeta, rho}{ shape parameter \code{zeta} is positive, skewness parameter \code{rho} is in the range (-1, 1). } \item{log}{ a logical flag by default \code{FALSE}. If TRUE, log values are returned. } \item{n}{ number of observations. } \item{p}{ a numeric vector of probabilities. } \item{x, q}{ a numeric vector of quantiles. } } \value{ All values for the \code{*snig} functions are numeric vectors: \code{d*} returns the density, \code{p*} returns the distribution function, \code{q*} returns the quantile function, and \code{r*} generates random deviates. All values have attributes named \code{"param"} listing the values of the distributional parameters. } \details{ The random deviates are calculated with the method described by Raible (2000). } \author{ Diethelm Wuertz. } \examples{ ## snig - set.seed(1953) r = rsnig(5000, zeta = 1, rho = 0.5) plot(r, type = "l", col = "steelblue", main = "snig: zeta=1 rho=0.5") ## snig - # Plot empirical density and compare with true density: hist(r, n = 50, probability = TRUE, border = "white", col = "steelblue") x = seq(-5, 5, length = 501) lines(x, dsnig(x, zeta = 1, rho = 0.5)) ## snig - # Plot df and compare with true df: plot(sort(r), (1:5000/5000), main = "Probability", col = "steelblue") lines(x, psnig(x, zeta = 1, rho = 0.5)) ## snig - # Compute Quantiles: qsnig(psnig(seq(-5, 5, 1), zeta = 1, rho = 0.5), zeta = 1, rho = 0.5) } \keyword{distribution} fBasics/man/dist-nigSlider.Rd0000644000176200001440000000100613202116741015541 0ustar liggesusers\name{nigSlider} \alias{nigSlider} \title{nigerbolic Distribution Slider} \description{ Displays interactively the dependence of the nigerbolic distribution on its parameters. } \usage{ nigSlider() } \value{ a tcl/tk based graphical user interface. This is a nice display for educational purposes to investigate the densities and probabilities of the invetrse Gaussian distribution. } \examples{ ## nigSlider - # nigSlider() } \keyword{distribution} fBasics/man/dist-nigShapeTriangle.Rd0000644000176200001440000000337113202116741017054 0ustar liggesusers\name{nigShapeTriangle} \alias{nigShapeTriangle} \title{NIG Shape Triangle} \description{ Plots the normal inverse Gaussian Shape Triangle. } \usage{ nigShapeTriangle(object, add = FALSE, labels = TRUE, \dots) } \arguments{ \item{object}{ an object of class \code{"fDISTFIT"} as returned by the function \code{nigFit}. } \item{add}{ a logical value. Should another point added to the NIG shape triangle? By default FALSE, a new plot will be created. } \item{labels}{ a logical flag by default \code{TRUE}. Should the logarithm of the density be returned? } \item{\dots}{ arguments to be passed to the function \code{integrate}. } } \value{ displays the parameters of fitted distributions in the NIG shape triangle. } \author{ David Scott for code implemented from \R's contributed package \code{HyperbolicDist}. } \references{ Atkinson, A.C. (1982); \emph{The simulation of generalized inverse Gaussian and hyperbolic random variables}, SIAM J. Sci. Stat. Comput. 3, 502--515. Barndorff-Nielsen O. (1977); \emph{Exponentially decreasing distributions for the logarithm of particle size}, Proc. Roy. Soc. Lond., A353, 401--419. Barndorff-Nielsen O., Blaesild, P. (1983); \emph{Hyperbolic distributions. In Encyclopedia of Statistical Sciences}, Eds., Johnson N.L., Kotz S. and Read C.B., Vol. 3, pp. 700--707. New York: Wiley. Raible S. (2000); \emph{Levy Processes in Finance: Theory, Numerics and Empirical Facts}, PhD Thesis, University of Freiburg, Germany, 161 pages. } \examples{ ## nigShapeTriangle - # } \keyword{distribution} fBasics/man/plot-acfPlot.Rd0000644000176200001440000001101013202116740015217 0ustar liggesusers\name{acfPlot} \alias{acfPlot} \alias{pacfPlot} \alias{teffectPlot} \alias{lacfPlot} \title{Autocorrelation Function Plots} \description{ Returns plots of autocorrelations including the autocorrelation function ACF, the partial ACF, the lagged ACF, and the Taylor effect plot. \cr The functions to display stylized facts are: \tabular{ll}{ \code{acfPlot} \tab autocorrelation function plot, \cr \code{pacfPlot} \tab partial autocorrelation function plot, \cr \code{lacfPlot} \tab lagged autocorrelation function plot, \cr \code{teffectPlot} \tab Taylor effect plot.} } \usage{ acfPlot(x, labels = TRUE, \dots) pacfPlot(x, labels = TRUE, \dots) lacfPlot(x, n = 12, lag.max = 20, type = c("returns", "values"), labels = TRUE, \dots) teffectPlot(x, deltas = seq(from = 0.2, to = 3, by = 0.2), lag.max = 10, ymax = NA, standardize = TRUE, labels = TRUE, \dots) } \arguments{ \item{deltas}{ the exponents, a numeric vector, by default ranging from 0.2 to 3.0 in steps of 0.2. } \item{labels}{ a logical value. Whether or not x- and y-axes should be automatically labeled and a default main title should be added to the plot. By default \code{TRUE}. } \item{lag.max}{ maximum lag for which the autocorrelation should be calculated, an integer. } \item{n}{ an integer value, the number of lags. } \item{standardize}{ a logical value. Should the vector \code{x} be standardized? } \item{type}{ [lacf] - \cr a character string which specifies the type of the input series, either "returns" or series "values". In the case of a return series as input, the required value series is computed by cumulating the financial returns: \code{exp(colCumsums(x))} } \item{x}{ an uni- or multivariate return series of class \code{timeSeries} or any other object which can be transformed by the function \code{as.timeSeries()} into an object of class \code{timeSeries}. } \item{ymax}{ maximum y-axis value on plot, \code{is.na(ymax)} TRUE, then the value is selected automatically. } \item{\dots}{ arguments to be passed. } } \value{ \code{acfPlot}, \code{pacfplot}, \cr return an object of class \code{"acf"}, see \code{\link{acf}}. \cr \code{lacfPlot} returns a list with the following two elements: \code{Rho}, the autocorrelation function, \code{lagged}, the lagged correlations. \cr \code{teffectPlot} \cr returns a numeric matrix of order \code{deltas} by \code{max.lag} with the values of the autocorrelations. } \details{ \bold{Autocorrelation Functions:} \cr\cr The functions \code{acfPlot} and \code{pacfPlot}, plot and estimate autocorrelation and partial autocorrelation function. The functions allow to get a first view on correlations within the time series. The functions are synonyme function calls for R's \code{acf} and \code{pacf} from the the \code{ts} package. \cr \bold{Taylor Effect:} \cr\cr The "Taylor Effect" describes the fact that absolute returns of speculative assets have significant serial correlation over long lags. Even more, autocorrelations of absolute returns are typically greater than those of squared returns. From these observations the Taylor effect states, that that the autocorrelations of absolute returns to the the power of \code{delta}, \code{abs(x-mean(x))^delta} reach their maximum at \code{delta=1}. The function \code{teffect} explores this behaviour. A plot is created which shows for each lag (from 1 to \code{max.lag}) the autocorrelations as a function of the exponent \code{delta}. In the case that the above formulated hypothesis is supported, all the curves should peak at the same value around \code{delta=1}. } \references{ Taylor S.J. (1986); \emph{Modeling Financial Time Series}, John Wiley and Sons, Chichester. Ding Z., Granger C.W.J., Engle R.F. (1993); \emph{A long memory property of stock market returns and a new model}, Journal of Empirical Finance 1, 83. } \examples{ ## data - SPI <- LPP2005REC[, "SPI"] plot(SPI, type = "l", col = "steelblue", main = "SP500") abline(h = 0, col = "grey") ## teffectPlot - # Taylor Effect: teffectPlot(SPI) } \keyword{hplot}