lpirfs: An R Package to Estimate Impulse Response Functions by Local Projections

Abstract:

Impulse response analysis is a cornerstone in applied (macro-)econometrics. Estimating impulse response functions using local projections (LPs) has become an appealing alternative to the traditional structural vector autoregressive (SVAR) approach. Despite its growing popularity and applications, however, no R package yet exists that makes this method available. In this paper, I introduce lpirfs, a fast and flexible R package that provides a broad framework to compute and visualize impulse response functions using LPs for a variety of data sets.

Cite PDF Tweet

Published

Dec. 27, 2019

Received

Jul 1, 2019

Citation

Adämmer, 2019

Volume

Pages

11/2

421 - 438


1 Introduction

Since the seminal paper of , analysing economic time series by Vector Auto Regressive (VAR) models has become a main pillar in empirical macroeconomic analysis. VARs have been traditionally used to recover structural shocks in order to estimate their propagating effects on economic variables. This approach, however, has been criticized for several drawbacks such as the imposed dynamics on the (economic) system, the curse of dimensionality and the more difficult application to nonlinearities .

Estimating impulse response functions using local projections (LPs) has become an appealing alternative, which is reflected in the over 1,000 citations of the pioneering paper by . Instead of extrapolating the parameters into increasingly distant horizons, LPs estimate the parameters sequentially at each point of interest. It is argued that LPs offer three advantages over the traditional structural vector autoregressive (SVAR) approach: first, LPs are easier to estimate since they rely solely on simple linear regressions; second, the point or joint-wise inference is easily conducted; and third, impulse responses that are estimated using LPs are more robust when a (linear) VAR is misspecified . Although the latter argument has been questioned by , the recent study by shows equal and even better performance of LPs when the lag lengths for each forecast horizon are adequately fixed. Yet, proved that LPs and VAR models estimate the same impulse responses when the lag structures are unrestricted. This finding implies that empirical impulse responses that are estimated using LPs and SVARs are likely similar at short horizons but differ at longer ones.The appendix contains a comparison of impulse responses that are estimated using LPs and the traditional SVAR approach.

Since their introduction in 2005, LPs have been broadly applied to investigate, among others, the macroeconomic effects of oil price shocks ; state-dependent government spending multipliers ; the effects of monetary policy on financial markets and economic aggregates ; and the link between credit growth, monetary policy, house prices, and financial stability . Apart from the different research questions, these studies further differ regarding the data structures because they use panel and nonpanel data.

Despite the rising popularity and applications, no R package yet exists that can estimate impulse responses using LPs. The only exception is the code for the smooth LP approach by . The approach reduces the variance of the LP parameters with a linear B-spline basis function because LP coefficients can suffer from high variance, sometimes making the interpretation more difficult. The code is partly available on GitHub and has been applied by . The vars package by only allows estimating impulse response functions that are based on the traditional SVAR approach.

As a remedy, this paper introduces lpirfs , a fast and flexible R package that enables estimating and visualizing impulse responses using LPs for a variety of data sets. The first part of this paper outlines the theory of LPs and the differences from the traditional SVAR approach. The second part outlines the main functions and options of the package, and the last section applies lpirfs by replicating the empirical results from the economic literature.

2 Estimating impulse response functions using local projections

An SVAR with n variables can be written as follows:

(1)(β110β1n0βn10βnn0)(y1yn)t=(α1αn)+(β111β1n1βn11βnn1)(y1yn)t1++(β11pβ1npβn1pβnnp)(y1yn)tp+(ε1εn)t,

which more concisely becomes the following:

B0Yt=αt+B(L)Yt+εt.

The residuals εt are assumed to be white noise with zero mean.The assumption of independent and identically distributed innovations is common in applied work but can be relaxed . This representation is appealing from an economic perspective because the structural shocks are contemporaneously uncorrelated, and the variables have a contemporaneous effect on each other. The contemporaneous effect is measured by the square matrix B0. However, estimating this SVAR without further assumptions is not possible because of the simultaneous identification problem. Merely assuming that the structural shocks are orthogonal does not fully identify the system.

The SVAR in reduced form (henceforth VAR) equals: (2)Yt=α~+B~(L)Yt+ut,

where α~=B01α, B~(L)=B01B(L)
and E[ut,uτ]={(σ12σ1,n2σn,1σn2),for  t=τ 0,else.

The coefficient matrix B~(L) is a nonlinear function of the contemporaneous parameter matrix B0 and the structural parameter matrix B(L). In contrast to the SVAR, the VAR residuals ut are contemporaneously correlated, which impedes an unbiased economic interpretation. The VAR residuals are assumed to be linked to the SVAR shocks by the following:

ut=B01εt,E[utut]=Σu=B01B01.

Given that the covariance matrix of εt equals the identity matrix, one must still impose n(n1)/2 restrictions to estimate the structural form. The most general approach is to separate the residuals into orthogonal shocks by calculating a Cholesky decomposition of the covariance matrix Σu. The first variable in such a system responds to its own exogenous shock, the second variable to the first variable plus an exogenous shock to the second variable, and so on. The results thus depend on ordering . The Wold representation states that any covariance-stationary time series can be rewritten as a sum of present and past innovations. This theorem enables mapping the estimated VAR(p) coefficients recursively to the infinite-order vector moving-average coefficients . Impulse response functions are estimated iteratively by rewriting VAR(p) into its companion form (i.e., a VAR(1)):

IR^(0)=B01IR^(1)=Φ1B01IR^(2)=Φ2B01  ,

where the matrix Φ contains the coefficients of the VAR(1).

In his pioneering paper, proposed an alternative approach to estimate impulse responses. His first step consists of ordinary least squares (OLS) regressions for each forecast horizon:

(3)yt+h=αh+B1hyt1++Bphytp+ut+hh,h=0,1,  ,H1,

where αh is a vector of constants, and Bih are parameter matrices for lag p and forecast horizon h. The vector elements ut+hh are autocorrelated and/or heteroscedastic disturbances. The collection of all regressions of Eq. ((3)) are called LPs. The slope matrix B1h can be interpreted as the response of yt+h to a reduced form shock in t . Structural impulse responses are then estimated by the following:

(4)IR^(t,h,di)=B^1hdi,

where di=B01. As in the SVAR approach, the shock matrix di must be identified from a linear VAR. The LP approach thus does not overcome the problem of identification. Given the serial correlation of ut+hh, proposed to estimate robust standard errors using the approach by .

A great advantage of LPs is their easy extension to nonlinear frameworks. The simplest approach to separate data into two regimes is using a binary (dummy) variable. The drawback, however, is that it lowers the degrees of freedom. As a remedy, proposed computing state probabilities with a logistic function that allows using all observations for the estimations. The logistic function equals the following:

(5)F(zt)= e(γzt)(1+e(γzt)),

(6)var(zt)=1, E(zt)=0,

where zt is standardized so that γ (> 0) is scale-invariant. The value of γ must be provided by the user. For example, if zt corresponds to changes in the gross domestic product (GDP) at time t, an increase in zt would lead to a decrease in F(zt). Values close to zero of F(zt) would thus indicate periods of economic expansion. proposed standardizing the cyclical components of the filter according to the method by to obtain the variable zt. The observations for the two regimes are the product of the transition function and the endogenous variables:

(7)Regime 1 (R1):ytl(1F(zt1)),l=1,  ,p,Regime 2 (R2):ytlF(zt1),l=1,  ,p.

used the values of the transition function at t1 to avoid contemporaneous feedback from policy actions regarding whether the economy is in a recession or an expansion. Structural nonlinear impulse responses are estimated using the following:

IR^R1(t,h,di)=B^1,R1hdi,         h=0,  ,H1,IR^R2(t,h,di)=B^1,R2hdi,         h=0,  ,H1,

where B^1,R10=I and B^1,R20=I. The coefficient matrices B^1,R1h and B^1,R2h are obtained from the following LPs:

(8)yt+h=αh + B1,R1h(yt1(1F(zt1)) +  + Bp,R1h(ytp(1F(zt1))+ B1,R2h(yt1F(zt1))  +  + Bp,R2h(ytpF(zt1))+ ut+hh,

with h=0,  ,H1. This nonlinear approach has been used by to investigate the effect of consumer confidence on durable goods during periods of economic expansion and recession.

Estimating impulse responses with an identified shock

Besides the easy extension to nonlinear frameworks, another advantage of LPs is their flexible application to situations in which an exogenous shock can be identified outside of an SVAR. For example, constructed a military news shock to investigate whether US government spending multipliers are higher during periods of economic slack or when interest rates are near the zero lower bound. Once an exogenous shock has been identified, impulse responses can be directly estimated using OLS regressions:

(9)yt+h=αh+βhshockt+ϕxt+ut+hh,h=0,1,  ,H1,

where αh denotes the regression constant, xt is a vector of control variables, and shockt is the identified shock variable. The coefficient βh corresponds to the response of y at time t+h to the shock variable (shock) at time t. The impulse responses are the sequence of all estimated βh. As above, robust standard errors can be estimated using the approach by . If the shock variable is endogenous, shockt can be estimated using the two-stage least squares (2SLS) regression. In the case of nonlinearities, the variables can either be multiplied with a dummy variable or with the values of the transition function in Eq. ((7)).

Estimating impulse responses for panel data

Another advantage of LPs is that they can be applied to panel data as well. Estimating impulse responses based on panel data have been put forward by , , and , among others. The general equation for panel data is the following:

yi,t+h=αi,h+shocki,tβh+xi,tγh+εi,t+h,h=0,1,  ,H1,

where αi,h denotes (cross-section) fixed effect, xi,t is a vector of control variables, and shocki,t denotes the identified shock variable. Besides using the absolute values of yt, lpirfs also allows estimating cumulative impulse responses using (yi,t+hyi,t1) as the endogenous variable, which is often done for panel data (see, e.g., ). Similar to the univariate approach, shockt can also be first estimated by an instrument variable approach (see, e.g., ). It is further crucial to account for heteroskedasticity and autocorrelation in panel models. The importance of robust standard errors in the context of corporate finance and asset pricing has been shown by .

3 The lpirfs package

lpirfs enables estimating all of the above models and specifications. The main functions of the package are the following:

The functions lp_lin() and lp_nl() estimate linear and nonlinear impulse responses based on SVARs whose shocks are identified by the Cholesky decomposition. The functions lp_lin_iv() and lp_nl_iv() allow estimating impulse responses when a shock has been identified outside of the VAR. The functions lp_lin_panel() and lp_nl_panel() can be used for panel data.

Nonpanel functions rely on several routines written with Rcpp by , making the computations very fast. The functions for panel data are based on the well-established plm package by . Parallel computation, which is optional and available for all functions, can further reduce the computation time.

Nonpanel functions allow computing ordinary and heteroskedasticity and autocorrelation consistent (HAC) estimators for the impulse responses based on the approach by . By default, lpirfs increases the truncation parameter with the number of horizons h, but a fixed value can also be manually provided. In addition, pre-whitening is another option that might improve the confidence interval coverage . The user can also apply an information criterion for each forecast horizon to find the optimal number of lags. The included criteria are those developed by , , and . The endogenous, exogenous, and switching variables must be given separately as a data.frame. Table 1 summarizes the input options of the nonpanel functions.

Applying lpirfs to panel data works slightly differently than using nonpanel functions due to the dependency on the plm package. Instead of providing the endogenous and exogenous variables separately, the user must provide the entire panel data set first, and then give the column names for the endogenous, exogenous, and other variables. The default is to estimate a fixed-effects model, but all options available for the plm package are also available within lpirfs. Table 2 summarizes the input options for the linear and nonlinear panel functions.

Each function output becomes an S3 object, which enables using the generic R functions plot() and summary(). In addition, the package also contains the functions plot_lin() and plot_nl(), which enable creating individual graphs of impulse responses.

Table 1: Comparison of linear and nonlinear LP functions.
Function names
Input name lp_lin() lp_nl() lp_lin_iv() lp_nl_iv() Input description
endog_data Data.frame with endogenous variables for VAR model.
shock - - One column data.frame with the identified shock.
use_twosls - - - Option to estimate shock with 2SLS approach.
instrum - - - Data.frame with the instrument(s) for the 2SLS approach.
lags_endog_lin - Number of lags for linear model.
lags_endog_nl - - Number of lags for nonlinear model in Eq. ((8)).
lags_criterion Choose lags based on information criterion (AICc, AIC or BIC).
max_lags Maximum number of lags for information criterion.
trend Options to include constant, trend and quadratic trend.
shock_type - - Two types of shock: standard deviation or unit shock.
use_nw Option to estimate standard errors by .
nw_lag Option to manually fix the truncation parameter.
nw_prewhite Option for pre-whitening .
adjust_se Option to adjust standard errors for small samples.
confint Value of width for confidence bands.
hor Number of horizons for impulse responses.
switching - - Switching variable zt. See Eq. (5).
lag_switching - - Option to lag the values of the logistic function F(zt).
use_logistic - - Option to use the logistic function. See Eq. (5).
use_hp - - Option to use the filter by .
lambda - - Value of λ for the HP-filter. See .
gamma - - Value of γ. See Eq. ((5)).
exog_data Optional data for exogenous variables.
lags_exog Number of lags for exogenous variables.
contemp_data Variables with contemporaneous impact.
num_cores Option to choose number of cores.

The table compares the options for lp_lin(), lp_nl(), lp_lin_iv(), and lp_nl_iv(). The symbol indicates whether the option, denoted by the row, is available for the function, denoted by the column. The optional lag length criteria are those by , and .

Table 2: Comparison of linear and nonlinear LP functions for panel data.
Function names
Input name lp_lin_panel() lp_nl_panel() Input description
data_set A data.frame, containing the panel data set.
data_sample Option to estimate a subset of the data.
endog_data Character name of the endogenous variable.
cumul_mult Option to estimate cumulative multipliers.
shock Character name of the variable to shock with.
diff_shock Option to use first differences of the shock variable.
iv_reg - Option to use instrument variable approach.
instrum - The name(s) of the instrument variable(s).
panel_model Option to choose type of panel model. See plm package.
panel_effect The effects introduced in the panel-model. See plm package.
robust_cov Options for robust covariance matrix estimator. See plm package.
robust_method Option for robust_cov. See plm package.
robust_type Option for robust_cov. See plm package.
robust_cluster Option for robust_cov. See plm package.
robust_maxlag Option for robust_cov. See plm package.
use_gmm Option to use GMM for estimation.
gmm_model Option to use "onestep" or "twosteps" approach. See plm package.
gmm_effect The effects introduced in the panel-model. See plm package.
gmm_transformation Additional option for GMM model. See plm package.
c_exog_data Name(s) of the exogenous variable(s) with contemporaneous impact.
l_exog_data Name(s) of the exogenous variable(s) with lagged impact.
lags_exog_data Lag length for the exogenous variable(s) with lagged impact.
c_fd_exog_data Exogenous variable(s) with contemporaneous impact of first differences.
l_fd_exog_data Exogenous variable(s) with lagged impact of first differences.
lags_fd_exog_data Number of lags for variable(s) with impact of first differences.
confint Value of width for confidence bands.
switching - Column name of the switching variable.
use_logistic - Option to use the logistic function. See Eq. (5).
use_hp - Option to use the filter by to obtain zt.
lag_switching - Option to lag the values of the logistic function F(zt).
lambda - - Value of λ for the HP-filter. See .
gamma - - Value of γ. See Eq. ((5)).
hor Number of horizons for impulse responses.

The table compares the options for lp_lin_panel() and lp_nl_panel(). The symbol indicates whether the option, denoted by the row, is available for the function, denoted by the column. The functions estimate linear and nonlinear impulse responses for models with panel data.

4 Examples and replications

In this section, I apply all the main functions of lpirfs to three different settings. The impulse responses are visualized by the generic plot() function, which serves as a wrapper for the built-in functions plot_lin() and plot_nl().

Two exercises replicate empirical results by and . The data sets are included in lpirfs. The third example uses the external Jordà-Schularick-Taylor Macrohistory Database, which covers 17 advanced economies since 1870 on an annual basis and comprises 25 real and nominal variables. I estimate how an increase in the interest rate affects mortgage lending. This example is based on a STATA code provided on Oscar Jordá’s website. Due to copyright issues, the database could not be included in the package, but I show how it can be easily downloaded with R.

Traditional approach: Replicating results by Jordà (2005)

The following code replicates parts of Figure 5 in . It shows how the output gap, inflation rate, and federal funds rate react to the corresponding structural shocks. The results are shown in Figure 1.In the appendix, I compare these results with those estimated by a general SVAR. lpirfs follows the convention by , namely that the first horizon, denoted on the x-axis, equals h=0. Applying the generic function summary() to the output returns a list of several matrices with OLS diagnostics. The first level of the list corresponds to the shock variable and the second level to the horizon. Table 3 shows OLS diagnostics for the first horizon of the first shock (output gap).

    
# --- Code to replicate Figure 5 in Jordá (2005, p. 176)
                        
# Load packages 
  library(lpirfs)
    
# Load data set
  endog_data  <- interest_rules_var_data
        
# Estimate linear model
  results_lin <- lp_lin(endog_data     = endog_data, 
                        lags_endog_lin = 4,   
                        trend          = 0,    
                        shock_type     = 1,
                        confint        = 1.96, 
                        hor            = 12)   

# Show impulse responses
  plot(results_lin)
  
# Show OLS diagnostics for the first shock of the first horizon  
  summary(results_lin)[[1]][1] 
                
                
# --- End example code          
                        
Table 3: OLS diagnostics shown by using summary().
R.sqrd. Adj. R.sqrd. F.stat p.value
h 1: GDP_gap 0.91 0.90 146.88 0.00
h 1: Infl 0.84 0.83 77.17 0.00
h 1: FF 0.94 0.93 218.74 0.00

The table shows OLS diagnostics for the example of the first horizon for the first identified shock (output gap).

graphic without alt text
Figure 1: Replication of Figure 5 in .

The example above only estimates impulse responses for the linear case, but also tested for nonlinearities. Although he found no “business-cycle” asymmetries, he identified significant asymmetries for several lags of both inflation and the federal funds rate. The following code uses a dummy approach to estimate the nonlinear impulse responses of the variables to a shock in the federal funds rate. used a threshold of 4.75% for the inflation rate, applied to its third lag. Figure 2 shows the empirical results for the nonlinear example. The results are comparable to the findings by , namely that the magnitudes of responses of inflation and output to interest rates are more responsive in the low-inflation regime (left panel) than in the high-inflation regime (right panel).

# --- Code for nonlinear effects of the federal funds rate. 

# Load packages for creating plots
  library(dplyr)
  library(gridExtra)
  library(ggpubr)
    
# Create dummy: apply threshold of 4.75 percent to the third lag of the inflation rate
  switching_data <-  if_else(dplyr::lag(endog_data$Infl, 3) > 4.75, 1, 0)

# Estimate nonlinear model 
  results_nl <- lp_nl(endog_data, 
                       lags_endog_lin = 4,              lags_endog_nl = 4,   
                       trend          = 1,              shock_type    = 0,   
                       confint        = 1.67,           hor           = 12,   
                       switching      = switching_data, lag_switching = FALSE,  
                       use_logistic   = FALSE)  
                
# Create nonlinear impulse responses
  nl_plots <- plot_nl(results_nl)   
    
# Combine and show plots using 'ggpubr' and 'gridExtra'
  single_plots      <- nl_plots$gg_s1[c(3, 6, 9)]
  single_plots[4:6] <- nl_plots$gg_s2[c(3, 6, 9)]
  all_plots         <- sapply(single_plots, ggplotGrob)
  marrangeGrob(all_plots, nrow = 3, ncol = 2, top = NULL)   
  
# --- End example code  
graphic without alt text
Figure 2: Nonlinear impulse responses based on .

The figure depicts nonlinear impulse responses of the output gap, inflation rate, and federal funds rate to a shock in the federal funds rate during periods of low (left panel) and high (right panel) inflation rates. The threshold of 4.75 is applied to the third lag of the inflation rate.

Using an external shock: Replicating results by Ramey and Zubairy (2018)

In this section, I replicate the empirical results by . The authors, among others, re-evaluate the findings by , who argued that government spending multipliers are more pronounced during economic recession than during economic expansion. applied a smooth transition VAR (STVAR) to estimate state-dependent fiscal multipliers. , however, showed that the estimated fiscal multipliers are much smaller when the impulse responses are estimated using LPs. The reason is that the LP approach does not assume that the system remains in a fixed regime once it has entered it.

The following code replicates parts of Figure 12 in the supplementary appendix by . The results are depicted in Figure 3. It shows how government spending and the GDP react to a government spending shock in the linear case as well as during periods of economic expansion and recession. The linear shock is identified according to . The absolute values of the figures differ because multiplied the log output response by a conversion factor of 5.6.


# --- Code to replicate parts of Figure 12 in the supplementary appendix by 
# --- Ramey and Zubairy (2018, p.35)

# Load packages for creating plots
  library(gridExtra)
  library(ggpubr)

# Load data from package
  ag_data      <- ag_data
  sample_start <- 7
  sample_end   <- dim(ag_data)[1]

# Endogenous data
  endog_data <- ag_data[sample_start:sample_end,3:5]

# Shock variable
  shock      <- ag_data[sample_start:sample_end, 3]

# Estimate linear model
  results_lin_iv <- lp_lin_iv(endog_data = endog_data, lags_endog_lin = 4,
                    shock      = shock,      trend          = 0,
                    confint    = 1.96,       hor            = 20)

# Make and save linear plots
  iv_lin_plots <- plot_lin(results_lin_iv)

# Nonlinear shock (estimated by Ramey and Zubairy (2018))
  shock <- ag_data[sample_start:sample_end, 7]

# Use moving average growth rate of GDP as exogenous variable
  exog_data <- ag_data[sample_start:sample_end, 6]

# Use moving average growth rate of GDP as switching variable
  switching_variable <- ag_data$GDP_MA[sample_start:sample_end] - 0.8

# Estimate nonlinear model
  results_nl_iv <- lp_nl_iv(endog_data = endog_data, lags_endog_nl  = 3,
                            shock      = shock,      exog_data      = exog_data,
                            lags_exog  = 4,          trend          = 0,
                            confint    = 1.96,       hor            = 20,
                            switching  = switching_variable, use_hp = FALSE,
                            gamma      = 3)

# Make and save nonlinear plots
  plots_nl_iv <- plot_nl(results_nl_iv)

# Make list to save all plots 
  combine_plots <- list()

# Save linear plots in list
  combine_plots[[1]] <- iv_lin_plots[[1]]
  combine_plots[[2]] <- iv_lin_plots[[3]]

# Save nonlinear plots for expansion period
  combine_plots[[3]] <- plots_nl_iv$gg_s1[[1]]
  combine_plots[[4]] <- plots_nl_iv$gg_s1[[3]]

# Save nonlinear plots for recession period 
  combine_plots[[5]] <- plots_nl_iv$gg_s2[[1]]
  combine_plots[[6]] <- plots_nl_iv$gg_s2[[3]]
  
# Show all plots  
  lin_plots_all      <- sapply(combine_plots, ggplotGrob)
  marrangeGrob(lin_plots_all, nrow = 2, ncol = 3, top = NULL)

# --- End example code
graphic without alt text
Figure 3: The figure replicates empirical results of Figure 12 from the supplementary appendix by . The left column shows the (linear) reaction of government spending (first row) and GDP (second row) to a government spending shock. The middle column shows the reactions during periods of economic expansion and the right column during periods of economic slack.

Estimating impulse responses for panel data

Using the Jordà-Schularick-Taylor Macrohistory Database, the following example estimates the impulse responses of the ratio of mortgage lending divided by the GDP to a 1% increase in the short-term interest rate. Observations during World Wars I and II and observations after 2013 are excluded.lpirfs first computes all lags and lags of the first differences of the exogenous data. If the user wants to use a sub-sample (see example), the observations will be dropped after the lags have been constructed. The empirical results are shown in Figure 4. An increase in the short-term interest rate leads to a decrease in the mortgage lending rate, whose effect attenuates after approximately 8 years.

 
#--- Begin code for panel data
 
# Load libraries to download and read excel file from the website
  library(httr)
  library(readxl)
  library(dplyr)
  
# Retrieve the external JST Macrohistory Database
  url_jst <-"http://www.macrohistory.net/JST/JSTdatasetR3.xlsx"
  GET(url_jst, write_disk(jst_link <- tempfile(fileext = ".xlsx")))
  jst_data <- read_excel(jst_link, 2L)
  
# Remove observations after 2013 and swap the first two columns 
  jst_data <- jst_data                      %>%
          dplyr::filter(year <= 2013)   %>%
          dplyr::select(country, year, everything())
    
# Prepare variables
  data_set <- jst_data                                       %>%
              mutate(stir    = stir)                         %>%
          mutate(mortgdp = 100*(tmort/gdp))              %>%
          mutate(hpreal  = hpnom/cpi)                    %>%
          group_by(country)                              %>%
          mutate(hpreal  = hpreal/hpreal[year==1990][1]) %>%
          mutate(lhpreal = log(hpreal))                  %>%
    
         mutate(lhpy    = lhpreal - log(rgdppc))        %>%
          mutate(lhpy    = lhpy - lhpy[year == 1990][1]) %>%
          mutate(lhpreal = 100*lhpreal)                  %>%
          mutate(lhpy    = 100*lhpy)                     %>%
          ungroup()                                      %>%
    
          mutate(lrgdp   = 100*log(rgdppc))              %>%
          mutate(lcpi    = 100*log(cpi))                 %>%
          mutate(lriy    = 100*log(iy*rgdppc))           %>%
          mutate(cay     = 100*(ca/gdp))                 %>%
          mutate(tnmort  = tloans - tmort)               %>%
          mutate(nmortgdp = 100*(tnmort/gdp))            %>%
          dplyr::select(country, year, mortgdp, stir, ltrate, 
          lhpy, lrgdp, lcpi, lriy, cay, nmortgdp)

 
# Exclude observations from WWI and WWII
  data_sample <- seq(1870, 2016)[which(!(seq(1870, 2016) %in%
                                       c(seq(1914, 1918), 
                                         seq(1939, 1947))))]

# Estimate linear panel model with robust covariance matrix
  results_panel <- lp_lin_panel(data_set  = data_set,  data_sample  = data_sample,
                        endog_data        = "mortgdp", cumul_mult   = TRUE,
                        shock             = "stir",    diff_shock   = TRUE,
                        panel_model       = "within",  panel_effect = "individual",
                        robust_cov        = "vcovSCC", c_exog_data  = "cay",
                        c_fd_exog_data    = colnames(data_set)[c(seq(4,9),11)],
                        l_fd_exog_data    = colnames(data_set)[c(seq(3,9),11)],
                        lags_fd_exog_data = 2,      confint      = 1.67,
                        hor               = 10)
                               
# Show irfs
  plot(results_panel)

#--- End example 
graphic without alt text
Figure 4: The figure shows the reaction of the ratio of mortgage lending divided by the GDP to a +1% change in the short-term interest rate.

The following example uses the Hodrick–Prescott filter to decompose the log-GDP time series for each country to obtain the standardized variable zt for the logistic function in Eq. (5). Figure 5 shows the impulse responses for both regimes. The mortgage lending ratio declines in both regimes, although it is more pronounced during periods of economic expansion (left panel) than periods of economic slack (right panel).


# --- Begin example 
    
# Estimate panel model
  results_panel <- lp_nl_panel(data_set   = data_set,  data_sample    = data_sample,
                        endog_data        = "mortgdp", cumul_mult     = TRUE,
                        shock             = "stir",    diff_shock     = TRUE,
                        panel_model       = "within",  panel_effect   = "individual",
                        robust_cov        = "vcovSCC", switching      = "lrgdp",
                        lag_switching     = TRUE,      use_hp         = TRUE,
                        lambda            = 6.25,      gamma          = 10,
                        c_exog_data       = "cay",     
                        c_fd_exog_data    = colnames(data_set)[c(seq(4,9),11)],
                        l_fd_exog_data    = colnames(data_set)[c(seq(3,9),11)], 
                        lags_fd_exog_data = 2,      
                        confint           = 1.67,
                        hor               = 10)

# Show irfs
  plot(results_panel)


# --- End example
graphic without alt text
Figure 5: The figure shows the reaction of the ratio of mortgage lending divided by the GDP to a +1% change in the short-term interest rate during periods of economic expansions (left panel) and economic slack (right panel).

5 Summary

Since the 1980s, impulse response analysis has become a cornerstone in (macro-)econometrics. The traditional approach of recovering the impulse responses recursively from a (linear) VAR has been criticized due to some drawbacks, such as the imposed dynamics on the (economic) system, the curse of dimensionality, and the more difficult application to nonlinear frameworks.

The LPs by have become a widely applied alternative to estimate impulse response functions. This paper introduced lpirfs, an R package that provides a broad framework for estimating and visualizing impulse response functions using LPs for a variety of data sets. I replicated the empirical results from the economic literature to prove the validity of the package and to show its usefulness for future research.

6 Appendix

This appendix contains a comparison between impulse responses estimated using the vars package and lpirfs. In addition, I conduct sensitivity analyses regarding the choices of γ in Eq. (5) for the switching function and different values of λ for the filter by . The code for all examples can be found in the vignette of lpirfs.

Comparison of impulse responses between lpirfs and vars

showed that LPs and VARs compute the same impulse responses when the lag structure is unrestricted. For empirical studies, this implies that impulse responses that are estimated by LPs and SVARs are likely to agree at short horizons but differ at longer ones. To verify this implication, I compare the impulse responses estimated using the lpirfs and vars packages. The latter relies on the common SVAR approach.

Figure 6 shows the empirical results. The black lines and gray-shaded areas are the same as in Figure 1, which replicates Figure 5 in . The orange lines and shaded areas correspond to impulse responses estimated by the vars package (i.e., a standard SVAR). The results show that impulse responses are similar up to that horizon, which equals the lag length p. For example, when the lag length p equals 2, the impulse responses and confidence intervals diverge very quickly (first column). When the lag length p equals 6, however, the impulse responses are much more similar. This finding coincides with the empirical results by , who compared the dynamic response of corporate bond spreads to a monetary policy shock.

graphic without alt text
Figure 6: Comparison of impulse responses estimated by the packages lpirfs and vars. Each column shows the results for a fixed number of lags (i.e., p = 2, 4, and 6). The shaded areas correspond to the 95% confidence intervals.

Sensitivity analyses for γ

The nonlinear functions in lpirfs allow separating the data into two regimes by either using a dummy approach or computing state probabilities with the logistic function given in Eq. (5). The logistic function depends on the parameter γ, which defines how sharply the two regimes are separated. To investigate how different choices of γ might affect the results, I compare the nonlinear impulse responses for a shock of the federal funds rate on the output gap.

Figure 7 shows the empirical results. Each column corresponds to one choice of γ, namely γ=1, 5, and 10. I use the output gap as a switching variable and decompose it using the filter by . The penalty term λ is set to 1 600 as suggested by . The first row of Figure 7 shows the evolution of the transition variable F(zt), along with NBER-dated recessions. By construction, a high value of the transition variable corresponds to a low output gap (i.e., periods of economic slack). Choosing a low value of γ makes the regime-switching smooth, whereas higher values of γ cause the switching to be quick. The second and third rows show nonlinear impulse responses for Regimes 1 (economic expansion) and 2 (economic recession). Although the choice of γ has an effect on the results, it does not change the overall conclusion, namely that no “business-cycle” effects exist regarding the changes in the federal funds rate, which is in accordance with the findings by . At most, the effect would be very shortly negative during periods of economic downturn.

graphic without alt text
Figure 7: Comparison of nonlinear impulse responses for different values of γ. Each column shows the results for one parameter value (i.e., γ=1,5, and 10). The gray shaded areas in the first row correspond to NBER-dated recessions. The gray shaded areas in the second and third rows correspond to the 95% confidence intervals of the impulse responses.

Sensitivity analyses for λ

To use the switching function in Eq. (5), one must provide a standardized variable zt. One option is to decompose a time series into a trend and a cyclical component using the filter by (hereafter the HP-filter). lpirfs includes this option whose routine is written in Rcpp, making the computation very fast. If applied, the cyclical component of the HP-filter will be standardized and used for zt. The filter depends on a penalty term λ, which must be given by the user. argued that the parameter should be 6.25 for annual data, 1 600 for quarterly data, and 129 600 for monthly data. To see how different choices of λ influence the nonlinear impulse responses, I decompose the output gap for three different values of λ and compare the results, which are shown in Figure 8. The value of γ is fixed to 5. The first row shows the cyclical component of the HP-filter along with the NBER-dated recessions. A low value in the cyclical component denotes periods of economic downturn. Note that the results of the second column in Figure 8 are identical to those in the second column of Figure 7. In contrast to the previous analysis, empirical results do change significantly, depending on the choice of λ. Thus, it is important to set the penalty term adequately.

graphic without alt text
Figure 8: Comparison of nonlinear impulse responses with different values of λ for the filter by . Each column shows the results for one parameter value (i.e., λ=6.25,1 600, and 129 600). The gray shaded areas in the first row correspond to NBER-dated recessions. The gray shaded areas in the second and third rows correspond to the 95% confidence intervals of the impulse responses.

7 Acknowledgement

I am grateful to the two anonymous reviewers, Philipp Wittenberg, Jon Danielsson, Rainer Schüssler, Tom Philipp Dybowski, and Detlef Steuer for their helpful comments and suggestions on the paper and package.

CRAN packages used

vars, lpirfs, Rcpp, plm

CRAN Task Views implied by cited packages

CausalInference, Econometrics, Finance, HighPerformanceComputing, MixedModels, NumericalMathematics, SpatioTemporal, TimeSeries

Note

This article is converted from a Legacy LaTeX article using the texor package. The pdf version is the official version. To report a problem with the html, refer to CONTRIBUTE on the R Journal homepage.

Footnotes

  1. The appendix contains a comparison of impulse responses that are estimated using LPs and the traditional SVAR approach.[↩]
  2. The assumption of independent and identically distributed innovations is common in applied work but can be relaxed .[↩]
  3. In the appendix, I compare these results with those estimated by a general SVAR.[↩]
  4. lpirfs first computes all lags and lags of the first differences of the exogenous data. If the user wants to use a sub-sample (see example), the observations will be dropped after the lags have been constructed.[↩]

References

P. Adämmer. lpirfs: Local projections impulse response functions. 2019. URL https://CRAN.R-project.org/package=lpirfs. R package version: 0.1.6.
M. I. Ahmed and S. P. Cassou. Does consumer confidence affect durable goods spending during bad and good economic times equally? Journal of Macroeconomics, 50: 86–97, 2016. DOI https://doi.org/10.1016/j.jmacro.2016.08.008.
H. Akaike. A new look at the statistical model identification. IEEE transactions on automatic control, 19(6): 716–723, 1974. DOI https://doi.org/10.1109/TAC.1974.1100705.
D. W. K. Andrews and J. C. Monahan. An improved heteroskedasticity and autocorrelation consistent covariance matrix estimator. Econometrica, 60(4): 953–966, 1992. DOI https://doi.org/10.2307/2951574.
A. J. Auerbach and Y. Gorodnichenko. Measuring the output responses to fiscal policy. American Economic Journal: Economic Policy, 4(2): 1–27, 2012. DOI https://doi.org/10.1257/pol.4.2.1.
A. J. Auerbach and Y. Gorodnichenko. Output spillovers from fiscal policy. American Economic Review, 103(3): 141–46, 2013. DOI https://doi.org/10.1257/aer.103.3.141.
R. Barnichon and C. Brownlees. Impulse response estimation by smooth local projections. Review of Economics and Statistics, 101(3): 522–530, 2019. DOI https://doi.org/10.1162/rest_a_00778.
O. Blanchard and R. Perotti. An Empirical Characterization of the Dynamic Effects of Changes in Government Spending and Taxes on Output. The Quarterly Journal of Economics, 117(4): 1329–1368, 2002. DOI https://doi.org/10.1162/003355302320935043.
L. Brugnolini. About local projection impulse response function reliability. CEIS Working Paper, 2018. URL https://papers.ssrn.com/sol3/papers.cfm?abstract_id=3229218.
Y. Croissant and G. Millo. Panel data econometrics in R: The plm package. Journal of Statistical Software, 27(2): 1–43, 2008. DOI https://doi.org/10.18637/jss.v027.i02.
D. Eddelbuettel, R. François, J. Allaire, K. Ushey, Q. Kou, N. Russel, J. Chambers and D. Bates. Rcpp: Seamless r and c++ integration. Journal of Statistical Software, 40(8): 1–18, 2011. DOI https://doi.org/10.18637/jss.v040.i08.
G. Favara and J. Imbs. Credit supply and the price of housing. American Economic Review, 105(3): 958–92, 2015. DOI https://doi.org/10.1257/aer.20121416.
J. Garı́n, R. Lester and E. Sims. Are supply shocks contractionary at the ZLB? Evidence from utilization-adjusted TFP data. Review of Economics and Statistics, 101(1): 160–175, 2019. DOI https://doi.org/10.1162/rest_a_00723.
J. D. Hamilton. Nonlinearities and the macroeconomic effects of oil prices. Macroeconomic Dynamics, 15(S3): 364–378, 2011. DOI https://doi.org/10.1017/S1365100511000307.
R. J. Hodrick and E. C. Prescott. Postwar US business cycles: An empirical investigation. Journal of Money, Credit, and Banking, 1–16, 1997. DOI https://doi.org/10.2307/2953682.
C. M. Hurvich and C.-L. Tsai. Regression and time series model selection in small samples. Biometrika, 76(2): 297–307, 1989. DOI https://doi.org/10.1093/biomet/76.2.297.
Ò. Jordà. Estimation and inference of impulse responses by local projections. American Economic Review, 95(1): 161–182, 2005. DOI https://doi.org/10.1257/0002828053828518.
Ò. Jordà, M. Schularick and A. M. Taylor. Betting the house. Journal of International Economics, 96: S2–S18, 2015. DOI https://doi.org/10.1016/j.jinteco.2014.12.011.
Ò. Jordà, M. Schularick and A. M. Taylor. The effects of quasi-random monetary experiments. Journal of Monetary Economics, In press: 2019. DOI https://doi.org/10.1016/j.jmoneco.2019.01.021.
Ò. Jordà and A. M. Taylor. The time for austerity: Estimating the average treatment effect of fiscal policy. The Economic Journal, 126(590): 219–255, 2016. DOI https://doi.org/10.1111/ecoj.12332.
J. Keating. Structural approaches to vector autoregressions. Federal Reserve Bank of St. Louis Review, 74(September/October): 1992. URL https://files.stlouisfed.org/files/htdocs/publications/review/92/09/Vector_Sep_Oct1992.pdf.
L. Kilian and Y. J. Kim. How reliable are local projection estimators of impulse responses? Review of Economics and Statistics, 93(4): 1460–1466, 2011. DOI https://doi.org/10.1162/REST_a_00143.
W. K. Newey and K. D. West. Hypothesis testing with efficient method of moments estimation. International Economic Review, 777–787, 1987. DOI https://doi.org/10.2307/2526578.
M. T. Owyang, V. A. Ramey and S. Zubairy. Are government spending multipliers greater during periods of slack? Evidence from twentieth-century historical data. American Economic Review, 103(3): 129–134, 2013. DOI https://doi.org/10.1257/aer.103.3.129.
M. A. Petersen. Estimating standard errors in finance panel data sets: Comparing approaches. The Review of Financial Studies, 22(1): 435–480, 2009. DOI https://doi.org/10.1093/rfs/hhn053.
B. Pfaff. VAR, SVAR and SVEC models: Implementation Within R Package vars. Journal of Statistical Software, 27(4): 2008. DOI https://doi.org/10.18637/jss.v027.i04.
M. Plagborg-Møller and C. K. Wolf. Local projections and VARs estimate the same impulse responses. Unpublished paper: Department of Economics, Princeton University, 2019. URL https://scholar.princeton.edu/sites/default/files/mikkelpm/files/lp_var.pdf.
V. A. Ramey and S. Zubairy. Government spending multipliers in good times and in bad: Evidence from US historical data. Journal of Political Economy, 126(2): 850–901, 2018. DOI https://doi.org/10.1086/696277.
M. O. Ravn and H. Uhlig. On adjusting the hodrick-prescott filter for the frequency of observations. Review of Economics and Statistics, 84(2): 371–376, 2002. DOI https://doi.org/10.1162/003465302317411604.
G. Schwarz. Estimating the dimension of a model. The Annals of Statistics, 6(2): 461–464, 1978. DOI https://doi.org/10.1214/aos/1176344136.
C. A. Sims. Macroeconomics and reality. Econometrica: Journal of the Econometric Society, 1–48, 1980. DOI https://doi.org/10.2307/1912017.
E. T. Swanson. Measuring the effects of federal reserve forward guidance and asset purchases on financial markets. National Bureau of Economic Research. 2017. URL https://www.nber.org/papers/w23311.
S. Tenreyro and G. Thwaites. Pushing on a string: US monetary policy is less powerful in recessions. American Economic Journal: Macroeconomics, 8(4): 43–74, 2016. DOI https://doi.org/10.1257/mac.20150016.

Reuse

Text and figures are licensed under Creative Commons Attribution CC BY 4.0. The figures that have been reused from other sources don't fall under this license and can be recognized by a note in their caption: "Figure from ...".

Citation

For attribution, please cite this work as

Adämmer, "lpirfs: An R Package to Estimate Impulse Response Functions by Local Projections", The R Journal, 2019

BibTeX citation

@article{RJ-2019-052,
  author = {Adämmer, Philipp},
  title = {lpirfs: An R Package to Estimate Impulse Response Functions by Local Projections},
  journal = {The R Journal},
  year = {2019},
  note = {https://rjournal.github.io/},
  volume = {11},
  issue = {2},
  issn = {2073-4859},
  pages = {421-438}
}