AR, MA and ARMA models

Size: px
Start display at page:

Download "AR, MA and ARMA models"

Transcription

1 AR, MA and AR by Hedibert Lopes P Based on Tsay s Analysis of Financial Time Series (3rd edition)

2 P 1 Stationarity P Outline

3 P Linear Time Series Analysis and Its Applications For basic concepts of linear time series analysis see Box, Jenkins, and Reinsel (1994, Chapters 2-3), and Brockwell and Davis (1996, Chapters 1-3) Shumway and Stoffer (2011, Chapters 1-3) The theories of linear time series discussed include stationarity dynamic dependence autocorrelation function modeling forecasting

4 P The econometric models introduced include (a) simple autoregressive models, (b) simple moving-average models, (b) mixed autoregressive moving-average models, (c) seasonal models, (d) unit-root nonstationarity, (e) regression models with time series errors, and (f) fractionally differenced models for long-range dependence.

5 Strict stationarity P The foundation of time series analysis is stationarity. A time series {r t } is said to be strictly stationary if the joint distribution of (r t1,..., r tk ) is identical to that of (r t1 +t,..., r tk +t) for all t, where k is an arbitrary positive integer and (t 1,..., t k ) is a collection of k positive integers. The joint distribution of (r t1,..., r tk ) is invariant under time shift. This is a very strong condition that is hard to verify empirically.

6 P Weak stationarity A time series {r t } is weakly stationary if both the mean of r t and the covariance between r t and r t l are time invariant, where l is an arbitrary integer. More specifically, {r t } is weakly stationary if (a) E(r t ) = µ, which is a constant, and (b) Cov(r t, r t l ) = γ l, which only depends on l. In practice, suppose that we have observed T data points {r t t = 1,..., T }. The weak stationarity implies that the time plot of the data would show that the T values fluctuate with constant variation around a fixed level. In applications, weak stationarity enables one to make inference concerning future observations (e.g., prediction).

7 P The covariance γ = Cov(r t, r t l ) is called the lag-l autocovariance of r t. It has two important properties: (a) γ 0 = V ar(r t ), and (b) γ l = γ l. The second property holds because Properties Cov(r t, r t ( l) ) = Cov(r t ( l), r t ) = Cov(r t+l, r t ) = Cov(r t1, r t1 l), where t 1 = t + l.

8 P Autocorrelation function The autocorrelation function of lag l is ρ l = Cov(r t, r t l ) V ar(rt )V ar(r t l ) = Cov(r t, r t l ) = γ l V ar(r t ) γ 0 where the property V ar(r t ) = V ar(r t l ) for a weakly stationary series is used. In general, the lag-l sample autocorrelation of r t is defined as ˆρ l = T t=l+1 (r t r)(r t l r) T t=1 (r t r) 2 0 l < T 1.

9 P Portmanteau Box and Pierce (1970) propose the Portmanteau statistic m Q (m) = T l=1 as a statistic for the null hypothesis H 0 : ρ 1 = = ρ m = 0 against the alternative hypothesis ˆρ 2 l H a : ρ i 0 for some i {1,..., m}. Under the assumption that {r t } is an iid sequence with certain moment conditions, Q (m) is asymptotically χ 2 m.

10 Ljung and Box (1978) P Ljung and Box (1978) modify the Q (m) statistic as below to increase the power of the in finite samples, Q(m) = T (T + 2) m l=1 ˆρ 2 l T l. The decision rule is to reject H 0 if Q(m) > q 2 α, where q 2 α denotes the 100(1 α)th percentile of a χ 2 m distribution.

11 P # Load data da = read.table(" header=true) # IBM simple returns and squared returns sibm=da[,2] sibm2 = sibm^2 # par(mfrow=c(1,2)) acf(sibm) acf(sibm2) # statistic Q(30) Box.(sibm,lag=30,type="Ljung") Box.(sibm2,lag=30,type="Ljung") > Box.(sibm,lag=30,type="Ljung") Box-Ljung data: sibm X-squared = , df = 30, p-value = > Box.(sibm2,lag=30,type="Ljung") Box-Ljung data: sibm2 X-squared = , df = 30, p-value < 2.2e-16

12 P A time series r t is called a white noise if {r t } is a sequence of independent and identically distributed random variables with finite mean and variance. All the s are zero. If r t is normally distributed with mean zero and variance σ 2, the series is called a Gaussian white noise.

13 P Linear Time Series A time series r t is said to be linear if it can be written as r t = µ + ψ i a t i, where µ is the mean of r t, ψ 0 = 1, and {a t } is white noise. i=0 a t denotes the new information at time t of the time series and is often referred to as the innovation or shock at time t. If r t is weakly stationary, we can obtain its mean and variance easily by using the independence of {a t } as E(r t ) = µ, where σ 2 a is the variance of a t. V (r t ) = σ 2 a ψi 2, i=0

14 P The lag-l aucovariance of r t is so γ l = Cov(r t, r t l ) ( ) = E ψ i a t i ψ j a t l j i=0 j=0 = E ψ i ψ j a t i a t l j = i=0 i,j=0 ψ j+l ψ j E(a 2 t l j ) = σ2 a ψ j ψ j+l, ρ l = γ l γ 0 = j=0 i=0 ψ iψ i+l 1 + i=1 ψ2 i Linear time series models are econometric and statistical models used to describe the pattern of the ψ weights of r t.

15 P AR(1) For instance, an stationary AR(1) model can be written as r t µ = φ 1 (r t 1 µ) + a t where {a t } is white noise. It is easy to see that r t µ = φ i 1a t i, and i=0 V (r t ) = 1 φ 2, 1 provided that φ 2 1 < 1. In other words, the weak stationarity of an AR(1) model implies that φ 1 < 1. Using φ 0 = (1 φ 1 )µ, one can rewrite a stationary AR(1) as σ2 a r t = φ 0 + φ 1 r t 1 + a t, with φ 1 measuring the persistence of the process.

16 P Autocovariance function The of a stationary AR(1) process is γ 0 = E[(r t µ)(r t µ)] = E[(φ 1 (r t 1 µ) + ɛ t )(r t µ)] = φ 1 E[(r t 1 µ)(r t µ)] + E(ɛ t (r t µ)] = φ 1 γ 1 + σa, 2 and γ l = E[(r t µ)(r t l µ)] = E[(φ 1 (r t 1 µ) + ɛ t )(r t l µ)] = φ 1 E[(r t 1 µ)(r t 1 l µ)] = φ 1 γ l 1 = φ l 1γ 0, for l = ±1, ±2,....

17 Autocorrelation function Stationarity From γ 1 = φ 1 γ 0 and γ 0 = φ 1 γ 1 + σ 2 a, it follows that P γ 0 = σ2 1 φ 2. 1 The of a (weakly) stationary AR(1) process is ρ l = φ l 1 l = ±1, ±2,... which decays exponentially with rate φ 1.

18 P An AR(2) model assumes the form where r t = φ 0 + φ 1 r t 1 + φ 2 r t 2 + a t, E(r t ) = µ = provided that φ 1 + φ 2 1. φ 0 1 φ 1 φ 2, AR(2) It is easy to see that γ 0 = φ 1 γ 1 + φ 2 γ 2 + σ 2 a, for l 0, γ l = φ 1 γ l 1 + φ 2 γ l 2, for l 0, ρ l = φ 1 ρ l 1 + φ 2 ρ l 2, l = ±2, 3,...

19 It is easy to see that Stationarity P and φ 1 ρ 1 = 1 φ 2 ρ 2 = φ 1 ρ 1 + φ 2, γ 0 = φ 1 ρ 1 γ 0 + φ 2 ρ 2 γ 0 + σ 2 a = (φ 1 ρ 1 + φ 2 (φ 1 ρ 1 + φ 2 )) γ 0 + σ 2 a = ( φ 1 (1 + φ 2 )ρ 1 + φ 2 2) γ0 + σa 2 ( ) φ 2 = 1 (1 + φ 2 ) + φ 2 2 γ 0 + σa 2 1 φ 2 such that { γ 0 = 1 φ 2 (1 + φ 2 )[(1 φ 2 2 ) φ2 1 ] } σ 2 a

20 P pdf(file="ar2-stationarityregion.pdf",width=7,height=7) phi1 <- seq(from = -2.5, to = 2.5, length = 51) plot(phi1,1+phi1,lty="dashed",type="l", xlab="",ylab="",cex.axis=.8,ylim=c(-1.5,1.5)) abline(a = -1, b = 0, lty="dashed") abline(a = 1, b = -1, lty="dashed") title(ylab=expression(phi[2]),xlab=expression(phi[1]),cex.lab=.8) polygon(x = phi1[6:46], y = 1-abs(phi1[6:46]), col="gray") lines(phi1,-phi1^2/4) text(0,-.5,expression(phi[2]<phi[1]^2/4),cex=.7) text(1.2,.5,expression(phi[2]>1-phi[1]),cex=.7) text(-1.75,.5,expression(phi[2]>1+phi[1]),cex=.7) points(1.75,-0.8,pch=16,col=1) points(0.9,0.05,pch=16,col=2) dev.off()

21 P Two sets of φ s Let us compute the for two cases: (φ 1, φ 2 ) = (1.75, 0.8) and (φ 1, φ 2 ) = (0.9, 0.05). φ φ2 > 1+φ1 φ2 < φ φ2 > 1 φ φ 1

22 Theoretical s P acf.hedi = function(k,phi1,phi2){ rhos = rep(0,k) rhos[1] = phi1/(1-phi2) rhos[2] = phi1*rhos[1]+phi2 for (l in 3:k) rhos[l] = phi1*rhos[l-1]+phi2*rhos[l-2] plot(0:k,c(1,rhos),type="h",xlab="lag",ylab="") title(substitute(paste(phi[1],"=",a,", ",phi[2],"=",b), list(a=phi1,b=phi2))) abline(h=0,lty=2) } pdf(file="ar2-acf.pdf",width=7,height=5) par(mfrow=c(1,2)) acf.hedi(100,1.75,-0.8) acf.hedi(150,0.9,0.05) dev.off()

23 Theoretical s φ 1 =1.75, φ 2 = 0.8 φ 1 =0.9, φ 2 =0.05 P Lag Lag

24 P Empirical s Let us simulate some data and compute the empirical s. acf1.hedi = function(n,k,phi1,phi2){ y = rep(0,2*n) for (t in 3:(2*n)) y[t] = phi1*y[t-1]+phi2*y[t-2]+rnorm(1,0,1) y = y[(n+1):(2*n)] acf(y,k) } pdf(file="ar2-acf-1.pdf",width=10,height=7) par(mfrow=c(2,2)) acf.hedi(100,1.75,-0.8) acf.hedi(150,0.9,0.05) set.seed(1234) acf1.hedi(10000,100,1.75,-0.8) acf1.hedi(10000,150,0.9,0.05) dev.off()

25 n = 10, 000 Theoretical vs Empirical φ 1=1.75, φ 2= 0.8 φ 1=0.9, φ 2=0.05 P Lag Lag Series y Series y Lag Lag

26 n = 1, 000 Theoretical vs Empirical φ 1=1.75, φ 2= 0.8 φ 1=0.9, φ 2=0.05 P Lag Lag Series y Series y Lag Lag

27 n = 500 Theoretical vs Empirical φ 1=1.75, φ 2= 0.8 φ 1=0.9, φ 2=0.05 P Lag Lag Series y Series y Lag Lag

28 n = 200 Theoretical vs Empirical φ 1=1.75, φ 2= 0.8 φ 1=0.9, φ 2=0.05 P Lag Lag Series y Series y Lag Lag

29 US real GNP P As an illustration, consider the quarterly growth rate of U.S. real gross national product (GNP), seasonally adjusted, from the second quarter of 1947 to the first quarter of Here we simply employ an AR(3) model for the data. Denoting the growth rate by r t the fitted model is r t = r t r t r t 3 + a t, with ˆσ a =

30 P Alternatively, r t 0.348r t r t r t 3 = a t, with the corresponding third-order difference equation ( B 0.179B B 3 ) = 0 or ( B)( B B 2 ) = 0 The first factor ( B) shows an exponentially decaying feature of the GNP.

31 P Business cycles The second factor ( B B 2 ) confirms the existence of stochastic business cycles. For an AR(2) model with a pair of complex characteristic roots, the average length of the stochastic cycles is 2π k = cos 1 [φ 1 /(2 φ 2 )] or k = quarters, which is about 3 years. Fact: If one uses a nonlinear model to separate U.S. economy into expansion and contraction periods, the data show that the average duration of contraction periods is about 3 quarters and that of expansion periods is about 12 quarters. The average duration of quarters is a compromise between the two separate durations. The periodic feature obtained here is common among growth rates of national economies. For example, similar features can be found for many OECD countries.

32 P R code gnp=scan(file=" # To create a time-series object gnp1=ts(gnp,frequency=4,start=c(1947,2)) par(mfrow=c(1,1)) plot(gnp1) points(gnp1,pch="*") # Find the AR order m1=ar(gnp,method="mle") m1$order m2=arima(gnp,order=c(3,0,0)) m2 # In R, intercept denotes the mean of the series. # Therefore, the constant term is obtained below: ( )* # Residual standard error sqrt(m2$sigma2) # Characteristic equation and solutions p1=c(1,-m2$coef[1:3]) roots = polyroot(p1) # Compute the absolute values of the solutions Mod(roots) [1] # To compute average length of business cycles: k=2*pi/acos( / )

33 P AR(p) The results of the AR(1) and AR(2) models can readily be generalized to the general AR(p) model: r t = φ 0 + φ 1 r t φ p r t p + a t, where p is a nonnegative integer and {a t } is white noise. The mean of a stationary series is φ 0 E(r t ) = 1 φ 1 φ p provided that the denominator is not zero. The associated characteristic equation of the model is 1 φ 1 x φ 2 x 2 φ p x p = 0. If all the solutions of this equation are greater than 1 in modulus, then the series r t is stationary.

34 P Partial The P of a stationary time series is a function of its and is a useful tool for determining the order p of an AR model. A simple, yet effective way to introduce P is to consider the following in consecutive orders: r t = φ 0,1 + φ 1,1 r t 1 + e 1,t, r t = φ 0,2 + φ 1,2 r t 1 + φ 2,2 r t 2 + e 2,t, r t = φ 0,3 + φ 1,3 r t 1 + φ 2,3 r t 2 + φ 3,3 r t 3 + e 3,t,. The estimate ˆφ i,i the ith equation is called the lag-i sample P of r t.

35 P For a stationary Gaussian AR(p) model, it can be shown that the sample P has the following properties: ˆφp,p φ p as T. ˆφl,l 0 for all l > p. V ( ˆφ l,l ) 1/T for l > p. These results say that, for an AR(p) series, the sample P cuts off at lag p.

36 P AIC The well-known Akaike information criterion (AIC) (Akaike, 1973) is defined as AIC = 2 T log(likelihood) + 2 (number of parameters), }{{}} T {{} goodness of fit penalty function where the likelihood function is evaluated at the maximum-likelihood estimates and T is the sample size. For a Gaussian AR(l) model, AIC reduces to AIC(l) = log( σ 2 l ) + 2l T where σ l 2 is the maximum-likelihood estimate of σa, 2 which is the variance of a t and T is the sample size.

37 Another commonly used criterion function is the SchwarzBayesian information criterion (BIC). BIC P For a Gaussian AR(l) model, the criterion is BIC(l) = log( σ 2 l ) + l log(t ) T The penalty for each parameter used is 2 for AIC and log(t ) for BIC. Thus, BIC tends to select a lower AR model when the sample size is moderate or large.

38 P For the AR(p) model, suppose that we are at the time index h and are interested in forecasting r h+l where l 1. The time index h is called the forecast origin and the positive integer l is the forecast horizon. Let ˆr h (l) be the forecast of r h+l using the minimum squared error loss function, i.e. E{[r h+l ˆr h (l)] 2 F h } min g E[(r h+l g) 2 F h ], where g is a function of the information available at time h (inclusive), that is, a function of F h. We referred to ˆr h (l) as the l-step ahead forecast of r t at the forecast origin h.

39 1-step-ahead forecast P It is easy to see that ˆr h (1) = E(r h+1 F h ) = φ 0 + and the associated forecast error is p φ i r h+1 i, i=1 and e h (1) = r h+1 ˆr h (1) = a h+1, V (e h (1)) = V (a h+1 ) = σ 2 a.

40 2-step-ahead forecast P Similarly, ˆr h (2) = φ 0 + φ 1ˆr h (1) + φ 2 r h + + φ p r h+2 p, with e h (2) = a h+2 + φ 1 a h+1 and V (e h (2)) = (1 + φ 2 1)σa. 2

41 Multistep-ahead forecast P In general, r h+l = φ 0 + and p φ i r h+l i + a h+l, i=1 ˆr h (l) = φ 0 + where ˆr h (i) = r h+i if i 0. p φ iˆr h (l i), i=1

42 P Mean reversion It can be shown that for a stationary AR(p) model, ˆr h (l) E(r t ) as l, meaning that for such a series long-term point forecast approaches its unconditional mean. This property is referred to as the mean reversion in the finance literature. For an AR(1) model, the speed of mean reversion is measured by the half-life defined as half-life = log(0.5) log( φ 1 ).

43 MA(1) model P There are several ways to introduce. One approach is to treat the model as a simple extension of white noise series. Another approach is to treat the model as an infinite-order AR model with some parameter constraints. We adopt the second approach.

44 P We may entertain, at least in theory, an AR model with infinite order as r t = φ 0 + φ 1 r t 1 + φ 2 r t a t. However, such an AR model is not realistic because it has infinite many parameters. One way to make the model practical is to assume that the coefficients φ i s satisfy some constraints so that they are determined by a finite number of parameters. A special case of this idea is r t = φ 0 θ 1 r t 1 θ 2 1r t 2 θ 3 1r t 3 + a t. where the coefficients depend on a single parameter θ 1 via φ i = θ1 i for i 1.

45 P Obviously, so r t + θ 1 r t 1 + θ1r 2 t 2 + θ1r 3 t 3 + = φ 0 + a t θ 1 (r t 1 + θ 1 r t 2 + θ1r 2 t 3 + θ1r 3 t 4 + ) = θ 1 (φ 0 + a t 1 ) r t = φ 0 (1 θ 1 ) + a t θ 1 a t 1, i.e., r t is a weighted average of shocks a t and a t 1. Therefore, the model is called an MA model of order 1 or MA(1) model for short.

46 P The general form of an MA(q) model is q r t = c 0 θ i a t i, i=1 MA(q) or r t = c 0 + (1 θ 1 B θ q B q )a t, where q > 0. Moving-average models are always weakly stationary because they are finite linear combinations of a white noise sequence for which the first two moments are time invariant. E(r t ) = c 0 V (r t ) = (1 + θ1 2 + θ θq)σ 2 a. 2

47 P of an MA(1) Assume that c 0 = 0 for simplicity. Then, r t l r t = r t l a t θ 1 r t l a t 1. Taking expectation, we obtain γ 1 = θ 1 σa 2 and γ l = 0, for l > 1. Since V (r t ) = (1 + θ1 2)σ2 a, it follows that ρ 0 = 1, ρ 1 = θ θ1 2, ρ l = 0, for l > 1.

48 P of an MA(2) For the MA(2) model, the autocorrelation coefficients are ρ 1 = θ 1 + θ 1 θ θ1 2 +, ρ 2 = θ2 2 Here the cuts off at lag 2. θ θ1 2 +, ρ l = 0, for l > 2. θ2 2 This property generalizes to other. For an MA(q) model, the lag-q is not zero, but ρ l = 0 for l > q. an MA(q) series is only linearly related to its first q-lagged values and hence is a finite-memory model.

49 Estimation Maximum-likelihood estimation is commonly used to estimate. There are two approaches for evaluating the likelihood function of an MA model. P The first approach assumes that a t = 0 for t 0, so a 1 = r 1 c 0, a 2 = r 2 c 0 + θ 1 a 1, etc. This approach is referred to as the conditional-likelihood method. The second approach treats a t = 0 for t 0, as additional parameters of the model and estimate them jointly with other parameters. This approach is referred to as the exact-likelihood method.

50 an MA(1) Stationarity P For the 1-step-ahead forecast of an MA(1) process, the model says r h+1 = c 0 + a h+1 θ 1 a h. Taking the conditional expectation, we have ˆr h (1) = E(r h+1 F h ) = c 0 θ 1 a h, e h (1) = r h+1 ˆr h (1) = a h+1 with V [e h (1)] = σ 2 a. Similarly, ˆr h (2) = E(r h+1 F h ) = c 0 e h (2) = r h+2 ˆr h (2) = a h+2 θ 1 a h+1 with V [e h (2)] = (1 + θ 2 1 )σ2 a.

51 an MA(2) P Similarly, for an MA(2) model, we have r h+l = c 0 + a h+l θ 1 a h+l 1 θ 2 a h+l 2, from which we obtain ˆr h (1) = c 0 θ 1 a h θ 2 a h 1, ˆr h (2) = c 0 θ 2 a h, ˆr h (l) = c 0, for l > 2.

52 P A brief summary of AR and is in order. We have discussed the following properties: For, is useful in specifying the order because cuts off at lag q for an MA(q) series. For, P is useful in order determination because P cuts off at lag p for an AR(p) process. An MA series is always stationary, but for an AR series to be stationary, all of its characteristic roots must be less than 1 in modulus. Carefully read Section 2.6 of Tsay (2010) about AR.

FE570 Financial Markets and Trading. Stevens Institute of Technology

FE570 Financial Markets and Trading. Stevens Institute of Technology FE570 Financial Markets and Trading Lecture 5. Linear Time Series Analysis and Its Applications (Ref. Joel Hasbrouck - Empirical Market Microstructure ) Steve Yang Stevens Institute of Technology 9/25/2012

More information

Prof. Dr. Roland Füss Lecture Series in Applied Econometrics Summer Term Introduction to Time Series Analysis

Prof. Dr. Roland Füss Lecture Series in Applied Econometrics Summer Term Introduction to Time Series Analysis Introduction to Time Series Analysis 1 Contents: I. Basics of Time Series Analysis... 4 I.1 Stationarity... 5 I.2 Autocorrelation Function... 9 I.3 Partial Autocorrelation Function (PACF)... 14 I.4 Transformation

More information

Autoregressive Moving Average (ARMA) Models and their Practical Applications

Autoregressive Moving Average (ARMA) Models and their Practical Applications Autoregressive Moving Average (ARMA) Models and their Practical Applications Massimo Guidolin February 2018 1 Essential Concepts in Time Series Analysis 1.1 Time Series and Their Properties Time series:

More information

Lecture Notes of Bus (Spring 2017) Analysis of Financial Time Series Ruey S. Tsay

Lecture Notes of Bus (Spring 2017) Analysis of Financial Time Series Ruey S. Tsay Lecture Notes of Bus 41202 (Spring 2017) Analysis of Financial Time Series Ruey S. Tsay Simple AR models: (Regression with lagged variables.) Motivating example: The growth rate of U.S. quarterly real

More information

Multivariate Time Series Analysis and Its Applications [Tsay (2005), chapter 8]

Multivariate Time Series Analysis and Its Applications [Tsay (2005), chapter 8] 1 Multivariate Time Series Analysis and Its Applications [Tsay (2005), chapter 8] Insights: Price movements in one market can spread easily and instantly to another market [economic globalization and internet

More information

Applied time-series analysis

Applied time-series analysis Robert M. Kunst robert.kunst@univie.ac.at University of Vienna and Institute for Advanced Studies Vienna October 18, 2011 Outline Introduction and overview Econometric Time-Series Analysis In principle,

More information

Stochastic Processes

Stochastic Processes Stochastic Processes Stochastic Process Non Formal Definition: Non formal: A stochastic process (random process) is the opposite of a deterministic process such as one defined by a differential equation.

More information

Week 5 Quantitative Analysis of Financial Markets Characterizing Cycles

Week 5 Quantitative Analysis of Financial Markets Characterizing Cycles Week 5 Quantitative Analysis of Financial Markets Characterizing Cycles Christopher Ting http://www.mysmu.edu/faculty/christophert/ Christopher Ting : christopherting@smu.edu.sg : 6828 0364 : LKCSB 5036

More information

Time Series Analysis -- An Introduction -- AMS 586

Time Series Analysis -- An Introduction -- AMS 586 Time Series Analysis -- An Introduction -- AMS 586 1 Objectives of time series analysis Data description Data interpretation Modeling Control Prediction & Forecasting 2 Time-Series Data Numerical data

More information

Multivariate Time Series

Multivariate Time Series Multivariate Time Series Notation: I do not use boldface (or anything else) to distinguish vectors from scalars. Tsay (and many other writers) do. I denote a multivariate stochastic process in the form

More information

STAT Financial Time Series

STAT Financial Time Series STAT 6104 - Financial Time Series Chapter 4 - Estimation in the time Domain Chun Yip Yau (CUHK) STAT 6104:Financial Time Series 1 / 46 Agenda 1 Introduction 2 Moment Estimates 3 Autoregressive Models (AR

More information

Review Session: Econometrics - CLEFIN (20192)

Review Session: Econometrics - CLEFIN (20192) Review Session: Econometrics - CLEFIN (20192) Part II: Univariate time series analysis Daniele Bianchi March 20, 2013 Fundamentals Stationarity A time series is a sequence of random variables x t, t =

More information

at least 50 and preferably 100 observations should be available to build a proper model

at least 50 and preferably 100 observations should be available to build a proper model III Box-Jenkins Methods 1. Pros and Cons of ARIMA Forecasting a) need for data at least 50 and preferably 100 observations should be available to build a proper model used most frequently for hourly or

More information

{ } Stochastic processes. Models for time series. Specification of a process. Specification of a process. , X t3. ,...X tn }

{ } Stochastic processes. Models for time series. Specification of a process. Specification of a process. , X t3. ,...X tn } Stochastic processes Time series are an example of a stochastic or random process Models for time series A stochastic process is 'a statistical phenomenon that evolves in time according to probabilistic

More information

Empirical Market Microstructure Analysis (EMMA)

Empirical Market Microstructure Analysis (EMMA) Empirical Market Microstructure Analysis (EMMA) Lecture 3: Statistical Building Blocks and Econometric Basics Prof. Dr. Michael Stein michael.stein@vwl.uni-freiburg.de Albert-Ludwigs-University of Freiburg

More information

Advanced Econometrics

Advanced Econometrics Advanced Econometrics Marco Sunder Nov 04 2010 Marco Sunder Advanced Econometrics 1/ 25 Contents 1 2 3 Marco Sunder Advanced Econometrics 2/ 25 Music Marco Sunder Advanced Econometrics 3/ 25 Music Marco

More information

Econometrics I: Univariate Time Series Econometrics (1)

Econometrics I: Univariate Time Series Econometrics (1) Econometrics I: Dipartimento di Economia Politica e Metodi Quantitativi University of Pavia Overview of the Lecture 1 st EViews Session VI: Some Theoretical Premises 2 Overview of the Lecture 1 st EViews

More information

Lecture 2: Univariate Time Series

Lecture 2: Univariate Time Series Lecture 2: Univariate Time Series Analysis: Conditional and Unconditional Densities, Stationarity, ARMA Processes Prof. Massimo Guidolin 20192 Financial Econometrics Spring/Winter 2017 Overview Motivation:

More information

Dynamic Time Series Regression: A Panacea for Spurious Correlations

Dynamic Time Series Regression: A Panacea for Spurious Correlations International Journal of Scientific and Research Publications, Volume 6, Issue 10, October 2016 337 Dynamic Time Series Regression: A Panacea for Spurious Correlations Emmanuel Alphonsus Akpan *, Imoh

More information

Time Series I Time Domain Methods

Time Series I Time Domain Methods Astrostatistics Summer School Penn State University University Park, PA 16802 May 21, 2007 Overview Filtering and the Likelihood Function Time series is the study of data consisting of a sequence of DEPENDENT

More information

Some Time-Series Models

Some Time-Series Models Some Time-Series Models Outline 1. Stochastic processes and their properties 2. Stationary processes 3. Some properties of the autocorrelation function 4. Some useful models Purely random processes, random

More information

Note: The primary reference for these notes is Enders (2004). An alternative and more technical treatment can be found in Hamilton (1994).

Note: The primary reference for these notes is Enders (2004). An alternative and more technical treatment can be found in Hamilton (1994). Chapter 4 Analysis of a Single Time Series Note: The primary reference for these notes is Enders (4). An alternative and more technical treatment can be found in Hamilton (994). Most data used in financial

More information

A time series is called strictly stationary if the joint distribution of every collection (Y t

A time series is called strictly stationary if the joint distribution of every collection (Y t 5 Time series A time series is a set of observations recorded over time. You can think for example at the GDP of a country over the years (or quarters) or the hourly measurements of temperature over a

More information

TIME SERIES ANALYSIS AND FORECASTING USING THE STATISTICAL MODEL ARIMA

TIME SERIES ANALYSIS AND FORECASTING USING THE STATISTICAL MODEL ARIMA CHAPTER 6 TIME SERIES ANALYSIS AND FORECASTING USING THE STATISTICAL MODEL ARIMA 6.1. Introduction A time series is a sequence of observations ordered in time. A basic assumption in the time series analysis

More information

A lecture on time series

A lecture on time series A lecture on time series Bernt Arne Ødegaard 15 November 2018 Contents 1 Survey of time series issues 1 1.1 Definition.............................. 2 1.2 Examples.............................. 2 1.3 Typical

More information

Time Series Models and Inference. James L. Powell Department of Economics University of California, Berkeley

Time Series Models and Inference. James L. Powell Department of Economics University of California, Berkeley Time Series Models and Inference James L. Powell Department of Economics University of California, Berkeley Overview In contrast to the classical linear regression model, in which the components of the

More information

Modelling using ARMA processes

Modelling using ARMA processes Modelling using ARMA processes Step 1. ARMA model identification; Step 2. ARMA parameter estimation Step 3. ARMA model selection ; Step 4. ARMA model checking; Step 5. forecasting from ARMA models. 33

More information

Midterm Suggested Solutions

Midterm Suggested Solutions CUHK Dept. of Economics Spring 2011 ECON 4120 Sung Y. Park Midterm Suggested Solutions Q1 (a) In time series, autocorrelation measures the correlation between y t and its lag y t τ. It is defined as. ρ(τ)

More information

University of Oxford. Statistical Methods Autocorrelation. Identification and Estimation

University of Oxford. Statistical Methods Autocorrelation. Identification and Estimation University of Oxford Statistical Methods Autocorrelation Identification and Estimation Dr. Órlaith Burke Michaelmas Term, 2011 Department of Statistics, 1 South Parks Road, Oxford OX1 3TG Contents 1 Model

More information

Problem Set 2: Box-Jenkins methodology

Problem Set 2: Box-Jenkins methodology Problem Set : Box-Jenkins methodology 1) For an AR1) process we have: γ0) = σ ε 1 φ σ ε γ0) = 1 φ Hence, For a MA1) process, p lim R = φ γ0) = 1 + θ )σ ε σ ε 1 = γ0) 1 + θ Therefore, p lim R = 1 1 1 +

More information

3. ARMA Modeling. Now: Important class of stationary processes

3. ARMA Modeling. Now: Important class of stationary processes 3. ARMA Modeling Now: Important class of stationary processes Definition 3.1: (ARMA(p, q) process) Let {ɛ t } t Z WN(0, σ 2 ) be a white noise process. The process {X t } t Z is called AutoRegressive-Moving-Average

More information

FORECASTING SUGARCANE PRODUCTION IN INDIA WITH ARIMA MODEL

FORECASTING SUGARCANE PRODUCTION IN INDIA WITH ARIMA MODEL FORECASTING SUGARCANE PRODUCTION IN INDIA WITH ARIMA MODEL B. N. MANDAL Abstract: Yearly sugarcane production data for the period of - to - of India were analyzed by time-series methods. Autocorrelation

More information

Time Series Analysis

Time Series Analysis Time Series Analysis Christopher Ting http://mysmu.edu.sg/faculty/christophert/ christopherting@smu.edu.sg Quantitative Finance Singapore Management University March 3, 2017 Christopher Ting Week 9 March

More information

Chapter 12: An introduction to Time Series Analysis. Chapter 12: An introduction to Time Series Analysis

Chapter 12: An introduction to Time Series Analysis. Chapter 12: An introduction to Time Series Analysis Chapter 12: An introduction to Time Series Analysis Introduction In this chapter, we will discuss forecasting with single-series (univariate) Box-Jenkins models. The common name of the models is Auto-Regressive

More information

Non-Stationary Time Series and Unit Root Testing

Non-Stationary Time Series and Unit Root Testing Econometrics II Non-Stationary Time Series and Unit Root Testing Morten Nyboe Tabor Course Outline: Non-Stationary Time Series and Unit Root Testing 1 Stationarity and Deviation from Stationarity Trend-Stationarity

More information

Introduction to Stochastic processes

Introduction to Stochastic processes Università di Pavia Introduction to Stochastic processes Eduardo Rossi Stochastic Process Stochastic Process: A stochastic process is an ordered sequence of random variables defined on a probability space

More information

Lecture 2: ARMA(p,q) models (part 2)

Lecture 2: ARMA(p,q) models (part 2) Lecture 2: ARMA(p,q) models (part 2) Florian Pelgrin University of Lausanne, École des HEC Department of mathematics (IMEA-Nice) Sept. 2011 - Jan. 2012 Florian Pelgrin (HEC) Univariate time series Sept.

More information

Unit root problem, solution of difference equations Simple deterministic model, question of unit root

Unit root problem, solution of difference equations Simple deterministic model, question of unit root Unit root problem, solution of difference equations Simple deterministic model, question of unit root (1 φ 1 L)X t = µ, Solution X t φ 1 X t 1 = µ X t = A + Bz t with unknown z and unknown A (clearly X

More information

AR(p) + I(d) + MA(q) = ARIMA(p, d, q)

AR(p) + I(d) + MA(q) = ARIMA(p, d, q) AR(p) + I(d) + MA(q) = ARIMA(p, d, q) Outline 1 4.1: Nonstationarity in the Mean 2 ARIMA Arthur Berg AR(p) + I(d)+ MA(q) = ARIMA(p, d, q) 2/ 19 Deterministic Trend Models Polynomial Trend Consider the

More information

Forecasting using R. Rob J Hyndman. 2.4 Non-seasonal ARIMA models. Forecasting using R 1

Forecasting using R. Rob J Hyndman. 2.4 Non-seasonal ARIMA models. Forecasting using R 1 Forecasting using R Rob J Hyndman 2.4 Non-seasonal ARIMA models Forecasting using R 1 Outline 1 Autoregressive models 2 Moving average models 3 Non-seasonal ARIMA models 4 Partial autocorrelations 5 Estimation

More information

Booth School of Business, University of Chicago Business 41914, Spring Quarter 2017, Mr. Ruey S. Tsay. Solutions to Midterm

Booth School of Business, University of Chicago Business 41914, Spring Quarter 2017, Mr. Ruey S. Tsay. Solutions to Midterm Booth School of Business, University of Chicago Business 41914, Spring Quarter 017, Mr Ruey S Tsay Solutions to Midterm Problem A: (51 points; 3 points per question) Answer briefly the following questions

More information

Econometric Forecasting

Econometric Forecasting Robert M. Kunst robert.kunst@univie.ac.at University of Vienna and Institute for Advanced Studies Vienna October 1, 2014 Outline Introduction Model-free extrapolation Univariate time-series models Trend

More information

Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications

Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications Prof. Massimo Guidolin 20192 Financial Econometrics Winter/Spring 2018 Overview Moving average processes Autoregressive

More information

Ch 6. Model Specification. Time Series Analysis

Ch 6. Model Specification. Time Series Analysis We start to build ARIMA(p,d,q) models. The subjects include: 1 how to determine p, d, q for a given series (Chapter 6); 2 how to estimate the parameters (φ s and θ s) of a specific ARIMA(p,d,q) model (Chapter

More information

Lecture 1: Fundamental concepts in Time Series Analysis (part 2)

Lecture 1: Fundamental concepts in Time Series Analysis (part 2) Lecture 1: Fundamental concepts in Time Series Analysis (part 2) Florian Pelgrin University of Lausanne, École des HEC Department of mathematics (IMEA-Nice) Sept. 2011 - Jan. 2012 Florian Pelgrin (HEC)

More information

Econometrics of Panel Data

Econometrics of Panel Data Econometrics of Panel Data Jakub Mućk Meeting # 9 Jakub Mućk Econometrics of Panel Data Meeting # 9 1 / 22 Outline 1 Time series analysis Stationarity Unit Root Tests for Nonstationarity 2 Panel Unit Root

More information

Multivariate Time Series: VAR(p) Processes and Models

Multivariate Time Series: VAR(p) Processes and Models Multivariate Time Series: VAR(p) Processes and Models A VAR(p) model, for p > 0 is X t = φ 0 + Φ 1 X t 1 + + Φ p X t p + A t, where X t, φ 0, and X t i are k-vectors, Φ 1,..., Φ p are k k matrices, with

More information

TIME SERIES ANALYSIS. Forecasting and Control. Wiley. Fifth Edition GWILYM M. JENKINS GEORGE E. P. BOX GREGORY C. REINSEL GRETA M.

TIME SERIES ANALYSIS. Forecasting and Control. Wiley. Fifth Edition GWILYM M. JENKINS GEORGE E. P. BOX GREGORY C. REINSEL GRETA M. TIME SERIES ANALYSIS Forecasting and Control Fifth Edition GEORGE E. P. BOX GWILYM M. JENKINS GREGORY C. REINSEL GRETA M. LJUNG Wiley CONTENTS PREFACE TO THE FIFTH EDITION PREFACE TO THE FOURTH EDITION

More information

Module 3. Descriptive Time Series Statistics and Introduction to Time Series Models

Module 3. Descriptive Time Series Statistics and Introduction to Time Series Models Module 3 Descriptive Time Series Statistics and Introduction to Time Series Models Class notes for Statistics 451: Applied Time Series Iowa State University Copyright 2015 W Q Meeker November 11, 2015

More information

Econometría 2: Análisis de series de Tiempo

Econometría 2: Análisis de series de Tiempo Econometría 2: Análisis de series de Tiempo Karoll GOMEZ kgomezp@unal.edu.co http://karollgomez.wordpress.com Segundo semestre 2016 II. Basic definitions A time series is a set of observations X t, each

More information

Univariate ARIMA Models

Univariate ARIMA Models Univariate ARIMA Models ARIMA Model Building Steps: Identification: Using graphs, statistics, ACFs and PACFs, transformations, etc. to achieve stationary and tentatively identify patterns and model components.

More information

Univariate Time Series Analysis; ARIMA Models

Univariate Time Series Analysis; ARIMA Models Econometrics 2 Fall 24 Univariate Time Series Analysis; ARIMA Models Heino Bohn Nielsen of4 Outline of the Lecture () Introduction to univariate time series analysis. (2) Stationarity. (3) Characterizing

More information

Estimation and application of best ARIMA model for forecasting the uranium price.

Estimation and application of best ARIMA model for forecasting the uranium price. Estimation and application of best ARIMA model for forecasting the uranium price. Medeu Amangeldi May 13, 2018 Capstone Project Superviser: Dongming Wei Second reader: Zhenisbek Assylbekov Abstract This

More information

MODELING INFLATION RATES IN NIGERIA: BOX-JENKINS APPROACH. I. U. Moffat and A. E. David Department of Mathematics & Statistics, University of Uyo, Uyo

MODELING INFLATION RATES IN NIGERIA: BOX-JENKINS APPROACH. I. U. Moffat and A. E. David Department of Mathematics & Statistics, University of Uyo, Uyo Vol.4, No.2, pp.2-27, April 216 MODELING INFLATION RATES IN NIGERIA: BOX-JENKINS APPROACH I. U. Moffat and A. E. David Department of Mathematics & Statistics, University of Uyo, Uyo ABSTRACT: This study

More information

Econ 623 Econometrics II Topic 2: Stationary Time Series

Econ 623 Econometrics II Topic 2: Stationary Time Series 1 Introduction Econ 623 Econometrics II Topic 2: Stationary Time Series In the regression model we can model the error term as an autoregression AR(1) process. That is, we can use the past value of the

More information

Stationary Stochastic Time Series Models

Stationary Stochastic Time Series Models Stationary Stochastic Time Series Models When modeling time series it is useful to regard an observed time series, (x 1,x,..., x n ), as the realisation of a stochastic process. In general a stochastic

More information

Econometrics II Heij et al. Chapter 7.1

Econometrics II Heij et al. Chapter 7.1 Chapter 7.1 p. 1/2 Econometrics II Heij et al. Chapter 7.1 Linear Time Series Models for Stationary data Marius Ooms Tinbergen Institute Amsterdam Chapter 7.1 p. 2/2 Program Introduction Modelling philosophy

More information

Quantitative Finance I

Quantitative Finance I Quantitative Finance I Linear AR and MA Models (Lecture 4) Winter Semester 01/013 by Lukas Vacha * If viewed in.pdf format - for full functionality use Mathematica 7 (or higher) notebook (.nb) version

More information

Chapter 2: Unit Roots

Chapter 2: Unit Roots Chapter 2: Unit Roots 1 Contents: Lehrstuhl für Department Empirische of Wirtschaftsforschung Empirical Research and undeconometrics II. Unit Roots... 3 II.1 Integration Level... 3 II.2 Nonstationarity

More information

Stat 248 Lab 2: Stationarity, More EDA, Basic TS Models

Stat 248 Lab 2: Stationarity, More EDA, Basic TS Models Stat 248 Lab 2: Stationarity, More EDA, Basic TS Models Tessa L. Childers-Day February 8, 2013 1 Introduction Today s section will deal with topics such as: the mean function, the auto- and cross-covariance

More information

Lecture 7: Model Building Bus 41910, Time Series Analysis, Mr. R. Tsay

Lecture 7: Model Building Bus 41910, Time Series Analysis, Mr. R. Tsay Lecture 7: Model Building Bus 41910, Time Series Analysis, Mr R Tsay An effective procedure for building empirical time series models is the Box-Jenkins approach, which consists of three stages: model

More information

STAT 443 Final Exam Review. 1 Basic Definitions. 2 Statistical Tests. L A TEXer: W. Kong

STAT 443 Final Exam Review. 1 Basic Definitions. 2 Statistical Tests. L A TEXer: W. Kong STAT 443 Final Exam Review L A TEXer: W Kong 1 Basic Definitions Definition 11 The time series {X t } with E[X 2 t ] < is said to be weakly stationary if: 1 µ X (t) = E[X t ] is independent of t 2 γ X

More information

Non-Stationary Time Series and Unit Root Testing

Non-Stationary Time Series and Unit Root Testing Econometrics II Non-Stationary Time Series and Unit Root Testing Morten Nyboe Tabor Course Outline: Non-Stationary Time Series and Unit Root Testing 1 Stationarity and Deviation from Stationarity Trend-Stationarity

More information

Lecture 5: Unit Roots, Cointegration and Error Correction Models The Spurious Regression Problem

Lecture 5: Unit Roots, Cointegration and Error Correction Models The Spurious Regression Problem Lecture 5: Unit Roots, Cointegration and Error Correction Models The Spurious Regression Problem Prof. Massimo Guidolin 20192 Financial Econometrics Winter/Spring 2018 Overview Stochastic vs. deterministic

More information

LECTURES 2-3 : Stochastic Processes, Autocorrelation function. Stationarity.

LECTURES 2-3 : Stochastic Processes, Autocorrelation function. Stationarity. LECTURES 2-3 : Stochastic Processes, Autocorrelation function. Stationarity. Important points of Lecture 1: A time series {X t } is a series of observations taken sequentially over time: x t is an observation

More information

Introduction to ARMA and GARCH processes

Introduction to ARMA and GARCH processes Introduction to ARMA and GARCH processes Fulvio Corsi SNS Pisa 3 March 2010 Fulvio Corsi Introduction to ARMA () and GARCH processes SNS Pisa 3 March 2010 1 / 24 Stationarity Strict stationarity: (X 1,

More information

ECON 616: Lecture 1: Time Series Basics

ECON 616: Lecture 1: Time Series Basics ECON 616: Lecture 1: Time Series Basics ED HERBST August 30, 2017 References Overview: Chapters 1-3 from Hamilton (1994). Technical Details: Chapters 2-3 from Brockwell and Davis (1987). Intuition: Chapters

More information

Lecture 4a: ARMA Model

Lecture 4a: ARMA Model Lecture 4a: ARMA Model 1 2 Big Picture Most often our goal is to find a statistical model to describe real time series (estimation), and then predict the future (forecasting) One particularly popular model

More information

Chapter 8: Model Diagnostics

Chapter 8: Model Diagnostics Chapter 8: Model Diagnostics Model diagnostics involve checking how well the model fits. If the model fits poorly, we consider changing the specification of the model. A major tool of model diagnostics

More information

Comment about AR spectral estimation Usually an estimate is produced by computing the AR theoretical spectrum at (ˆφ, ˆσ 2 ). With our Monte Carlo

Comment about AR spectral estimation Usually an estimate is produced by computing the AR theoretical spectrum at (ˆφ, ˆσ 2 ). With our Monte Carlo Comment aout AR spectral estimation Usually an estimate is produced y computing the AR theoretical spectrum at (ˆφ, ˆσ 2 ). With our Monte Carlo simulation approach, for every draw (φ,σ 2 ), we can compute

More information

Nonlinear time series

Nonlinear time series Based on the book by Fan/Yao: Nonlinear Time Series Robert M. Kunst robert.kunst@univie.ac.at University of Vienna and Institute for Advanced Studies Vienna October 27, 2009 Outline Characteristics of

More information

ECON/FIN 250: Forecasting in Finance and Economics: Section 6: Standard Univariate Models

ECON/FIN 250: Forecasting in Finance and Economics: Section 6: Standard Univariate Models ECON/FIN 250: Forecasting in Finance and Economics: Section 6: Standard Univariate Models Patrick Herb Brandeis University Spring 2016 Patrick Herb (Brandeis University) Standard Univariate Models ECON/FIN

More information

Vector autoregressions, VAR

Vector autoregressions, VAR 1 / 45 Vector autoregressions, VAR Chapter 2 Financial Econometrics Michael Hauser WS17/18 2 / 45 Content Cross-correlations VAR model in standard/reduced form Properties of VAR(1), VAR(p) Structural VAR,

More information

Box-Jenkins ARIMA Advanced Time Series

Box-Jenkins ARIMA Advanced Time Series Box-Jenkins ARIMA Advanced Time Series www.realoptionsvaluation.com ROV Technical Papers Series: Volume 25 Theory In This Issue 1. Learn about Risk Simulator s ARIMA and Auto ARIMA modules. 2. Find out

More information

LATVIAN GDP: TIME SERIES FORECASTING USING VECTOR AUTO REGRESSION

LATVIAN GDP: TIME SERIES FORECASTING USING VECTOR AUTO REGRESSION LATVIAN GDP: TIME SERIES FORECASTING USING VECTOR AUTO REGRESSION BEZRUCKO Aleksandrs, (LV) Abstract: The target goal of this work is to develop a methodology of forecasting Latvian GDP using ARMA (AutoRegressive-Moving-Average)

More information

Topic 4 Unit Roots. Gerald P. Dwyer. February Clemson University

Topic 4 Unit Roots. Gerald P. Dwyer. February Clemson University Topic 4 Unit Roots Gerald P. Dwyer Clemson University February 2016 Outline 1 Unit Roots Introduction Trend and Difference Stationary Autocorrelations of Series That Have Deterministic or Stochastic Trends

More information

Econ 424 Time Series Concepts

Econ 424 Time Series Concepts Econ 424 Time Series Concepts Eric Zivot January 20 2015 Time Series Processes Stochastic (Random) Process { 1 2 +1 } = { } = sequence of random variables indexed by time Observed time series of length

More information

Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications

Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications Lecture 3: Autoregressive Moving Average (ARMA) Models and their Practical Applications Prof. Massimo Guidolin 20192 Financial Econometrics Winter/Spring 2018 Overview Moving average processes Autoregressive

More information

STAT 248: EDA & Stationarity Handout 3

STAT 248: EDA & Stationarity Handout 3 STAT 248: EDA & Stationarity Handout 3 GSI: Gido van de Ven September 17th, 2010 1 Introduction Today s section we will deal with the following topics: the mean function, the auto- and crosscovariance

More information

TMA4285 December 2015 Time series models, solution.

TMA4285 December 2015 Time series models, solution. Norwegian University of Science and Technology Department of Mathematical Sciences Page of 5 TMA4285 December 205 Time series models, solution. Problem a) (i) The slow decay of the ACF of z t suggest that

More information

Econometrics of financial markets, -solutions to seminar 1. Problem 1

Econometrics of financial markets, -solutions to seminar 1. Problem 1 Econometrics of financial markets, -solutions to seminar 1. Problem 1 a) Estimate with OLS. For any regression y i α + βx i + u i for OLS to be unbiased we need cov (u i,x j )0 i, j. For the autoregressive

More information

Econ 423 Lecture Notes: Additional Topics in Time Series 1

Econ 423 Lecture Notes: Additional Topics in Time Series 1 Econ 423 Lecture Notes: Additional Topics in Time Series 1 John C. Chao April 25, 2017 1 These notes are based in large part on Chapter 16 of Stock and Watson (2011). They are for instructional purposes

More information

Booth School of Business, University of Chicago Business 41914, Spring Quarter 2017, Mr. Ruey S. Tsay Midterm

Booth School of Business, University of Chicago Business 41914, Spring Quarter 2017, Mr. Ruey S. Tsay Midterm Booth School of Business, University of Chicago Business 41914, Spring Quarter 2017, Mr. Ruey S. Tsay Midterm Chicago Booth Honor Code: I pledge my honor that I have not violated the Honor Code during

More information

Lab: Box-Jenkins Methodology - US Wholesale Price Indicator

Lab: Box-Jenkins Methodology - US Wholesale Price Indicator Lab: Box-Jenkins Methodology - US Wholesale Price Indicator In this lab we explore the Box-Jenkins methodology by applying it to a time-series data set comprising quarterly observations of the US Wholesale

More information

Ch 8. MODEL DIAGNOSTICS. Time Series Analysis

Ch 8. MODEL DIAGNOSTICS. Time Series Analysis Model diagnostics is concerned with testing the goodness of fit of a model and, if the fit is poor, suggesting appropriate modifications. We shall present two complementary approaches: analysis of residuals

More information

Non-Stationary Time Series and Unit Root Testing

Non-Stationary Time Series and Unit Root Testing Econometrics II Non-Stationary Time Series and Unit Root Testing Morten Nyboe Tabor Course Outline: Non-Stationary Time Series and Unit Root Testing 1 Stationarity and Deviation from Stationarity Trend-Stationarity

More information

ITSM-R Reference Manual

ITSM-R Reference Manual ITSM-R Reference Manual George Weigt February 11, 2018 1 Contents 1 Introduction 3 1.1 Time series analysis in a nutshell............................... 3 1.2 White Noise Variance.....................................

More information

7. Forecasting with ARIMA models

7. Forecasting with ARIMA models 7. Forecasting with ARIMA models 309 Outline: Introduction The prediction equation of an ARIMA model Interpreting the predictions Variance of the predictions Forecast updating Measuring predictability

More information

1 Linear Difference Equations

1 Linear Difference Equations ARMA Handout Jialin Yu 1 Linear Difference Equations First order systems Let {ε t } t=1 denote an input sequence and {y t} t=1 sequence generated by denote an output y t = φy t 1 + ε t t = 1, 2,... with

More information

Lecture 6: Univariate Volatility Modelling: ARCH and GARCH Models

Lecture 6: Univariate Volatility Modelling: ARCH and GARCH Models Lecture 6: Univariate Volatility Modelling: ARCH and GARCH Models Prof. Massimo Guidolin 019 Financial Econometrics Winter/Spring 018 Overview ARCH models and their limitations Generalized ARCH models

More information

Chapter 4: Models for Stationary Time Series

Chapter 4: Models for Stationary Time Series Chapter 4: Models for Stationary Time Series Now we will introduce some useful parametric models for time series that are stationary processes. We begin by defining the General Linear Process. Let {Y t

More information

APPLIED ECONOMETRIC TIME SERIES 4TH EDITION

APPLIED ECONOMETRIC TIME SERIES 4TH EDITION APPLIED ECONOMETRIC TIME SERIES 4TH EDITION Chapter 2: STATIONARY TIME-SERIES MODELS WALTER ENDERS, UNIVERSITY OF ALABAMA Copyright 2015 John Wiley & Sons, Inc. Section 1 STOCHASTIC DIFFERENCE EQUATION

More information

Reliability and Risk Analysis. Time Series, Types of Trend Functions and Estimates of Trends

Reliability and Risk Analysis. Time Series, Types of Trend Functions and Estimates of Trends Reliability and Risk Analysis Stochastic process The sequence of random variables {Y t, t = 0, ±1, ±2 } is called the stochastic process The mean function of a stochastic process {Y t} is the function

More information

ARIMA Models. Jamie Monogan. January 16, University of Georgia. Jamie Monogan (UGA) ARIMA Models January 16, / 27

ARIMA Models. Jamie Monogan. January 16, University of Georgia. Jamie Monogan (UGA) ARIMA Models January 16, / 27 ARIMA Models Jamie Monogan University of Georgia January 16, 2018 Jamie Monogan (UGA) ARIMA Models January 16, 2018 1 / 27 Objectives By the end of this meeting, participants should be able to: Argue why

More information

ARIMA Modelling and Forecasting

ARIMA Modelling and Forecasting ARIMA Modelling and Forecasting Economic time series often appear nonstationary, because of trends, seasonal patterns, cycles, etc. However, the differences may appear stationary. Δx t x t x t 1 (first

More information

Part II. Time Series

Part II. Time Series Part II Time Series 12 Introduction This Part is mainly a summary of the book of Brockwell and Davis (2002). Additionally the textbook Shumway and Stoffer (2010) can be recommended. 1 Our purpose is to

More information

5 Autoregressive-Moving-Average Modeling

5 Autoregressive-Moving-Average Modeling 5 Autoregressive-Moving-Average Modeling 5. Purpose. Autoregressive-moving-average (ARMA models are mathematical models of the persistence, or autocorrelation, in a time series. ARMA models are widely

More information

Gaussian processes. Basic Properties VAG002-

Gaussian processes. Basic Properties VAG002- Gaussian processes The class of Gaussian processes is one of the most widely used families of stochastic processes for modeling dependent data observed over time, or space, or time and space. The popularity

More information

2. An Introduction to Moving Average Models and ARMA Models

2. An Introduction to Moving Average Models and ARMA Models . An Introduction to Moving Average Models and ARMA Models.1 White Noise. The MA(1) model.3 The MA(q) model..4 Estimation and forecasting of MA models..5 ARMA(p,q) models. The Moving Average (MA) models

More information

Univariate, Nonstationary Processes

Univariate, Nonstationary Processes Univariate, Nonstationary Processes Jamie Monogan University of Georgia March 20, 2018 Jamie Monogan (UGA) Univariate, Nonstationary Processes March 20, 2018 1 / 14 Objectives By the end of this meeting,

More information