Skip to content
Snippets Groups Projects
forecast-evaluation.Rmd 15.1 KiB
Newer Older
  • Learn to ignore specific revisions
  • pbac's avatar
    pbac committed
    ---
    title: "Forecast evaluation"
    author: "Peder Bacher"
    date: "`r Sys.Date()`"
    
    pbac's avatar
    pbac committed
    output:
      rmarkdown::html_vignette:
        toc: true
        toc_debth: 3
    
    pbac's avatar
    pbac committed
    vignette: >
    
      %\VignetteIndexEntry{Forecast evaluation}
    
    pbac's avatar
    pbac committed
      %\VignetteEngine{knitr::rmarkdown}
      %\VignetteEncoding{UTF-8}
    ---
    
    ```{r external-code, cache=FALSE, include=FALSE, purl = FALSE}
    # Have to load the knitr to use hooks
    library(knitr)
    # This vignettes name
    vignettename <- "forecast-evaluation"
    
    pbac's avatar
    pbac committed
    # REMEMBER: IF CHANGING IN THE shared-init (next block), then copy to the others!
    
    pbac's avatar
    pbac committed
    ```
    
    pbac's avatar
    pbac committed
    
    
    pbac's avatar
    pbac committed
    ```{r init, cache=FALSE, include=FALSE, purl=FALSE}
    
    # Width will scale all
    figwidth <- 12
    # Scale the wide figures (100% out.width)
    figheight <- 4
    # Heights for stacked time series plots
    figheight1 <- 5
    figheight2 <- 6.5
    figheight3 <- 8
    figheight4 <- 9.5
    figheight5 <- 11
    
    pbac's avatar
    pbac committed
    
    
    # Set the size of squared figures (same height as full: figheight/figwidth)
    owsval <- 0.35
    ows <- paste0(owsval*100,"%")
    ows2 <- paste0(2*owsval*100,"%")
    # 
    fhs <- figwidth * owsval
    
    # Set for square fig: fig.width=fhs, fig.height=fhs, out.width=ows}
    # If two squared the:  fig.width=2*fhs, fig.height=fhs, out.width=ows2
    
    # Check this: https://bookdown.org/yihui/rmarkdown-cookbook/chunk-styling.html
    # Set the knitr options
    knitr::opts_chunk$set(
      collapse = TRUE,
    
    pbac's avatar
    pbac committed
      comment = "##!!    ",
    
    pbac's avatar
    pbac committed
      cache.path = paste0("../tmp/vignettes/tmp-",vignettename,"/"),
    
    pbac's avatar
    pbac committed
      fig.path = paste0("../tmp/vignettes/tmp-",vignettename,"/"),
    
      fig.height = figheight,
      fig.width = figwidth,
      out.width = "100%"
    )
    options(digits=3)
    
    
    pbac's avatar
    pbac committed
    
    # For cropping output and messages
    cropfun <- function(x, options, func){
    
    pbac's avatar
    pbac committed
      ## if (is.null(lines)) {
      ##   return(func(x, options))  # pass to default hook
      ## }
      if(!is.null(lines)){
          x <- unlist(strsplit(x, "\n"))
          i <- grep("##!!",x)
          if(length(i) > lines){
              # truncate the output, but add ....
              x <- x[-i[(lines+1):length(i)]]
              x[i[lines]] <- pst(x[i[lines]], "\n\n## ...output cropped")
          }
          # paste these lines together
          x <- paste(c(x, ""), collapse = "\n")
    
    pbac's avatar
    pbac committed
      x <- gsub("!!","",x)
      func(x, options)
    }
    
    hook_chunk <- knit_hooks$get("chunk")
    
    knit_hooks$set(chunk = function(x, options) {
        cropfun(x, options, hook_chunk)
    
    pbac's avatar
    pbac committed
    ```
    
    pbac's avatar
    pbac committed
    
    
    [onlineforecasting]: https://onlineforecasting.org/articles/onlineforecasting.pdf
    [building heat load forecasting]: https://onlineforecasting.org/examples/building-heat-load-forecasting.html
    [onlineforecasting.org]: https://onlineforecasting.org
    <!--shared-init-end-->
    
    
    
    pbac's avatar
    pbac committed
    
    ## Intro
    This vignette provides a short overview of the basics of forecast evaluation
    with the functions from the onlineforecast package. It follows up on the
    
    pbac's avatar
    pbac committed
    vignettes [setup-data](setup-data.html) and [setup-and-use-model](setup-and-use-model.html), and continues the building load forecast
    modelling presented there. If something is introduced in the present text, but
    not explained, then have a look in the two preceding vignettes to find an explanation.
    
    pbac's avatar
    pbac committed
    
    ## Load forecasts
    
    First Load the package, setup the model and calculate the forecasts:
    
    pbac's avatar
    pbac committed
    ```{r}
    
    pbac's avatar
    pbac committed
    # Load the package
    
    pbac's avatar
    pbac committed
    ```
    
    Just start by:
    ```{r}
    # Keep the data in D to simplify notation
    
    pbac's avatar
    pbac committed
    D <- Dbuilding
    
    pbac's avatar
    pbac committed
    # Keep the model output in y (just easier code later)
    D$y <- D$heatload
    
    pbac's avatar
    pbac committed
    # Generate time of day in a forecast matrix
    
    pbac's avatar
    pbac committed
    D$tday <- make_tday(D$t, 0:36)
    ```
    
    
    
    ## Score period
    
    ### Score period
    Set the `scoreperiod` as a logical vector to control which points will be
    included in score calculations.
    
    Use it to exclude a burn-in period of one week:
    ```{r}
    # Set the score period
    D$scoreperiod <- in_range("2010-12-22", D$t)
    ```
    
    
    ### Train period
    
    One fundamental caveat in data-driven modelling is over-fitting a model. This
    can easily happen when the model is fitted (trained) and evaluated on the same
    data. There are essentially two ways of dealing with this: Penalize increased
    model complexity or divide into a training set and test set (cross-validation). 
    
    In most forecasting applications the easiest and most transparent approach
    is some cross-validation approach - many methods for dividing into sets have
    been suggested. For online forecasting it is luckily quite straight forward,
    when a model is fitted using a recursive estimation method, like the RLS. In
    each time step the following happens:
    
    - Data for the new time point becomes available, both observations and new
      forecasts.
      
    - The parameters in the model are updated.
    
    - A new forecast is calculated.
    
    Hence, those forecasts are only calculated based on past data, so there is
    no need for dividing into a training set and a test set!
    
    However, the parameters (like the forgetting factor and low-pass filter
    coefficients) are optimized on a particular period, hence over-fitting is
    possible, however it's most often very few parameters compared to the number of
    observations - so the it's very unlikely to over-fit a recursive fitted model in
    this setup.
    
    
    
    ## Models
    
    
    ```{r, output.lines=10}
    # Define a new model with low-pass filtering of the Ta input
    model <- forecastmodel$new()
    model$output = "y"
    model$add_inputs(Ta = "lp(Ta, a1=0.9)",
                     I = "lp(I, a1=0.9)",
    
    pbac's avatar
    pbac committed
                     mu = "one()")
    
    pbac's avatar
    pbac committed
    model$add_prmbounds(Ta__a1 = c(0.8, 0.9, 0.99),
    
                        I__a1 = c(0.6, 0.9, 0.99),
                        lambda = c(0.9, 0.99, 0.9999))
    
    pbac's avatar
    pbac committed
    model$add_regprm("rls_prm(lambda=0.9)")
    
    pbac's avatar
    pbac committed
    # Optimize the parameters, only on two horizons
    kseqopt <- c(3,18)
    rls_optim(model, D, kseqopt)
    
    pbac's avatar
    pbac committed
    ```
    
    Fit for all horizons and see the fit summary:
    ```{r}
    
    pbac's avatar
    pbac committed
    # Forecast for all horizons
    
    pbac's avatar
    pbac committed
    model$kseq <- 1:36
    # Fit with RLS
    fit1 <- rls_fit(model$prm, model, D)
    
    pbac's avatar
    pbac committed
    # See the summary of the fit
    
    pbac's avatar
    pbac committed
    summary(fit1)
    ```
    
    Let us extend the model by adding a new input: A diurnal pattern comprised by
    Fourier series. It can simply be added to the current model object:
    ```{r, output.lines=10}
    # Add a diurnal curve using fourier series
    model$add_inputs(mu_tday = "fs(tday/24, nharmonics=4)")
    # Optimize the parameters
    
    pbac's avatar
    pbac committed
    rls_optim(model, D, kseq=kseqopt)
    
    pbac's avatar
    pbac committed
    ```
    
    Fit for all horizons and see the fit summary:
    ```{r}
    # Fit with RLS
    fit2 <- rls_fit(model$prm, model, D)
    # Check the fit
    summary(fit2)
    ```
    
    Keep the forecasts for plotting and later analysis:
    ```{r}
    
    pbac's avatar
    pbac committed
    # Keep the forecasts from each model by just inserting them in the data.list
    
    pbac's avatar
    pbac committed
    D$Yhat1 <- fit1$Yhat
    D$Yhat2 <- fit2$Yhat
    ```
    
    
    pbac's avatar
    pbac committed
    Plot the forecasts for the full score period:
    
    pbac's avatar
    pbac committed
    ```{r, fig.height=figheight2}
    # Plot to see the forecasts for the shortest and the longest horizon
    plot_ts(subset(D,D$scoreperiod), c("^y|^Yhat1","^y|^Yhat2"), kseq = c(1,36))
    ```
    
    Plot the full the first 14 days of the score period:
    ```{r, fig.height=figheight2}
    # Plot to see the forecasts for the shortest and the longest horizon
    plot_ts(subset(D,which(D$scoreperiod)[1:(14*24)]), c("^y|^Yhat1","^y|^Yhat2"), kseq = c(1,36))
    ```
    We can see how adding the diurnal pattern enables to track the morning shower peaks.
    
    
    
    ## Reference models
    
    The performance of a forecast model should be compared to a reference
    model. This is however not at all trivial, since the suitable reference model
    depends on the particular case of forecasting, e.g. the suitable reference model
    for wind power forecasting is not the same as for solar power forecasting -
    even within the same application the suitable reference model can be different
    
    pbac's avatar
    pbac committed
    depending on particular conditions etc.
    
    pbac's avatar
    pbac committed
    
    In general the fundamental reference model should be the simplest reasonable
    model not relying on any inputs, hence either a model based on a mean
    calculation or some persistence should used. It can also be, that the study is
    about concluding the value of using NWPs as input, and in that case the
    reference model should be the best model without the NWPs.
    
    We will here demonstrate how to generate persistence forecasts, both a
    persistence with the current model output and a diurnal persistence, which uses
    the latest value lagged a given period from the forecast time point.
    
    First the simple persistence:
    ```{r}
    
    pbac's avatar
    pbac committed
    # The simple persistence (forecast for same horizons as the model)
    D$YhatP <- persistence(D$y, model$kseq)
    
    pbac's avatar
    pbac committed
    # Plot a few horizons
    plot_ts(D, c("^y$|YhatP$"), c("2011-01-05","2011-01-10"), kseq=c(1,24,36))
    ```
    Remember that the forecasts are lagged in the plot. Maybe it's even more obvious
    to see that it's simply the current value for all horizons:
    ```{r}
    D$YhatP[1:4, 1:8]
    ```
    
    A diurnal (i.e. 24 hours) persistence is: Take the value from the most recent
    time point, at the same time of day, as the forecast time point
    (i.e. `tod(t+k)`). It can be obtained by:
    ```{r}
    # Use the argument perlen to set the period length
    
    pbac's avatar
    pbac committed
    D$YhatDP <- persistence(D$y, model$kseq, perlen=24)
    
    pbac's avatar
    pbac committed
    # Plot a few horizons
    plot_ts(D, c("^y$|YhatDP$"), c("2011-01-05","2011-01-10"), kseq=c(1,24,36))
    ```
    Note how going beyond the `perlen` value, then the forecasts are the 48 hours
    lag values (going >48 the forecasts will be 72 lagged and so fourth).
    
    
    ## Score comparison
    
    Now it's just a matter of calculating the score, as a function of the horizon,
    for each model and compare them.
    
    
    pbac's avatar
    pbac committed
    We have kept the forecasts in forecast matrices for each model, we can find them by:
    
    pbac's avatar
    pbac committed
    ```{r}
    # Find the forecasts in D
    nms <- grep("^Yhat", names(D), value=TRUE)
    nms
    ```
    
    pbac's avatar
    pbac committed
    So it's the small and the large model, and as reference the simple and the
    diurnal persistence model.
    
    pbac's avatar
    pbac committed
    
    One quite important point: When comparing forecasts from different models
    exactly the same forecast points must be included. When NAs are present, not all
    models predict the same values, e.g. a persistence model will leave forecasts
    after NAs, also as NAs.
    
    So to make sure that exactly the same points are included in the score
    calculation, we must only forecast points where all forecasts are available
    (i.e. non-NA):
    ```{r}
    
    pbac's avatar
    pbac committed
    # Find all complete cases for all forecasts and horizons
    ok <- complete_cases(D[nms])
    
    pbac's avatar
    pbac committed
    ```
    
    
    pbac's avatar
    pbac committed
    Check if there are NAs in the forecasts:
    
    pbac's avatar
    pbac committed
    ```{r}
    sum(ok)
    length(ok)
    ```
    
    
    pbac's avatar
    pbac committed
    The forecasts will always have NAs from the start, e.g.:
    
    pbac's avatar
    pbac committed
    ```{r}
    
    pbac's avatar
    pbac committed
    D$Yhat1[1:11, 1:10]
    ```
    but in this particular case other periods with NAs exists:
    ```{r}
    D$y[59:72]
    D$YhatP[59:72, 1]
    ```
    They have been excluded as non complete cases. 
    
    Actually we only want to include the scoreperiod in the evaluation:
    ```{r}
    ok <- ok & D$scoreperiod
    ```
    and there all models had complete forecasts:
    ```{r}
    sum(ok)
    sum(D$scoreperiod)
    ```
    
    We can now use the `score()` function for calculating the score with only the
    complete cases found above:
    ```{r}
    # The score as a function of the horizon
    
    pbac's avatar
    pbac committed
    R <- residuals(D$Yhat1, D$y)
    
    pbac's avatar
    pbac committed
    score(R, ok & D$scoreperiod)
    ```
    Actually, the default way is to only use complete cases, hence:
    ```{r}
    # Only complete cases are used per default
    score(R, D$scoreperiod) == score(R, ok & D$scoreperiod)
    ```
    Whether to use complete cases only can be controlled by:
    ```{r}
    # The score as a function of the horizon
    score(R, usecomplete=FALSE) == score(R)
    
    pbac's avatar
    pbac committed
    ```
    
    
    
    pbac's avatar
    pbac committed
    These steps can be made for all models by, where also only complete cases for
    all models are used per default:
    
    pbac's avatar
    pbac committed
    ```{r}
    
    pbac's avatar
    pbac committed
    RMSE <- score(residuals(D[nms], D$y), D$scoreperiod)
    
    pbac's avatar
    pbac committed
    ```
        
    ```{r, include=FALSE}
    # sapply(kseq, function(k){
    
    #     rmse(y - lagdf(YhatDM[ ,pst("k",k)], k))
    
    pbac's avatar
    pbac committed
    #     # hej det er vilfred jeg er peders søn og jeg elsker min far go jeg god til matematik og jeg elsker også min mor 
    # })
    ```
    
    Plot the RMSE as a function of the horizon:
    ```{r, fig.height=figheight2}
    
    pbac's avatar
    pbac committed
    plot(0, type="n", xlim=range(model$kseq), ylim=range(RMSE), xlab="Horizon k", ylab="RMSE (kW)")
    for(i in 1:ncol(RMSE)){
        points(model$kseq, RMSE[ ,i], type="b", col=i)
    
    pbac's avatar
    pbac committed
    }
    
    pbac's avatar
    pbac committed
    legend("topleft", nms, lty=1, col=1:length(nms))
    
    pbac's avatar
    pbac committed
    ```
    
    
    
    ### Training set and test set
    
    
    pbac's avatar
    pbac committed
    As explained, it is most times not necessary to divide in a train and a test set
    when fitting recursively (i.e. using RLS), however it can sometimes be useful.
    
    pbac's avatar
    pbac committed
    
    An easy approach is to set a logical vector, which is TRUE until the end of the
    
    pbac's avatar
    pbac committed
    training period (with a week of burn-in):
    
    pbac's avatar
    pbac committed
    ```{r plottrain}
    
    pbac's avatar
    pbac committed
    D$trainperiod <- in_range(D$t[7*24]-1, D$t, "2011-02-01")    
    
    pbac's avatar
    pbac committed
    plot(D$t, D$trainperiod)
    ```
    then optimize the parameters only on this period, by taking a subset:
    ```{r, output.lines=10}
    # Optimize the parameters
    
    pbac's avatar
    pbac committed
    rls_optim(model, subset(D,D$trainperiod), kseqopt)
    
    pbac's avatar
    pbac committed
    ```
    
    and then fit on the entire set:
    ```{r}
    # Fit with RLS
    
    pbac's avatar
    pbac committed
    fit <- rls_fit(model$prm, model, D)
    
    pbac's avatar
    pbac committed
    ```
    
    Finally, the score can be calculated on the period following the train period by:
    ```{r scorefit}
    
    pbac's avatar
    pbac committed
    score(fit$Yhat, !D$trainperiod)
    
    pbac's avatar
    pbac committed
    ```
    
    In this way it's rather easy to set up different schemes, like optimizing the
    parameters once a week etc.
    
    
    
    ## Residual analysis and model validation
    
    In the process of developing good forecasting models it is the always an
    interesting and informative experience (and necessary) to investigate the
    results of a model. Most of the time it boils down to investigating if there are
    any significant patterns left in the residuals - and how, if any, they can be
    described by extending the model.
    
    Plot for the small model:
    ```{r plot1, fig.height=figheight5}
    kseq <- c(1,18,36)
    plot_ts(fit1, kseq=kseq)
    ```
    In the second plot we see the residuals and it's clear that there is a diurnal
    pattern - and in the lower three plots the coefficients has also a diurnal pattern.
    
    Plot for the larger model (plots not included here):
    ```{r, fig.height=figheight5, fig.keep="none"}
    plot_ts(fit2, kseq=kseq)
    ```
    
    
    pbac's avatar
    pbac committed
    A pairs plot with residuals and inputs to see if patterns are left:
    ```{r plotpairs, fig.height=figwidth}
    kseq <- c(1,36)
    D$Residuals <- residuals(fit2)[ ,pst("h",kseq)]
    D$hour <- aslt(D$t)$hour
    pairs(D, subset=D$scoreperiod, pattern="Residuals|Ta|I|hour|^t$", kseq=kseq)
    ```
    So inspecting the two upper rows, there are no clear patterns to be seen for the
    mean (red lines are not deviating from zero). Some differences in the marginal
    distribution of the residuals are seen, e.g. for the hour the variance is
    clearly highest in the mornings.
    
    Examine how well the dynamics are modelled with the auto-correlation and cross-correlations:
    ```{r plotacf, fig.height=figwidth, echo=-1}
    par(mfrow=c(2,2))
    acf(D$Residuals$h1, na.action=na.pass)
    ccf(lagvec(D$Ta$k1,1), D$Residuals$h1, na.action=na.pass)
    ccf(lagvec(D$I$k1,1), D$Residuals$h1, na.action=na.pass)
    ccf(lagvec(D$I$k1,1), D$Residuals$h1, na.action=na.pass)
    ```
    
    A shorter period of plots of the fits (plots not included here):
    
    pbac's avatar
    pbac committed
    ```{r, fig.height=figheight5, fig.keep="none"}
    xlim <- c("2011-01-01","2011-01-14")
    
    plot_ts(fit1, xlim=xlim, kseq=kseq)
    
    pbac's avatar
    pbac committed
    plot_ts(fit2, xlim=xlim, kseq=kseq)
    ```
    
    The data plotted is returned:
    ```{r tscoef}
    tmp <- plot_ts(fit2, kseq=kseq, plotit=FALSE)
    class(tmp)
    names(tmp)
    # Residuals
    plot_ts(tmp, c("^Residuals"), kseq=kseq)
    # All RLS coefficients
    nms <- names(fit2$Lfitval$k1)
    plot_ts(tmp, pattern=nms, kseq=kseq)
    ```
    
    ```{r, fig.height=figheight3}
    plot_ts(tmp, pattern=c("^y$|^Yhat",nms), c("2011-02-06","2011-02-10"), kseq=kseq)
    ```
    
    The RLS coefficients are in the fit for each horizon:
    ```{r rlscoefficients}
    str(fit1$Lfitval$k1)
    ```
    
    
    pbac's avatar
    pbac committed
    
    
    pbac's avatar
    pbac committed
    
    Histograms and box-plots to find patterns. From the histogram and qq-norm plot:
    ```{r}
    par(mfrow=c(1,2))
    hist(D$Residuals$h1)
    qqnorm(D$Residuals$h1)
    qqline(D$Residuals$h1)
    ```
    We can see, that the residuals are symmetrical with heavy tails.
    
    
    From boxplots we see the distribution as a function of the time of day
    (i.e. hour in the pairs plot above):
    
    pbac's avatar
    pbac committed
    ```{r}
    boxplot(D$Residuals$h1 ~ D$tday$k0)
    ```
    They seem to be symmetrical and centered around zero, hence no pattern left in
    the mean - only the variance change.