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.
Since the seminal paper of (Sims 1980), 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 (Auerbach and Gorodnichenko 2013).
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 (Jordà 2005). 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 (Jordà 2005). Although the latter argument has been
questioned by (Kilian and Kim 2011), the recent study by (Brugnolini 2018) shows
equal and even better performance of LPs when the lag lengths for each
forecast horizon are adequately fixed. Yet, (Plagborg-Møller and Wolf 2019) 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.
Since their introduction in 2005, LPs have been broadly applied to investigate, among others, the macroeconomic effects of oil price shocks (Hamilton 2011); state-dependent government spending multipliers (Auerbach and Gorodnichenko 2012; Auerbach and Gorodnichenko 2013; Owyang et al. 2013); the effects of monetary policy on financial markets and economic aggregates (Tenreyro and Thwaites 2016; Swanson 2017; Jordà et al. 2019); and the link between credit growth, monetary policy, house prices, and financial stability (Favara and Imbs 2015; Jordà et al. 2015; Jordà and Taylor 2016). 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 (Barnichon and Brownlees 2019). 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 (Garı́n et al. 2019). The vars package by (Pfaff 2008) only allows estimating impulse response functions that are based on the traditional SVAR approach.
As a remedy, this paper introduces lpirfs (Adämmer 2019), 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.
An SVAR with
which more concisely becomes the following:
The residuals
The SVAR in reduced form (henceforth VAR) equals:
where
and
The coefficient matrix
Given that the covariance matrix of
where the matrix
In his pioneering paper, (Jordà 2005) proposed an alternative approach to estimate impulse responses. His first step consists of ordinary least squares (OLS) regressions for each forecast horizon:
where
where
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, (Auerbach and Gorodnichenko 2012) proposed computing state probabilities with a logistic function that allows using all observations for the estimations. The logistic function equals the following:
where
(Auerbach and Gorodnichenko 2012) used the values of the transition function at
where
with
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, (Ramey and Zubairy 2018) 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:
where
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 (Auerbach and Gorodnichenko 2013), (Owyang et al. 2013), and (Jordà et al. 2015), among others. The general equation for panel data is the following:
where
lpirfs enables estimating all of the above models and specifications. The main functions of the package are the following:
lp_lin()
and lp_nl()
, which estimate linear and nonlinear
impulse responses based on structural VARs,lp_lin_iv()
and lp_nl_iv()
, which estimate linear and nonlinear
impulse responses for a shock that has been identified outside of
the VAR, andlp_lin_panel()
and lp_nl_panel()
, which estimate linear and
nonlinear impulse responses for panel data.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 (Eddelbuettel et al. 2011), making the computations very fast. The functions for panel data are based on the well-established plm package by (Croissant and Millo 2008). 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 (Newey and West 1987). By default, lpirfs increases
the truncation parameter with the number of horizons 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.
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 (Newey and West 1987). | ||||
nw_lag | Option to manually fix the truncation parameter. | ||||
nw_prewhite | Option for pre-whitening (Andrews and Monahan 1992). | ||||
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 |
||
lag_switching | - | - | Option to lag the values of the logistic function |
||
use_logistic | - | - | Option to use the logistic function. See Eq. (5). | ||
use_hp | - | - | Option to use the filter by (Hodrick and Prescott 1997). | ||
lambda | - | - | Value of |
||
gamma | - | - | Value of |
||
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
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 (Hodrick and Prescott 1997) to obtain |
||
lag_switching | - | Option to lag the values of the logistic function |
||
lambda | - | - | Value of |
|
gamma | - | - | Value of |
|
hor | Number of horizons for impulse responses. |
The table compares the options for lp_lin_panel()
and lp_nl_panel()
.
The symbol
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 (Jordà 2005) and (Ramey and Zubairy 2018). 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.
The following code replicates parts of Figure 5 in Jordà (2005 176).
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.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
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 (Jordà 2005) example of the first horizon for the first identified shock (output gap).
The example above only estimates impulse responses for the linear case, but (Jordà 2005) 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. (Jordà 2005) 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 (Jordà 2005), 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
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.
In this section, I replicate the empirical results by (Ramey and Zubairy 2018). The authors, among others, re-evaluate the findings by (Auerbach and Gorodnichenko 2012), who argued that government spending multipliers are more pronounced during economic recession than during economic expansion. (Auerbach and Gorodnichenko 2012) applied a smooth transition VAR (STVAR) to estimate state-dependent fiscal multipliers. (Ramey and Zubairy 2018), 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 Ramey and Zubairy (2018 35). 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 (Blanchard and Perotti 2002). The absolute values of the figures
differ because (Ramey and Zubairy 2018) multiplied the log output response by a
conversion factor of
# --- 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
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.
#--- 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
The following example uses the Hodrick–Prescott filter to decompose the
log-GDP time series for each country to obtain the standardized variable
# --- 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
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 (Jordà 2005) 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.
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 vignette
of lpirfs.
(Plagborg-Møller and Wolf 2019) 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 Jordà (2005 176). 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
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
Figure 7 shows the empirical results. Each
column corresponds to one choice of
To use the switching function in
Eq. (5), one must provide a
standardized variable
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.
CausalInference, Econometrics, Finance, HighPerformanceComputing, MixedModels, NumericalMathematics, SpatioTemporal, TimeSeries
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.
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 ...".
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} }