[Returnanalytics-commits] r3560 - in pkg/PerformanceAnalytics/sandbox: . qwafafew2014 qwafafew2014/R qwafafew2014/data

noreply at r-forge.r-project.org noreply at r-forge.r-project.org
Sun Nov 23 15:28:24 CET 2014


Author: peter_carl
Date: 2014-11-23 15:28:24 +0100 (Sun, 23 Nov 2014)
New Revision: 3560

Added:
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/Baily_LopezdePrado_stop-out.R
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/mbb.R
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/table.RiskStats.R
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/data/
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/data/Futures Trend 201409a.csv
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/qwafafew2014.R
   pkg/PerformanceAnalytics/sandbox/qwafafew2014/qwafafew2014.Rpres
Log:
- presentation and code for Chicago chapter QWAFAFEW presentation



Added: pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/Baily_LopezdePrado_stop-out.R
===================================================================
--- pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/Baily_LopezdePrado_stop-out.R	                        (rev 0)
+++ pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/Baily_LopezdePrado_stop-out.R	2014-11-23 14:28:24 UTC (rev 3560)
@@ -0,0 +1,108 @@
+# --------------------------------------------------------------------
+# Max Quartile Loss at Confidence level MLdP
+# --------------------------------------------------------------------
+
+MaxQL<-function(R, confidence=0.95, type=c("ac","normal"), ...) {
+  # @TODO Handle multi-column output
+  if(!is.vector(R))
+    x = checkData(R[,1])
+  else
+    x = checkData(R)
+  x = na.omit(x)
+  if(type[1]=="ac"){  
+    mu = mean(x, na.rm = TRUE)
+    sigma_infinity = StdDev(x)
+    phi = cov(x[-1],x[-length(x)])/(cov(x[-length(x)]))
+    phi=.5
+    sigma = sigma_infinity*((1-phi^2)^0.5)
+    dPi0 = 0
+    minQ = minQ(phi, mu, sigma, dPi0, confidence)
+  }
+  if(type[1]=="normal"){
+    minQ = minQ_norm(x, confidence)
+  }
+  MaxQL=min(0,minQ[[1]])
+#   rownames(MaxQL) = paste0("MaxQL (", confidence*100, "%)") #,"t*")
+  return(MaxQL)  
+}
+
+# --------------------------------------------------------------------
+# Max Quartile Loss at Confidence level - First-order AC 
+# --------------------------------------------------------------------
+getQ <- function(bets, phi, mu, sigma, dPi0, confidence) {
+  # Compute analytical solution to quantile
+  #1) Mean (eq 15)
+  mean=(phi^(bets+1)-phi)/(1-phi)*(dPi0-mu)+mu*bets  # wrong?
+  #2) Variance (eq 15)
+  var=sigma^2/(phi-1)^2
+  var=var*((phi^(2*(bets+1))-1)/(phi^2-1)-2*(phi^(bets+1)-1)/(phi-1)+bets+1)
+  #3) Quantile
+  q=mean+qnorm(1-confidence)*(var^0.5)
+  #print(sprintf("bets %g, mean %g, var %g, var1 %g, var2 %g, var3 %g, q %g", bets, mean, var, var1, var2, var3, q))
+  q
+}
+
+goldenSection<-function(a, b, FUN, minimum = TRUE, ...) {
+  FUN = match.fun(FUN)
+  tol = 10^-9
+  sign = 1
+  
+  if(minimum) sign = -1
+  N = round(ceiling(-2.078087*log(tol/abs(b-a))))
+  r = 0.618033989
+  c = 1.0 - r
+  x1 = r*a + c*b
+  x2 = c*a + r*b
+  f1 = sign * FUN(x1,...=...)
+  f2 = sign * FUN(x2,...=...)
+  #print(f1); print(f2)
+  for(i in 1:N){
+    if(f1>f2){
+      a = x1
+      x1 = x2
+      f1 = f2
+      x2 = c*a+r*b
+      f2 = sign*FUN(x2,...=...)
+    } else {
+      b = x2
+      x2 = x1
+      f2 = f1
+      x1 = r*a + c*b
+      f1 = sign*FUN(x1,...=...)
+    }
+  }
+  if(f1 < f2){
+    return(list(minQ=sign*f1, t=x1))
+  } else {
+    return(list(minQ=sign*f2, t=x2))
+  }
+}
+
+minQ <- function(phi, mu, sigma, dPi0, confidence) {
+  q = 0
+  bets = 0
+  while (q <= 0) {
+    bets = bets + 1
+    q = getQ(bets, phi, mu, sigma, dPi0, confidence)
+  }
+  #print(sprintf("bets %g, q %g", bets, q))
+  goldenSection(0,bets,getQ,FALSE,phi=phi,mu=mu,sigma=sigma,dPi0=dPi0,confidence=confidence)
+}
+
+# minQ(0.5, 1, 2, 1, 0.95)
+# MinQ = -9.15585580378
+# Time at MinQ = 12.4832517718
+
+# --------------------------------------------------------------------
+# Max Quartile Loss at Confidence level - Assuming IID (eq. 5)
+# --------------------------------------------------------------------
+
+minQ_norm<-function(x, confidence){
+# Calculate the maximum drawdown for a normal distribution, assuming iid returns
+  x = na.omit(x)
+  sd = StdDev(x)
+  mu = mean(x, na.rm = TRUE)
+  minQ = -((qnorm(1-confidence)*sd)^2)/(4*mu)
+  t = ((qnorm(1-confidence)*sd)/(2*mu))^2
+  return(list(minQ=minQ,t=t))
+}

Added: pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/mbb.R
===================================================================
--- pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/mbb.R	                        (rev 0)
+++ pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/mbb.R	2014-11-23 14:28:24 UTC (rev 3560)
@@ -0,0 +1,27 @@
+mbb <- function(R, N=length(R), k=6, nrep=1000, verbose=TRUE, cores=6){
+#' Moving blocks bootstrap 
+#' 
+#' Follows Efron and Tibshirani (sec. 8.6).
+#' With a nod to http://stat.wharton.upenn.edu/~buja/STAT-541/time-series-bootstrap.R
+
+#' N length of the resulting time series
+#' k size of the moving blocks
+#' nrep number of bootstrap replications
+  require(foreach)
+  require(doMC)
+  registerDoMC(cores)
+  .mdd <- function(R, N, k){
+    result.mbb <- rep(NA, N) # local vector for a bootstrap replication
+    for(j in 1:ceiling(N/k)) {  # fill the vector with random blocks
+      endpoint <- sample(k:N, size=1) # by randomly sampling endpoints
+      result.mbb[(j-1)*k+1:k] <- R[endpoint-(k:1)+1] # and copying blocks to the local vector
+    }
+    result <- as.matrix(result.mbb[1:N])# trim overflow when k doesn't divide N
+    return(result)
+  }
+  
+  result <- foreach(i=1:nrep, .combine=cbind, .inorder=TRUE) %dopar% {
+    .mdd(R=R, N=N, k=k)
+  }
+  return(result)
+}
\ No newline at end of file

Added: pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/table.RiskStats.R
===================================================================
--- pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/table.RiskStats.R	                        (rev 0)
+++ pkg/PerformanceAnalytics/sandbox/qwafafew2014/R/table.RiskStats.R	2014-11-23 14:28:24 UTC (rev 3560)
@@ -0,0 +1,229 @@
+# Additional and re-organized tables for WB presentations
+
+table.RiskStats <-
+function (R, ci = 0.95, scale = NA, Rf = 0, MAR = .1/12, p= 0.95, digits = 4)
+{# @author Peter Carl
+    # Risk Statistics: Statistics and Stylized Facts
+
+    y = checkData(R, method = "zoo")
+    if(!is.null(dim(Rf)))
+        Rf = checkData(Rf, method = "zoo")
+    # Set up dimensions and labels
+    columns = ncol(y)
+    rows = nrow(y)
+    columnnames = colnames(y)
+    rownames = rownames(y)
+
+    if(is.na(scale)) {
+        freq = periodicity(y)
+        switch(freq$scale,
+            minute = {stop("Data periodicity too high")},
+            hourly = {stop("Data periodicity too high")},
+            daily = {scale = 252},
+            weekly = {scale = 52},
+            monthly = {scale = 12},
+            quarterly = {scale = 4},
+            yearly = {scale = 1}
+        )
+    }
+
+    # for each column, do the following:
+    for(column in 1:columns) {
+        x = na.omit(y[,column,drop=FALSE])
+        # for each column, make sure that R and Rf are for the same dates
+        if(!is.null(dim(Rf))){ # if Rf is a column
+            z = merge(x,Rf)
+            zz = na.omit(z)
+            x = zz[,1,drop=FALSE]
+            Rf.subset = zz[,2,drop=FALSE]
+        }
+        else { # unless Rf is a single number
+            Rf.subset = Rf
+        }
+
+        z = c(
+                Return.annualized(x, scale = scale), 
+                StdDev.annualized(x, scale = scale),
+                SharpeRatio.annualized(x, scale = scale, Rf = Rf),
+                DownsideDeviation(x,MAR=0)*sqrt(scale),# Add annualization to this function
+                SortinoRatio(x)*sqrt(scale), # New function adds annualization
+                PerformanceAnalytics:::AverageDrawdown(x),
+                maxDrawdown(x),
+                SterlingRatio(x),
+                VaR(x, p=p,method="historical"),
+                ES(x, p=p,method="historical"),
+                skewness(x), 
+                kurtosis(x),
+                VaR(x, p=p),
+                ES(x, p=p),
+                SharpeRatio(x, p=p, Rf=Rf, FUN="ES", annualize=TRUE),
+                length(x)
+                )
+        znames = c(
+                "Annualized Return", 
+                "Annualized Std Dev", 
+                "Annualized Sharpe Ratio",
+                "Annualized Downside Deviation",
+                "Annualized Sortino Ratio",
+                "Average Drawdown",
+                "Maximum Drawdown",
+                "Sterling Ratio (10%)",
+                paste("Historical VaR (",base::round(p*100,1),"%)",sep=""),
+                paste("Historical ETL (",base::round(p*100,1),"%)",sep=""),
+                "Skewness",
+                "Excess Kurtosis",
+                paste("Modified VaR (",base::round(p*100,1),"%)",sep=""),
+                paste("Modified ETL (",base::round(p*100,1),"%)",sep=""),
+                paste("Annualized Modified Sharpe Ratio (ETL ", base::round(p*100,1),"%)",sep=""),
+                "# Obs"
+                )
+        if(column == 1) {
+            resultingtable = data.frame(Value = z, row.names = znames)
+        }
+        else {
+            nextcolumn = data.frame(Value = z, row.names = znames)
+            resultingtable = cbind(resultingtable, nextcolumn)
+        }
+    }
+    colnames(resultingtable) = columnnames
+    ans = base::round(resultingtable, digits)
+    ans
+}
+
+table.PerfStats <-
+function (R, scale = NA, Rf = 0, digits = 4)
+{# @author Peter Carl
+    # Performance Statistics: Statistics and Stylized Facts
+
+    y = checkData(R)
+    if(!is.null(dim(Rf)))
+        Rf = checkData(Rf)
+    # Set up dimensions and labels
+    columns = ncol(y)
+    rows = nrow(y)
+    columnnames = colnames(y)
+    rownames = rownames(y)
+
+    if(is.na(scale)) {
+        freq = periodicity(y)
+        switch(freq$scale,
+            minute = {stop("Data periodicity too high")},
+            hourly = {stop("Data periodicity too high")},
+            daily = {scale = 252},
+            weekly = {scale = 52},
+            monthly = {scale = 12},
+            quarterly = {scale = 4},
+            yearly = {scale = 1}
+        )
+    }
+
+    # for each column, do the following:
+    for(column in 1:columns) {
+        x = na.omit(y[,column,drop=FALSE])
+        # for each column, make sure that R and Rf are for the same dates
+        if(!is.null(dim(Rf))){ # if Rf is a column
+            z = merge(x,Rf)
+            zz = na.omit(z)
+            x = zz[,1,drop=FALSE]
+            Rf.subset = zz[,2,drop=FALSE]
+        }
+        else { # unless Rf is a single number
+            Rf.subset = Rf
+        }
+
+        z = c(
+                Return.cumulative(x),
+                Return.annualized(x, scale = scale), 
+                StdDev.annualized(x, scale = scale),
+                length(subset(x, x>0)),
+                length(subset(x, x<=0)),
+                length(subset(x, x>0))/length(x),
+                mean(subset(x, x>0)),
+                mean(subset(x, x<=0)),
+                mean(x),
+                AverageDrawdown(x),
+                AverageRecovery(x)
+                )
+        znames = c(
+                "Cumulative Return",
+                "Annualized Return", 
+                "Annualized Std Dev", 
+                "# Positive Months",
+                "# Negative Months",
+                "% Positive Months",
+                "Average Positive Month",
+                "Average Negative Month",
+                "Average Month",
+                "Average Drawdown",
+                "Average Months to Recovery"
+                )
+        if(column == 1) {
+            resultingtable = data.frame(Value = z, row.names = znames)
+        }
+        else {
+            nextcolumn = data.frame(Value = z, row.names = znames)
+            resultingtable = cbind(resultingtable, nextcolumn)
+        }
+    }
+    colnames(resultingtable) = columnnames
+    ans = base::round(resultingtable, digits)
+    ans
+}
+
+table.RiskContribution <- function(R, p, ..., weights=NULL, scale=NA, geometric = TRUE) {
+
+    R = na.omit(R)
+    if(is.null(weights)) {
+        message("no weights passed in, assuming equal weighted portfolio")
+        weights = rep(1/dim(R)[[2]], dim(R)[[2]])
+    }
+    if (is.na(scale)) {
+      freq = periodicity(R)
+      switch(freq$scale, minute = {
+          stop("Data periodicity too high")
+      }, hourly = {
+          stop("Data periodicity too high")
+      }, daily = {
+          scale = 252
+      }, weekly = {
+          scale = 52
+      }, monthly = {
+          scale = 12
+      }, quarterly = {
+          scale = 4
+      }, yearly = {
+          scale = 1
+      })
+    }
+    
+    # Returns
+    # ret.col = colMeans(R)*weights
+    ret.col = Return.annualized(R, geometric=geometric)*weights
+    percret.col = ret.col/sum(ret.col)
+    result = cbind(t(ret.col), t(percret.col))
+    # Standard Deviation
+    sd.cols = StdDev(R, weights=weights, invert=TRUE, portfolio_method="component", p=(1-1/12))
+    result = cbind(sd.cols$contribution*sqrt(scale), sd.cols$pct_contrib_StdDev, result)
+    # VaR?
+    var.cols = VaR(R, weights=weights, method="gaussian", portfolio_method="component", p=(1-1/12))
+    result = cbind(var.cols$contribution, var.cols$pct_contrib_VaR, result)
+    
+    mvar.cols = VaR(R, weights=weights, method="gaussian", portfolio_method="component", p=(1-1/12))
+    result = cbind(mvar.cols$contribution, mvar.cols$pct_contrib_VaR, result)
+    
+    # ES
+    es.cols = ES(R, weights=weights, method="gaussian", portfolio_method="component", p=(1-1/12))
+    result = cbind(es.cols$contribution, es.cols$pct_contrib_ES, result)
+
+    mes.cols = ES(R, weights=weights, method="modified", portfolio_method="component", p=(1-1/12))
+    result = cbind(weights, mes.cols$contribution, mes.cols$pct_contrib_MES, result)
+    total = colSums(result)
+    
+    result = rbind(result, colSums(result))
+    rownames(result) = c(colnames(R),"Total")
+#     colnames(result) = c("Weights", "Contribution to mETL", "Percentage Contribution to mETL", "Contribution to gETL", "Percentage Contribution to gETL", "Contribution to Annualized StdDev", "Percentage Contribution to StdDev", "Contribution to Annualized E(R)", "Percentage Contribution to E(R)")
+
+    colnames(result) = c("Weights", "Contribution to mETL", "%Contribution to mETL", "Contribution to gETL", "%Contribution to gETL", "Contribution to mVaR", "%Contribution to mVaR", "Contribution to gVaR", "%Contribution to gVaR", "Contribution to Annualized StdDev", "%Contribution to StdDev", "Contribution to Annualized E(R)", "%Contribution to E(R)")
+    return(result)
+
+}

Added: pkg/PerformanceAnalytics/sandbox/qwafafew2014/data/Futures Trend 201409a.csv
===================================================================
--- pkg/PerformanceAnalytics/sandbox/qwafafew2014/data/Futures Trend 201409a.csv	                        (rev 0)
+++ pkg/PerformanceAnalytics/sandbox/qwafafew2014/data/Futures Trend 201409a.csv	2014-11-23 14:28:24 UTC (rev 3560)
@@ -0,0 +1,298 @@
+,Trend1,Trend2,Trend3,Trend4,Trend5,Trend6,Trend7,Trend8,Trend9,Trend10,Trend11,Trend12,Trend13,Trend14,Trend15,Trend16,Trend17,Trend18,Trend19,Trend20,Trend21,Trend22,EDHEC CTA,NewEdge CTA,NewEdge Trend Index,Barclay BTOP50
+1990-01-31,,,0.0373,,0.0563,,,,,,,,,,,,,,0.0365,,,,,,,0.0008
+1990-02-28,,,0.0389,,0.0245,,,,,,,,,,,,,,0.0181,,,,,,,0.0044
+1990-03-31,,,0.0308,,0.0568,,,,,,,,,,,,,,0.0945,,,,,,,0.0123
+1990-04-30,,,0.0242,,0.0834,,,,,,,,,,,,,,0.129,,,,,,,0.0299
+1990-05-31,,,-0.0519,,-0.1209,,,,,,,,,,,,,,-0.079,,,,,,,-0.0315
+1990-06-30,,,0.0347,,0.0455,,,,,,,,,,,,,,0.0249,,,,,,,0.0022
+1990-07-31,,,0.148,,0.0432,,,,,,,,,,,,,,0.2008,,,,,,,0.0363
+1990-08-31,,,0.0333,,0.0898,,-0.0216,,,,,,,,,,,,0.1854,,,,,,,0.0493
+1990-09-30,,,0.026,,0.0072,,-0.0262,,,,,,,,,,,,0.0857,,,,,,,0.0229
+1990-10-31,,,0.0703,,0.0213,,-0.1475,,,,,,,,,,,,-0.0036,,,,,,,0.0208
+1990-11-30,,,0.0291,,0.0007,,0.0901,,,,,,,,,,,,0.0031,,,,,,,0.0074
+1990-12-31,,,0.0053,,-0.0082,,-0.0112,,,,,,,,,,,,-0.0009,,,,,,,-0.0094
+1991-01-31,,,-0.056,,-0.0759,,0.0115,,,,,,,,,,,,-0.1594,,,,,,,-0.0493
+1991-02-28,,,0.0171,,-0.0258,,0.0801,,,,,,,,,,,,0.013,,,,,,,0.0024
+1991-03-31,,,0.0307,,0.1604,,0.237,,,,,,,,,,,,0.0243,,,,,,,0.0561
+1991-04-30,,,0.0018,,-0.0166,,-0.0329,,,,,,,,,,,,-0.137,,,,,,,0.0058
+1991-05-31,,,-0.0078,,0.0266,,-0.1306,,,,,,,,,,,,0.0294,,,,,,,-0.0238
+1991-06-30,,,0.0197,,0.0543,,0.1241,,,,,,,,,,,,0.0211,,,,,,,0.0287
+1991-07-31,,,-0.038,,-0.0854,,0.0899,,,,,,,,,,,,-0.0152,,,,,,,-0.0185
+1991-08-31,,,-0.0596,,-0.0292,,-0.0051,,,,,,,,,,,,-0.0633,,,,,,,-0.005
+1991-09-30,,,0.0109,,0.0211,,0.0323,,,,,,,,,,,,0.1161,,,,,,,0.0444
+1991-10-31,,,-0.0008,,0.0031,,-0.0096,,,,,0.021,,,,,,,0.1661,,,,,,,-0.0146
+1991-11-30,,,0.0033,,-0.0209,,0.025,,,,,0.013,,,,,,,-0.0209,,,,,,,0.0146
+1991-12-31,,,0.1766,,0.1601,,0.1696,,,,,0.0963,,,,,,,0.3375,,,,,,,0.1063
+1992-01-31,,,-0.0815,,-0.0555,,-0.0677,,,,,-0.0496,,,,,,,-0.126,,,,,,,-0.0663
+1992-02-29,,,-0.0103,,-0.0504,,-0.0538,,,,,-0.0191,,,,,,,-0.06,,,,,,,-0.0232
+1992-03-31,,,-0.0044,,-0.0261,,0.0551,,,,,0.0141,,,,,,,-0.0547,,,,,,,-0.003
+1992-04-30,,,-0.0045,,-0.0222,,-0.0529,,,,,0.013,,,,,,,0.0031,,,,,,,-0.0316
+1992-05-31,,,0.0107,,-0.0226,,-0.0024,,,,,0.0212,,,,,,,-0.0571,,,,,,,0.0027
+1992-06-30,,,0.1392,,0.1064,,0.1174,,,,,0.0644,,,,,,,0.0658,,,,,,,0.0584
+1992-07-31,,,0.0816,,0.1114,,0.1656,,,,,0.0648,,,,,,,0.1652,,,,,,,0.074
+1992-08-31,,,0.0694,,0.0453,,0.0813,,,,,0.0392,,,,,,,0.0192,,,,,,,0.0515
+1992-09-30,,,0.0005,,-0.0043,,-0.1027,,,,,0.0077,,,,,,,-0.0034,,,,,,,-0.0208
+1992-10-31,,,-0.0323,,-0.0321,,0.0188,,,,,-0.0739,,,,,,,-0.0331,,,,,,,-0.0047
+1992-11-30,,,0.0265,,0.0424,,0.0233,,,,,0.0491,,,,,,,0.0465,,,,,,,0.0129
+1992-12-31,,,-0.0043,,-0.0011,,-0.025,,,,,-0.0309,,,,,,,-0.0454,,,,,,,-0.0157
+1993-01-31,,,-0.0255,,0.0031,,0.0423,,,,,-0.0429,,,,,,,-0.0421,,,,,,,-0.0091
+1993-02-28,,,0.0549,,0.1243,,0.0934,,,,,0.0394,,,,,,,0.061,,,,,,,0.0687
+1993-03-31,,,-0.0051,,-0.0309,,-0.0211,,,,,0.0171,,,,,,,0.0457,,,,,,,-0.0048
+1993-04-30,,,0.0516,,-0.0001,,0.0142,,,,,0.0449,,,,,,,0.0924,,,,,,,0.0317
+1993-05-31,,,-0.015,,0.0279,,-0.0102,,,,,0.0324,,,,,,,0.0488,,,,,,,0.0125
+1993-06-30,,,-0.0193,,0.0381,,0.0303,,,,,-0.01,,,,,,,-0.0122,,,,,,,0.0112
+1993-07-31,,,0.0478,,0.046,,0.0309,,,,,0.0436,,,,,,,0.066,,,,,,,0.0314
+1993-08-31,,,-0.0704,,-0.0612,,0.0081,,,,,-0.0328,,,,,,,-0.0528,,,,,,,-0.0015
+1993-09-30,,,0.0113,,-0.0707,,0.0361,,,,,0.0026,,,,,,,0.0116,-0.0816,,,,,,-0.0089
+1993-10-31,,,-0.0025,,-0.0545,,0.0206,,,,,-0.0486,,,,,,,-0.0659,0.0271,,,,,,-0.0092
+1993-11-30,,,0.0145,,-0.0231,,-0.0003,,,,,0.0738,,,,,,,0.0371,0.0562,,,,,,-0.0091
+1993-12-31,,,0.0824,,0.0417,,0.0284,,,,,0.0794,,,,,,,0.1283,0.032,,,,,,0.0166
+1994-01-31,,,-0.0773,,-0.0377,,0.0134,,,,,-0.0204,,,,,,,-0.0145,-0.0245,,,,,,-0.031
+1994-02-28,,,-0.0162,,-0.0845,,0.03,,,,,-0.0406,,,,,,,-0.0416,0.132,,,,,,-0.0215
+1994-03-31,,,0.0795,,0.0635,,0.0609,,,,,0.0452,,,,,,,0.0287,0.0676,,,,,,0.0209
+1994-04-30,,,-0.0205,,-0.0374,,-0.0343,,,,,-0.0203,,,,,,,-0.0839,0.0502,,,,,,-0.0083
+1994-05-31,,,0.0489,,0.0349,,-0.0291,,,,,0.0925,,,,,,,0.1501,0.0868,,,,,,0.0212
+1994-06-30,,,0.051,,0.149,,0.0028,,,,,0.0321,,,,,,,0.0147,-0.0705,,,,,,0.0348
+1994-07-31,,,-0.0254,,0.0253,,-0.117,,,,,-0.013,,,,,,,0.0098,-0.0674,,,,,,-0.0199
+1994-08-31,,,-0.0491,,-0.0335,,-0.0512,,,,,-0.0174,,,,,,,-0.0738,0.1755,,,,,,-0.0299
+1994-09-30,,,0.0355,,0.0348,,-0.0142,,,,,0.0115,,,,,,,0.0505,-0.0401,,,,,,0.0103
+1994-10-31,,,0.028,,0.005,,0.009,,,,,-0.0302,,,,,,,0.0543,0.019,,,,,,0.0087
+1994-11-30,,,0.0462,,0.0284,,0.045,,,,,0.0923,,,,,,,0.1424,0.0352,,,,,,0.0137
+1994-12-31,,,0.023,,-0.0356,,-0.0224,,,,,-0.0238,,,,,,,0.0106,0.0034,,,,,,-0.0065
+1995-01-31,,-0.0616,-0.0291,,-0.0287,,-0.0228,,,,,-0.0156,,,,,,,-0.0791,0.0393,,,,,,-0.0268
+1995-02-28,,0.0957,0.0645,,0.0485,,0.0119,,,,,-0.0149,,,,,,,0.0124,0.009,,,,,,0.0293
+1995-03-31,,0.1015,0.1461,,0.0402,,0.0452,,,,,0.0257,,,,,,,0.0663,0.0245,,,,,,0.0715
+1995-04-30,,0.0216,0.0424,,0.014,,0.0084,,,,,0.0563,,,,,,,0.0473,-0.0054,,,,,,0.0129
+1995-05-31,,0.0649,-0.0084,,-0.013,,0.0809,,,,,0.0182,,,,,,,0.0822,0.0692,,,,,,0.0148
+1995-06-30,,0.0363,0.0102,,0.0008,,-0.0234,,,,,-0.0149,,,,,,,0.0011,-0.0966,,,,,,-0.0158
+1995-07-31,,-0.037,-0.0202,,-0.0549,,0.0104,,,,,-0.0568,,,,,,,-0.0875,0.0206,,,,,,-0.0178
+1995-08-31,,-0.0058,0.015,,0.0257,,0.068,,,,,-0.0489,,,,,,,-0.0534,-0.0578,,,,,,0.02
+1995-09-30,,0.0175,-0.0145,,-0.0275,,-0.0057,,,,,-0.0003,,,,,,,-0.0184,0.0849,,,,,,-0.0128
+1995-10-31,,-0.0381,-0.0016,,-0.0075,,0.0034,,,,,-0.0085,,,,,,,-0.0667,-0.0032,,,,,,0.0046
+1995-11-30,,0.0207,0.003,,0.0077,,0.0216,,,,,0.0239,,,,,,,-0.0019,0.0049,,,,,,0.0181
+1995-12-31,,0.057,0.0738,,0.0647,,-0.0064,0.1451,,,,0.144,,,,,,,0.1911,0.005,,,,,,0.0369
+1996-01-31,,0.0538,0.0717,,0.0377,,0.0545,0.0168,,,,-0.0426,,,,,,,-0.0685,0.0898,,,,,,0.0261
+1996-02-29,,-0.0665,-0.1056,,-0.0722,,-0.0007,-0.085,,,,-0.0673,,,,,,,-0.1378,0.0005,,,,,,-0.0495
+1996-03-31,,-0.0048,0.0106,,0.0341,,-0.003,0.1162,,,,0.0365,,,,,,,0.0966,0.0074,,,,,,0.0007
+1996-04-30,,0.0859,0.0549,,0.0515,,0.0558,0.0618,,,,0.1346,,,,0.044,,,0.1427,0.0269,,,,,,0.0374
+1996-05-31,,-0.044,-0.0547,,-0.0267,,0.0196,-0.0946,,,,-0.0352,,,,-0.024904215,,,-0.0941,-0.0079,,,,,,-0.017
+1996-06-30,,-0.003,0.0414,,0.0091,,0.0011,-0.0014,,,,0.0091,,,,0.004911591,,,0.0152,-0.0443,,,,,,0.0034
+1996-07-31,,0.0388,0.012,,-0.0113,,0.0058,-0.0723,,,,-0.0489,,,,-0.021505376,,,-0.063,0.052,,,,,,0.0002
+1996-08-31,,0.0726,-0.0129,,0.0209,,0.0304,0.0019,,,,-0.0045,,,,0.005994006,,,-0.0334,0.0082,,,,,,-0.0032
+1996-09-30,,0.0751,0.0257,,0.0173,,0.0277,-0.0152,,,,0.0906,,,,0.106256207,,,0.0603,-0.0127,,,,,,0.028
+1996-10-31,,0.1037,0.0978,,0.1336,,0.0351,0.1514,,,,0.0437,,,,0.086175943,,,0.1684,0.0481,,,,,,0.0523
+1996-11-30,,0.0146,0.0389,,0.1038,,0.0703,0.0505,,,,0.031,,,,0.098347107,,,0.0245,0.0477,,,,,,0.0478
+1996-12-31,,-0.0312,0.0123,,-0.0403,,-0.0219,0.0464,,,,-0.0409,,,,0.031602709,,,-0.0641,-0.0071,,,,,,-0.0154
+1997-01-31,,0.0964,0.0779,,0.0368,,0.0207,0.0222,,,,0.0504,,,,0.031363968,,,0.0528,0.0219,,,0.0393,,,0.0315
+1997-02-28,,0.0512,0.055,,0.0177,,-0.0041,0.0457,,,,0.0625,,,,0.064356436,,,0.0915,0.0579,,,0.0298,,,0.0251
+1997-03-31,,-0.0217,-0.0238,,-0.0208,,0.0167,0.0271,,,,0.0076,,,,-0.023255814,,,-0.015,0.0382,,,-0.0021,,,0.0027
+1997-04-30,,-0.0407,-0.0243,,-0.0256,,-0.0493,-0.0544,,,,0.0139,,,,-0.041496599,,,-0.0516,0.039,,,-0.017,,,-0.011
+1997-05-31,,-0.0062,0.0137,,-0.0174,,0.0401,0.0556,,,,-0.0036,,,,0.007806955,,,-0.0132,0.0325,,,-0.0015,,,-0.0131
+1997-06-30,,0.002,0.0065,,0.0319,,0.0034,-0.0332,,,,0.0142,,,,0.045774648,,,0.0038,0.0219,,,0.0085,,,0.0094
+1997-07-31,,0.1927,0.0753,,0.0689,,0.088,0.0275,,,,0.055,,,,0.094276094,,,0.0411,0.0512,,,0.0591,,,0.0497
+1997-08-31,,0.0102,-0.0708,,-0.0511,,-0.0221,-0.0571,,,,-0.0357,,,,-0.08,,,-0.0808,0.0033,,,-0.0473,,,-0.0303
+1997-09-30,,0.0187,0.0112,,0.0387,,0.05,-0.0283,,,,0.0119,,,,0.021404682,,,0.0495,-0.0026,,,0.0198,,,0.0063
+1997-10-31,-0.1297,-0.0858,-0.0168,,0.018,,-0.0077,0.0402,,,,-0.0911,,,,0.020956123,,,-0.0537,0.0035,,,-0.0098,,,-0.0008
+1997-11-30,0.0996,0.0572,-0.0009,,0.0039,,-0.0163,-0.0125,,,,-0.0127,,,,-0.019884541,,,0.021,-0.0383,,,0.0133,,,0.0158
+1997-12-31,0.0814,0.0795,0.0476,,0.0459,,0.0366,0.0756,,,,0.0647,,,,0.107984293,,,0.0746,-0.0118,,,0.0286,,,0.0209
+1998-01-31,0.015,0.0025,0.0289,,0.0281,,0.0166,0.0356,,,,0.0493,,,,-0.025398701,,,-0.009,0.0352,,,0.0104,,,0.0083
+1998-02-28,0.0327,0.0021,-0.0246,,-0.0259,,-0.0312,0.0269,,,-0.079,0.0471,,,,0.058181818,,,0.0409,-0.0355,,,-0.0065,,,-0.0121
+1998-03-31,0.0738,0.0279,0.0118,,0.0412,,-0.0063,-0.0073,,,-0.026,0.0375,,,,0.012027491,,,-0.0445,-0.0449,,,0.0122,,,0.0185
+1998-04-30,-0.0163,-0.0543,-0.07,,-0.0637,,-0.1067,-0.0802,,,-0.114,-0.0429,,,,-0.027730617,,,-0.0445,-0.0154,,,-0.0296,,,-0.0313
+1998-05-31,0.0853,0.0355,0.0419,,0.0333,,0.0281,-0.0135,,,0.042,0.0137,,,,0.049476135,,,0.0261,0.0073,,,0.0193,,,0.023
+1998-06-30,0.0297,0.0136,0.0237,,0.0133,,-0.0219,0.0372,,,-0.076,0.0177,,,,0.039378813,,,-0.0234,0.0095,,,0.0051,,,0.0027
+1998-07-31,0.0151,-0.0475,-0.0459,,-0.0405,,-0.0346,-0.0222,,,-0.02,0.0162,,,,-0.003735326,,,-0.0083,0.0282,,,-0.001,,,0.0016
+1998-08-31,0.1099,0.1957,0.065,,0.0891,,0.1315,0.1543,,,0.278,0.0564,,,,0.198714515,,,0.2324,0.0948,,,0.0691,,,0.0554
+1998-09-30,0.0451,0.0193,0.0526,,0.0186,,0.0602,0.0251,,,0.106,0.0189,,,,0.00357462,,,-0.0333,0.0396,,,0.0454,,,0.046
+1998-10-31,-0.057,0.0086,-0.015,,0.0345,,0.0178,-0.0151,,,-0.095,-0.0214,,,,0.000445236,,,-0.1139,0.0042,,,0.0004,,,0.0181
+1998-11-30,0.0115,-0.0106,-0.0047,,-0.0083,,-0.0233,0.0296,,,0.058,-0.043,,,,0.024032043,,,0.0094,0.0119,,,-0.0089,,,-0.0238
+1998-12-31,0.095,0.027,0.0261,,0.0075,,0.0379,0.0569,,,-0.073,0.0379,,,,0.037809648,,,0.0467,0.008,,,0.0221,,,0.0216
+1999-01-31,-0.0138,-0.0386,-0.0396,,-0.0503,,-0.0257,-0.0769,,,-0.125,-0.0204,,,0.0119,-0.047319933,,,-0.1156,-0.0213,,,-0.0167,,,-0.0201
+1999-02-28,0.0361,0.0122,0.0324,,0.0254,,0.0327,0.0179,,,0.151,0.0442,,,0.0034,0.023296703,,,0.1335,-0.0035,,,0.0197,,,0.0241
+1999-03-31,-0.0398,-0.0277,0.013,,-0.0031,,0.0292,-0.0335,,,0.087,-0.0145,,,-0.0495,-0.021477663,,,-0.0943,-0.0079,,,-0.0065,,,-0.0066
+1999-04-30,0.1051,0.0311,0.0554,,0.0486,,0.0464,0.0592,,,-0.006,0.0328,,,0.0266,0.063652327,,,0.0752,-0.0268,,,0.021,,,0.0252
+1999-05-31,-0.0839,-0.031,-0.0297,,-0.036,,0.0044,-0.0075,,-0.0029,0.085,-0.0247,,,0.0217,-0.037969459,,-0.0266,-0.0609,0.0208,,,-0.015,,,-0.0093
+1999-06-30,0.0529,0.0451,0.0566,,0.0457,,0.0312,0.0354,,-0.0014,0.039,0.0226,,,0.0271,0.026598027,,0.0281,-0.0068,0.0069,,,0.0234,,,0.0305
+1999-07-31,-0.0201,0.0195,-0.0323,,0.005,,0.0235,0.0051,,-0.0222,0.086,0.0294,,,-0.0366,-0.027580443,,-0.0177,-0.0083,0.0232,,,-0.0051,,,-0.0163
+1999-08-31,-0.0347,-0.0251,0.0113,,0.0042,,0.0149,0.0174,,0.0213,-0.168,0.0161,,,0.0564,0.032660077,,-0.0173,0.0312,-0.0345,,,-0.0027,,,0.0099
+1999-09-30,-0.0017,0.0063,0.0086,,0.0145,,0.015,0.0002,,-0.0481,-0.073,0.0355,,,0.0156,0.026217228,,0.0112,0.0099,-0.0091,,,0.0064,,,-0.0001
+1999-10-31,-0.062,-0.0682,-0.1106,,-0.049,,-0.043,-0.055,,-0.048,-0.161,-0.0774,,,-0.059,-0.041768045,,-0.0526,-0.0957,-0.003,,,-0.0354,,,-0.0371
+1999-11-30,0.1393,0.0184,0.0236,,0.0147,,-0.0045,0.0681,,0.0701,0.094,0.037,,,0.003,0.047820567,,0.0426,0.1364,0.0263,,,0.0166,,,0.0155
+1999-12-31,0.0904,0.0429,0.0278,,0.0313,,-0.0037,0.0201,,0.0484,-0.073,0.0756,,,0.0883,0.027463651,,0.0111,0.0841,0.0072,,,0.0142,,,0.0028
+2000-01-31,-0.0396,0.0155,0.0187,,0.0306,,0.0087,-0.0038,,-0.0502,-0.003,-0.0102,,,0.0261,0.011399371,0.016249516,0.0418,0.0802,0.0708,,,0.0128,0.0234,0.0197,0.0071
+2000-02-29,0.0172,-0.0199,-0.0137,,-0.0071,,-0.061,-0.004,,0.0252,-0.098,0.0519,,,-0.0644,-0.001554606,0.019403525,-0.0154,-0.0905,-0.0039,,,-0.0022,-0.0078,-0.024,-0.019
+2000-03-31,-0.0328,-0.0229,-0.0426,,-0.0288,,0.0329,-0.0177,,-0.084,0.012,-0.0001,,,0.0282,-0.027247956,0.000101203,0.0714,-0.0416,-0.0067,,,-0.0138,-0.0188,-0.0303,-0.0251
+2000-04-30,0.0206,0.0014,0.0085,,-0.0118,,-0.0425,-0.0252,,-0.0027,-0.009,0.0073,,,0.0178,-0.039215686,-0.02683367,-0.0285,0.0548,-0.0046,,,-0.0241,-0.0145,-0.034,-0.0255
+2000-05-31,-0.0026,0.0252,-0.016,,0.0162,,0.0453,0.0246,,0.0697,0.141,0.0031,,,-0.0315,0.069970845,0.024075047,0.0803,-0.0258,0.0161,0.0335,,0.0114,0.0013,-0.0115,0.0024
+2000-06-30,-0.0127,-0.0244,-0.0437,,0.0253,,-0.0328,-0.0118,,0.0155,0.082,0.0041,,,-0.0564,-0.053328143,0.007073294,-0.0416,-0.0219,-0.0108,-0.0225,,-0.0124,-0.0185,-0.0298,-0.0174
+2000-07-31,-0.0458,-0.0077,-0.0167,,-0.024,,-0.0656,-0.03,,-0.0125,0.165,-0.0071,,,0.0129,-0.021792763,-0.013435084,-0.0257,-0.0526,-0.0124,0.0088,,-0.0131,-0.0157,-0.0238,-0.0131
+2000-08-31,0.0323,0.0181,0.0353,,0.0291,,-0.0157,0.0264,,0.1268,0.039,0.0185,,,0.0394,0.034468264,0.041223074,0.0317,0.1176,-0.0197,-0.0429,,0.0189,0.0083,0.0318,0.004
+2000-09-30,-0.0776,0.0062,-0.0269,,-0.0332,,-0.0734,-0.0034,,-0.0436,-0.073,-0.045,,,0.0178,-0.006095083,-0.019748163,-0.0283,-0.0453,0.0093,-0.0134,,-0.0208,-0.0324,-0.0678,-0.0284
+2000-10-31,0.0209,0.0254,0.0481,,0.0307,,-0.007,0.0194,,0.0196,0.016,-0.027,,,0.0227,0.046197874,0.009497228,0.0485,0.0951,-0.0031,0.0309,,0.0075,0.0174,0.0323,0.0205
+2000-11-30,0.0733,0.0597,0.0622,,0.0602,,0.1425,0.0581,,0.0905,-0.051,0.0179,,,0.0961,0.037514654,0.122588251,0.0797,0.0858,0.0552,0.0569,,0.0425,0.0675,0.1262,0.0687
+2000-12-31,0.1681,0.0447,0.1362,,0.024,,0.1412,0.0412,,0.089,0.201,0.1078,,,0.1219,0.149152542,0.104380562,0.1805,-0.0018,0.0229,0.0754,,0.0682,0.0885,0.1441,0.0983
+2001-01-31,0.0438,0.0072,0.0071,,-0.009,,0.0063,-0.0042,,-0.0962,0.269,0.0115,,,0.0272,-0.000983284,0.047054891,-0.0522,0.0228,-0.029,0.0206,,0.0025,0.0074,0.01,0.0064
+2001-02-28,0.0056,0.006,-0.013,,0.0133,,-0.0143,0.0252,,0.1876,-0.022,-0.0161,,,0.0749,0.029199475,0.031228539,-0.0543,0.0299,0.0142,0.0269,,-0.0016,0.0013,0.0109,0.0013
+2001-03-31,0.0709,0.0675,0.0881,,0.0678,,0.0263,0.1051,,0.1346,0.032,0.0597,,,0.1296,0.118265859,0.033070988,0.1211,0.1517,0.0613,0.0709,,0.0438,0.0534,0.0833,0.0516
+2001-04-30,-0.0531,-0.0148,-0.0493,,-0.0839,,-0.0735,-0.0688,,-0.1525,-0.07,-0.034,,,-0.1015,-0.06299886,-0.031001517,-0.0559,-0.102,0.0015,-0.0466,,-0.0362,-0.0427,-0.0837,-0.042
+2001-05-31,-0.0261,0.0129,0.0185,,0.0151,,-0.0029,-0.0027,,-0.0066,0.032,0.0126,,,0.0261,-0.021296015,-0.00501932,0.0389,0.0513,0.0194,-0.0049,,0.0081,0.0106,0.0103,0.005
+2001-06-30,-0.0266,-0.0136,-0.0194,,-0.0152,,0.0156,-0.0092,,0.0539,0.038,-0.0181,,,-0.0077,0.014609885,-0.013099608,-0.022,0.0447,0.0118,-0.0268,0.0043,-0.0077,-0.0119,-0.0235,-0.0085
+2001-07-31,0.0066,0.0472,-0.0498,-0.0001,0.0124,,-0.0372,-0.0052,,-0.0126,-0.027,-0.0145,,,-0.0534,0.016237745,0.024119608,0.0368,-0.0285,0.0247,0.0077,0.0172,-0.004,-0.0073,-0.029,-0.0048
+2001-08-31,0.0056,0.0237,0.0328,0.0270027,0.0168,,0.0038,0.0185,,,0.019,-0.0289,,,0.0612,0.008139885,0.038707027,-0.0452,0.0489,0.0169,0.0802,0.0718,0.0153,0.0184,0.0285,0.0205
+2001-09-30,0.0464,0.0782,-0.0264,0.0601811,0.073,,0.0597,0.0984,,,0.093,0.0599,,,0.1991,0.163875598,0.061420024,0.0738,0.0928,0.055,0.0681,0.0837,0.0246,0.016,0.0404,0.0252
+2001-10-31,0.1375,0.0107,0.0405,0.0577753,0.0468,,0.0601,0.0535,,,0.003,0.053,,,0.1032,0.008992806,0.067656211,0.0297,0.0413,0.0307,0.0025,0.0426,0.0336,0.0371,0.0721,0.0384
+2001-11-30,-0.071,-0.0312,-0.0771,-0.0624348,-0.0995,,-0.1103,-0.0316,,,-0.076,-0.0357,,,-0.0882,-0.046600458,-0.074169939,0.0058,-0.1368,-0.0393,-0.0635,-0.0684,-0.0543,-0.0764,-0.136,-0.0696
+2001-12-31,-0.0515,0.0486,0.0205,0.0029637,0.0357,,0.0288,0.0049,,,-0.084,0.0072,,,0.0355,-0.02457265,-0.019735697,0.1042,-0.005,-0.0166,0.0236,-0.0181,0.0148,0.0257,0.0385,0.0205
+2002-01-31,-0.1013,-0.0117,0.0214,-0.0317665,-0.0086,,0.0042,-0.0249,,,-0.131,-0.046,,,0.0159,-0.035323111,-0.026675217,0.0405,-0.0173,-0.0083,0.004,0.0096,-0.0072,-0.0044,-0.0071,-0.005
+2002-02-28,-0.0604,-0.0069,-0.0419,0.0018121,-0.0198,,-0.0079,-0.0654,,,-0.072,-0.0222,,,-0.0173,-0.046551235,-0.01643611,-0.1371,0.0133,-0.0387,-0.073,-0.0384,-0.0202,-0.0217,-0.0392,-0.0287
+2002-03-31,0.1262,0.02,0.0119,-0.0631188,-0.0176,,-0.0029,0.057,,-0.0752,0.124,0.0314,,,-0.0148,-0.019648705,0.027078247,0.1653,-0.0662,0.037,0.027,-0.0775,0.0009,0.0017,0.0032,0.0021
+2002-04-30,-0.0376,-0.0099,-0.0337,0.0353622,-0.0408,,0.0052,-0.0843,,0.0155,-0.123,-0.0329,,,-0.0959,-0.019131491,-0.003836072,-0.0144,0.0499,-0.0073,0.016,0.0147,-0.0104,-0.0146,-0.0249,-0.0172
+2002-05-31,-0.0396,0.0234,0.0659,0.0187457,0.0372,,0.0037,0.0134,,0.0675,0.003,0.0627,,,0.0546,-0.001857585,0.001136794,-0.0249,0.0151,0.0082,0.0565,-0.0037,0.027,0.038,0.0504,0.0291
+2002-06-30,0.0795,0.0841,0.1209,0.0763969,0.0793,,0.1133,0.0693,,0.0738,0.077,0.0714,,,0.1532,0.129652605,0.083505033,0.0922,0.0775,0.0787,0.1075,0.1072,0.0655,0.0728,0.131,0.0729
+2002-07-31,0.0471,0.0597,0.0573,0.0365166,0.075,,0.0408,0.049,,0.0595,0.122,0.0362,,,0.1744,0.057386052,0.094730375,0.0376,-0.0397,0.0279,0.0527,0.0465,0.0413,0.0277,0.0734,0.0358
+2002-08-31,0.0604,0.0278,0.0154,0.052068,0.0352,,0.0322,0.0426,,0.0544,0.095,0.0149,,,0.0748,0.024668917,0.065068603,0.0083,0.0986,0.0208,0.0148,0.0401,0.022,0.022,0.0386,0.0217
+2002-09-30,0.0763,0.0344,0.06,0.1049737,0.0344,,0.0473,0.0692,,0.0513,0.045,0.0143,,,0.0866,0.082615307,0.086873878,0.069,0.0329,0.0334,0.0335,0.0653,0.0284,0.0218,0.0584,0.0339
+2002-10-31,-0.0796,-0.0272,-0.0692,-0.0447151,-0.0456,,-0.09,-0.0711,,-0.0773,-0.136,-0.0442,,,-0.0609,-0.095973783,-0.046019836,0.0099,-0.1019,-0.0141,-0.0456,-0.0588,-0.0376,-0.0327,-0.0678,-0.0406
+2002-11-30,-0.0069,-0.0171,-0.0352,0.0242593,-0.0114,,-0.0364,-0.0549,,-0.0508,0.053,-0.0043,,,-0.0188,-0.046090109,-0.021584735,-0.035,-0.018,-0.014,-0.0285,-0.0554,-0.0164,-0.0225,-0.0541,-0.0257
+2002-12-31,0.1416,0.0658,0.0694,0.0810749,0.0328,,0.069,0.075,,0.078,0.201,0.0111,,,0.0837,0.104234528,0.103974663,0.1692,0.1841,0.0552,0.0473,0.148,0.0489,0.0472,0.0935,0.0576
+2003-01-31,0.0595,0.0518,0.0399,0.1011867,0.072,,0.0779,0.0418,,0.132,-0.006,0.0716,,,0.0802,0.069321534,0.051773364,-0.0184,0.2418,-0.005,0.0299,0.0978,0.0441,0.0495,0.0764,0.0522
+2003-02-28,0.1195,0.0403,0.0637,0.0779875,0.0746,,0.0516,0.0444,,0.0722,-0.022,0.0521,,,0.0921,0.08091954,0.086873445,0.0616,0.1318,0.0091,0.0399,0.0556,0.0402,0.0472,0.0741,0.0561
+2003-03-31,-0.108,-0.0504,-0.0824,-0.0950606,-0.0434,,-0.0363,-0.0297,,-0.1283,-0.031,-0.0748,,,-0.0619,-0.082730753,-0.083752593,0.0093,-0.0473,0.0082,-0.0452,-0.0556,-0.0445,-0.0552,-0.0912,-0.058
+2003-04-30,0.0245,0.0377,0.0011,0.053471,0.0269,,0.0127,-0.016,,0.0145,-0.032,0.0505,,,0.0208,-0.009738001,-0.000186325,-0.079,0.0202,-0.0362,0.0418,0.0014,0.0065,0.0165,0.0076,0.0161
[TRUNCATED]

To get the complete diff run:
    svnlook diff /svnroot/returnanalytics -r 3560


More information about the Returnanalytics-commits mailing list