2. Volatility Models. 2.1 Background. Below are autocorrelations of the log-index.

Size: px
Start display at page:

Download "2. Volatility Models. 2.1 Background. Below are autocorrelations of the log-index."

Transcription

1 2. Volatility Models 2.1 Background Example 2.1: Consider the following daily close-toclose SP500 values [January 3, 2000 to March 27, 2009] Below are autocorrelations of the log-index. Obviously the persistence of autocorrelations indicate that the series is integrated (see definition below). The autocorrelations of the return series suggest that the returns might be stationary SP500 Daily Returns and Index Values SP500 Index Autocorrelations Index (log) ACF Lag SP500 Return Autocorrelations Years Return (%) ACF Lag: ac p-val Lag 1 2

2 Definition 2.1: Time series y t, t =1,...,T is covariance stationary if Definition 2.3: Times series y t is said to be integrated of order 1, if it is of the form (1) E[y t ] = μ, for all t Cov[y t,y t+k ] = γ k, for all t Var[y t ] = γ 0 (< ), for all t (3) (1 L)y t = δ + ψ(l)u t, denoted as y t I(1), where (4) ψ(l) =1+ψ 1 L + ψ 2 L 2 + ψ 3 L 3 + Any series that are not stationary are said to be nonstationary. Definition 2.2:Time series u t is a white noise process if E[u t ] = μ, for all t such that j=1 ψ j <, ψ(1) 0, roots of ψ(z) =0 are outside the unit circle [or the polynomial (4) is of order zero], and u t is a white noise series with mean zero and variance σu 2. (2) Cov[u t,u s ] = 0, for all t s Var[u t ] = σ 2 u We denote u t WN(μ, σ 2 u). <, for all t. Remark 2.1: Usually it is assumed in (2) that μ =0. Remark 2.2: A WN-process is obviously stationary. 3 4

3 Remark 2.3: If a time series process is of the form of the right hand side of (4), i.e., (5) x t = δ + ψ(l)u t, where ψ(l) satisfies the conditions of Def 1.3, it can be shown that x t is stationary. We denote x t I(0), i.e, integrated of order zero. Remark 2.4: The assumption ψ(1) 0 is important. It rules out for example trend stationary series (6) y t = α + βt + ψ(l)u t. Because E[y t ]=α + βt, y t is nonstationary. However, (7) (1 L)y t = β + ψ(l)u t, where (8) ψ(l) =(1 L)ψ(L). Now, although, (1 L)y t is stationary, however, ψ(1) = (1 1)ψ(1)=0, Example 2.2: (Example 2.1 continued) Below are results for ARMA(1, 1). R (stats::arima): AR(1) > arfit <- arima(x = spr, order = c(1,0,q)); > print(arfit); > tsdiag(arfit) Coefficients: ar1 ma1 intercept s.e sigma^2 estimated as 1.954: log likelihood = , aic = T = 2320, R2 = Residuals: LB p-value which does not satisfy the rule in Definition 1.3, and hence a trend stationary series is not I(1). 5 6

4 Residual autocorrelations for ARMA(1, 1): Standardized Residuals Time ACF of Residuals The residual autocorrelations and related Q-statistics indicate some, although small autocorrelation left to the series. The autocorrelations of the squared residuals strongly suggest that there is still left time dependency into the series. ARMA(1,1) residuals squared ACF Lag p values for Ljung-Box statistic p value ACF Lag The dependency is nonlinear by nature, however lag Lag ac p-val

5 Also a casual analysis with rolling k = 22-day ( month of trading days) mean volatility (annualized standard deviation) (9) (10) t = k,...t m t = 1 k s t = 2521 k t u=t k+1 t u=t k+1 r u, (r u m t ) 2, SP500 daily returns and 22-day rolling average Because squared observations are the building blocks of the variance of the series, the results suggest that the variation (volatility) of the series is time dependent. This leads to the so called ARCH-family of models. Note: Volatility not directly observable!! Methods: Return (%) a) Implied volatility b) Realized volatility c) Econometric modeling (stochastic volatility, ARCH) SP500 absolute returns and 22-day rolling volatility Volatility (%p.a) sqrt(252) x abs ret 22 day volat Day The inventor of this modeling approach is Robert F. Engle (1982). Autoregressive conditional heteroscedasticity with estimates of the variance of United Kingdom inflation. Econometrica, 50,

6 2.2. Conditional Heteroscedasticity ARCH-models The general setup for ARCH models is (11) y t = x tθ + u t with x t =(x 1t,x 2t,...,x pt ), θ =(θ 1,θ 2,...,θ p ), t =1,...,T, and (12) u t F t 1 N(0,σ 2 t ), where F t is the information available at time t (usually the past values of u t ; u 1,...,u t 1 ), and Furthermore, it is assumed that ω>0, α i 0 for all i and α α q < 1. For short it is denoted u t ARCH(q). This reminds essentially an AR(q) process for the squared residuals, because defining ν t = u 2 t σ2 t, we can write u 2 t = ω + α 1u 2 t 1 + α 2u 2 t α qu 2 t q + ν t. (14) Nevertheless, the error term ν t is time heteroscedastic, which implies that the conventional estimation procedure used in AR-estimation does not produce optimal results here. σ 2 t = Var(u t F t 1 )=ω + α 1 u 2 t 1 + α 2u 2 t α qu 2 t q. (13) 11 12

7 Properties of ARCH-processes Consider (for the sake of simplicity) ARCH(1) process (15) σt 2 = ω + αu 2 t 1 with ω > 0 and 0 α < 1 and u t u t 1 N(0,σt 2). (a) u t is white noise (i) Constant mean (zero): (16) E[u t ]=E[E t 1 [u t ]]=E[0]=0. }{{} =0 Note E t 1 [u t ] = E[u t F t 1 ], the conditional expectation given information up to time t 1. (ii) Constant variance: Using again the law of iterated expectations, we get (18) Var[u t ] = E[u 2 t ]=E [ E t 1 [u 2 t ]] = E[σ 2 t ]=E[ω + αu2 t 1 ] = ω + αe[u 2 t 1 ]. = ω(1 + α + α α n ) + α n+1 E[u 2 t n 1 ] }{{} 0, as n = ω ( lim n ni=0 α i) = ω 1 α. (iii) Autocovariances: Exercise, show that autocovariances are zero, i.e., E[u t u t+k ]=0 for all k 0. (Hint: use the law of iterated expectations.) The law of iterated expectations: Consider time points t1 <t 2 such that F t1 F t2, then for any t>t 2 (17) E t1 [E t2 [u t ]] = E [E[u t F t2 ] F t1 ] = E[u t F t1 ]=E t1 [u t ]

8 (b) The unconditional distribution of u t symmetric, but nonnormal: (i) Skewness: Exercise, show that E[u 3 t ]=0. (ii) Kurtosis: Exercise, show that under the assumption u t u t 1 N(0,σt 2 ), and that α< 1/3, the kurtosis (19) ω 2 E[u 4 t ]=3 (1 α) 2 1 α 2 1 3α 2. Hint: If X N(0,σ 2 ) then E[(X μ) 4 ]=3(σ 2 ) 2 =3σ 4. is Because (1 α 2 )/(1 3α 2 ) > 1 we have that ω 2 (20) E[u 4 t ] > 3 (1 α) 2 =3[Var(u t)] 2, we find that the kurtosis of the unconditional distribution exceed that what it would be, if u t were normally distributed. Thus the unconditional distribution of u t is nonnormal and has fatter tails than a normal distribution with variance equal to Var[u t ]= ω/(1 α)

9 (c) Standardized variables: Estimation of ARCH models Write z t = u t (21) σt 2 then z t NID(0, 1), i.e., normally and independently distributed. Thus we can always write (22) u t = z t σ 2 t, where z t independent standard normal random variables (strict white noise). This gives us a useful device to check after fitting an ARCH model the adequacy of the specification: Check the autocorrelations of the squared standardized series. Given the model (23) y t = x tθ + u t with u t F t 1 N(0,σt 2), we have y t {x t, F t 1 } N(x t θ,σ2 t ), t =1,...,T. Then the log-likelihood function becomes (24) with l(θ) = T t=1 l t (θ) l t (θ) = 1 2 log(2π) 1 2 log σ2 t 1 2 (y t x tθ) 2 /σt 2, (25) where θ =(θ,ω,α). In practice more fat tailed (and/or skewed) conditional distributions are assumed

10 Most popular conditional distributions: Student t: (26) l t = 1 2 log ( π(ν 2)Γ(ν/2) 2 Γ((ν+1)/2) 2 ) 1 2 log σ2 t (ν+1) 2 log (1+ (y t x tθ) 2 σ 2 t (ν 2) Γ( ) the gamma function, ν>2 the degrees of freedom. Generalized error distribtuion (GED): (27) l t = 1 2 log ( Γ(1/r) 3 Γ(3/r)(r/2) 2 ) 1 2 log σ2 t ( Γ(3/r)(yt x tθ) 2 σ 2 t Γ(1/r) ), ) r/2, r the tail parameter, r = 2 a normal distribution, r<2 fat-tailed. Skewed-Student: (28) ( ) l t = 1 2 log π(ν 2)Γ(ν/2)2 (ξ+1/ξ) 2 1 4s 2 Γ((ν+1)/2) 2 2 log σ2 t ) log (1+ (m+s(y t x tθ)) 2 ξ 2I t, σ 2 t (ν 2) where { 1, if (yt x I t = tθ) m/s (29) 1, if (y t x tθ) < m/s ξ is the asymmetry parameter (ξ = 1, symmetric). Also skewed normal and skewed ged are available in some versions. More details:

11 The maximum likelihood (ML) estimate ˆθ is the value maximizing the likelihood function, i.e., (30) l(ˆθ) = max l(θ). θ The maximization is accomplished by numerical methods. Non-Gaussian series are estimated often by quasi maximum likelihood (QML), i.e., as if the error were conditionally normal. Under fairly general conditions the QML estimator of ˆθ is consistent and asymptotically normal: (31) T (ˆθ θ) N(0, Jθ 1 I θ Jθ 1 ), where [ ] lt (θ) (32) J θ = E θ θ, and (33) [ ] lt (θ) l t (θ) I θ = E θ θ. Remark 2.5: If the conditional ditribution is Gaussian, J θ = I θ

12 Generalized ARCH models In practice the ARCH needs fairly many lags. Usually far less lags are needed by modifying the model to (34) σ 2 t = ω + αu2 t 1 + βσ2 t 1, with ω>0, α>0, β 0, and α + β<1. The model is called the Generalized ARCH (GARCH) model. Usually the above GARCH(1,1) is adequate in practice. Note again that defining ν t = u 2 t σ2 t, we can write (35) u 2 t = ω +(α + β)u2 t 1 + ν t βν t 1 a heteroscedastic ARMA(1,1) process. Applying backward substitution, one easily gets (36) σ 2 t = ω 1 β + α an ARCH( ) process. j=1 β j 1 u 2 t j Thus the GARCH term captures all the history from t 2 backwards of the shocks u t. Econometric packages call α (coefficient of u 2 t 1 ) the ARCH parameter and β (coefficient of σt 1 2 ) the GARCH parameter

13 Imposing additional lag terms, the model can be extended to GARCH(r, q) model (37) σ 2 t = ω + r j=1 [c.f. ARMA(p, q)]. β j σ 2 t j + q αu 2 t i i=1 Example 2.3: MA(1)-GARCH(1,1) model of SP500 returns estimated with conditional normal, u t F t 1 N(0,σt 2), and GED, u t F t 1 GED(0,σt 2) The model is (38) r t = μ + u t + θu t 1 σ 2 t = ω + αu 2 t 1 + βσ2 t 1. Nevertheless, as noted above, in practice GARCH(1,1) is adequate SP500 Returns

14 > fgarch::garchfit(spr ~arma(0,1) + garch(1,1), data = spr, cond.dist = "ged", trace = F) Conditional Distribution: norm Coefficient(s): mu ma1 omega alpha1 beta Std. Errors: based on Hessian Error Analysis: Estimate Std. Error t value Pr(> t ) mu ma *** omega *** alpha e-15 *** beta < 2e-16 *** --- Signif. codes: 0 *** ** 0.01 * Log Likelihood: normalized: AIC: BIC: (computed from fit@llh ) > fgarch::garchfit(spr ~arma(0,1) + garch(1,1), data = spr, cond.dist = "ged", trace = F) Conditional Distribution: ged Coefficient(s): mu ma1 omega alpha1 beta1 shape Std. Errors: based on Hessian Error Analysis: Estimate Std. Error t value Pr(> t ) mu ** ma *** omega * alpha e-11 *** beta < 2e-16 *** shape < 2e-16 *** --- Signif. codes: 0 *** ** 0.01 * Log Likelihood: normalized: AIC: BIC: (computed from fit@llh ) Goodness of fit (AIC, BIC) is marginally better for GED. The shape parameter estimate is < 2 (statistically significantly) indicated fat tails. Otherwise the coefficient estimates are about the same

15 Residual Diagnostics: Autocorrelations of squared standardized residuals: Normal: GED: Lag LB p-value LB p-value JB = , df = 2, p-value = (dropping the outlier JB = 43.96) The autocorrelations of the squared standardized residuals pass (approximately) the white noise test. Nevertheless, the normality of the standardized residuals is strongly rejected. Usually this affects mostly to stantard errors. Common practice is to use some sort of robust standard errors (e.g. White) SP500 Return residuals [MA(1)-GED-GARCH(1,1)] Conditional Volatility Volatility [sqrt(252*h_t)] Days 29 30

16 The variance function can be extended by including regressors (exogenous or predetermined variables), x t,init (39) σ 2 t = ω + αu 2 t 1 + βσ2 t 1 + πx t. Note that if x t can assume negative values, it may be desirable to introduce absolute values x t in place of x t in the conditional variance function. Example 2.4: Monday effect in SP500 returns and/or volatility? Pulse (additive) effect on mean and innovative effect on volatility y t = φ 0 + φ m M t + φ(y t 1 φ m M t 1 )+u t (40) σt 2 = ω + πm t + αu 2 t 1 + βσ2 t 1, where M t = 1 if Monday, zero otherwise. For example, with daily data a Monday dummy could be introduced into the model to capture the non-trading over the weekends in the volatility

17 SAS: conditional t-distribution proc autoreg data = tmp; model sp500 = mon/ nlag = 1 garch = (p=1, q=1) dist = t; hetero mon; run;... The AUTOREG Procedure GARCH Estimates SSE Observations 2321 MSE Uncond Var Log Likelihood Total R-Square SBC AIC MAE AICC MAPE Normality Test Pr > ChiSq <.0001 Standard Approx Variable DF Estimate Error t Value Pr > t Variable Label Intercept mon AR ARCH ARCH <.0001 GARCH <.0001 TDFI <.0001 Inverse of t DF HET E E Degrees of freedom estimate: 1/ ARCH-M Model The regression equation may be extended by introducing the variance function into the equation (41) y t = x t θ + λg(σ2 t )+u t, where u t GARCH, and g is a suitable function (usually square root or logarithm). This is called the ARCH in Mean (ARCH-M) model [Engle, Lilien and Robbins (1987) ]. The ARCH-M model is often used in finance, where the expected return on an asset is related to the expected asset risk. The coefficient λ reflects the risk-return tradeoff. No empirical evidence of a Monday effect in returns or volatility. 33 Econometrica, 55,

18 Example 2.5: Does the daily mean return of SP500 depend on the volatility level? Model AR(1)-GARCH(1, 1)-M with conditional t-distribution (42) y t = φ 0 + φ 1 y t 1 + λ σ 2 t + u t σ 2 t = ω + αu 2 t 1 + βσ2 t 1, where u t F t 1 t ν (t-distribution with ν degrees of freedom, to be estimated). proc autoreg data = tmp; model sp500 = / nlag = 1 garch = (p=1, q=1, mean = sqrt) dist = t; /* t-dist */ run; The AUTOREG Procedure GARCH Estimates SSE Observations 2321 MSE Uncond Var. Log Likelihood Total R-Square SBC AIC MAE AICC MAPE Normality Test Pr > ChiSq <.0001 Standard Approx Variable DF Estimate Error t Value Pr > t Intercept AR ARCH ARCH <.0001 GARCH <.0001 DELTA TDFI <.0001 Inverse of t DF The volatility term in the mean equation (DELTA) is not statistically significant neither is the constant, indicating no discernible drift in SP500 index (again ˆν =1/ )

19 Asymmetric ARCH: TARCH, EGARCH, PARCH The TARCH model A stylized fact in stock markets is that downward movements are followed by higher volatility than upward movements. A rough view of this can be obtained from the cross-autocorrelations of z t and z 2 t, where z t defined in (21). Example 2.6: Cross-autocorrelations of z t and z 2 2 from Ex 2.5 Cross-correlations of z and z^2 Threshold ARCH, TARCH (Zakoian 1994, Journal of Economic Dynamics and Control, , Glosten, Jagannathan and Runkle 1993, Journal of Finance, ) is given by [TARCH(1,1)] (43)σ2 t = ω + αu2 t 1 + γu2 t 1 d t 1 + βσ 2 t 1, where ω>0, α, β 0, α + 1 2γ + β<1, and d t =1,ifu t < 0 (bad news) and zero otherwise. ACF Lag The impact of good news is α and bad news α + γ. Thus, γ 0 implies asymmetry. Some autocorrelations signify possible leverage effect. Leverage exists if γ>

20 Example 2.7: SP500 returns, MA(1)-TARCH model (EViews, Dependent Variable: SP500 Method: ML - ARCH (Marquardt) - Generalized error distribution (GED) Sample (adjusted): 1/04/2000 3/27/2009 Included observations: 2321 after adjustments Convergence achieved after 28 iterations MA Backcast: 1/03/2000 Presample variance: backcast (parameter = 0.7) GARCH = C(3) + C(4)*RESID(-1)^2 + C(5)*RESID(-1)^2*(RESID(-1)<0) + C(6)*GARCH(-1) ============================================================== Variable Coefficient Std. Error z-stat Prob C MA(1) ============================================================== Variance Equation ============================================================== C RESID(-1)^ RES(-1)^2*(RES(-1)<0) GARCH(-1) ============================================================== R-squared Mean dependent var Adjusted R-squared S.D. dependent var S.E. of regression Akaike info criterion Sum squared resid Schwarz criterion Log likelihood Hannan-Quinn criter F-statistic Durbin-Watson stat Prob(F-statistic) ============================================================== Inverted MA Roots.07 ============================================================== The EGARCH model Nelson (1991) (Econometrica, ) proposed the Exponential GARCH (EGARCH) model for the variance function of the form (EGARCH(1,1)) (44) log σt 2 = ω + β log σ2 t 1 + α z t 1 + γz t 1, σt 2 where z t = u t / is the standardized shock. Again, the impact is asymmetric if γ 0, and leverage is present if γ<0. Statistically significant positive asymmetry parameter estimate indicates presence of leverage

21 Example 2.8: MA(1)-EGARCH(1,1)-M estimation results. Dependent Variable: SP500 Method: ML - ARCH (Marquardt) - Generalized error distribution (GED) Sample (adjusted): 1/04/2000 3/27/2009 Included observations: 2321 after adjustments Convergence achieved after 25 iterations MA Backcast: 1/03/2000 Presample variance: backcast (parameter = 0.7) LOG(GARCH) = C(3) + C(4)*ABS(RESID(-1)/@SQRT(GARCH(-1))) + C(5) *RESID(-1)/@SQRT(GARCH(-1)) + C(6)*LOG(GARCH(-1)) ============================================================= Variable Coefficient Std. Error z-statistic Prob C MA(1) ============================================================= Variance Equation ============================================================= C(3) C(4) C(5) C(6) ============================================================= GED PARAM ============================================================= R-squared Mean dependent var Adj R-sq S.D. dependent var S.E. of regr Akaike info criterion Sum sq resid Schwarz criterion Log lik Hannan-Quinn criter F-statistic Durbin-Watson stat P(F-stat) ============================================================= Inverted MA Roots.07 ============================================================= Power ARCH (PARCH) Ding, Granger, and Engle (1993). A long memory property of stock market returns and a new model. Journal of Empirical Finance. PARC(1,1) (45)σ δ t = ω + βσδ t 1 + α( u t 1 γu t 1 ) δ, where γ is the leverage parameter. γ>0 implies leverage. Again Again statistically significant leverage

22 Example 2.9: R: fgarch::garchfit MA(1)-APARCH(1,1) results for SP500 returns. R parametrization: MA(1), mu and theta gfa <- fgarch::garchfit(sp500r~arma(0,1) + aparch(1,1), + data = sp500r, cond.dist = "ged", trace=f) The leverage parameter ( gamma1 ) estimates to unity. ˆδ = ( ) does not deviate significantly from unity (standard deviation process). Mean and Variance Equation: data ~ arma(0, 1) + aparch(1, 1) [data = sp500r] Conditional Distribution: ged Error Analysis: Estimate Std. Error t value Pr(> t ) mu ma *** omega *** alpha e-11 *** gamma < 2e-16 *** beta < 2e-16 *** delta e-09 *** shape < 2e-16 *** --- Signif. codes: 0 *** ** 0.01 * Log Likelihood: normalized:

23 Integrated GARCH (IGARCH) 2.3 Predicting Volatility Often in GARCH ˆα+ˆβ 1. Engle and Bollerslev (19896). Modelling the persistence of conditional variances, Econometrics Reviews 5, 1 50, introduce integrated GARCH with α + β =1. (46) σ 2 t = ω + αu2 t 1 +(1 α)σ2 t 1. Close to the EWMA (Exponentially Weighted Moving Average) specification Predicting with the GARCH models is straightforward. Generally a k-period forward prediction is of the form σt k 2 = E [ ] [ ] (48) t u 2 t+k = E u 2 t+k F t k =1, 2,... (47) σ 2 t = αu2 t 1 +(1 α)σ2 t 1 favored often in by practitioners. Unconditional variance does not exist [more details, see Nelson (1990). Stationarity and persistence in in the GARCH(1,1) model. Econometric Theory 6, ]

24 Because (49) u t = σ t z t, where generally z t i.i.d(0, 1). Thus in (48) E t [u 2 t+k ] = E t[σ 2 t+k z2 t+k ] = E t [σ 2 t+k ]E t[z 2 t+k ] (z t are i.i.d(0, 1)) = E t [σt+k 2 ]. (50) This can be utilize to derive explicit prediction formulas in most cases. ARCH(1): (51) (52) where (53) σ 2 t+1 = ω + αu2 t σ 2 t k = ω(1 αk 1 ) 1 α + α k 1 σ 2 t+1 Recursive fromula: (54) σ 2 t k = = σ 2 + α k 1 (σ 2 t+1 σ2 ), σ 2 = Var[u t ]= ω 1 α σ 2 t+1 for k =1 ω + ασ 2 t k 1 for k>

25 GARCH(1,1): IGARCH: (55) σ 2 t+1 = ω + αu2 t + βσ2 t. σ t k 2 = ω(1 (α+β)k 1 ) +(α + β) 1 (α+β) k 1 σt+1 2 (56) = σ 2 +(α + β) k 1 (σt+1 2 σ2 ), where (57) σ 2 = ω 1 α β. (58) (59) σ 2 t+1 = ω + αu2 t +(1 α)σ 2 t. σ 2 t k =(k 1)ω + σ t

26 TGARCH: (60) σ 2 t+1 = ω + αu2 t + γu2 t d t + βσ 2 t. σ 2 t k = ω(1 (α+1 2 γ+β)k 1 ) 1 (α+γ/2+β) (61) with (62) +(α γ + β)k 1 σ 2 t+1 = σ 2 +(α γ + β)k 1 (σ 2 t+1 σ2 ) σ 2 = ω 1 α 1 2 γ β. EGARCH and APARCH prediction equations are a bit more involved. Recursive formulas are more appropriate in these cases. The volatility forecasts are applied for example in Value At Risk computations

27 Evaluation of predictions unfortunately not that straightforward! (see, Andersen and Bollerslev (1998) International Economic Review. 53

Example 2.1: Consider the following daily close-toclose SP500 values [January 3, 2000 to March 27, 2009] SP500 Daily Returns and Index Values

Example 2.1: Consider the following daily close-toclose SP500 values [January 3, 2000 to March 27, 2009] SP500 Daily Returns and Index Values 2. Volatility Models 2.1 Background Example 2.1: Consider the following daily close-toclose SP500 values [January 3, 2000 to March 27, 2009] SP500 Daily Returns and Index Values -10-5 0 5 10 Return (%)

More information

GARCH Models. Eduardo Rossi University of Pavia. December Rossi GARCH Financial Econometrics / 50

GARCH Models. Eduardo Rossi University of Pavia. December Rossi GARCH Financial Econometrics / 50 GARCH Models Eduardo Rossi University of Pavia December 013 Rossi GARCH Financial Econometrics - 013 1 / 50 Outline 1 Stylized Facts ARCH model: definition 3 GARCH model 4 EGARCH 5 Asymmetric Models 6

More information

Volatility. Gerald P. Dwyer. February Clemson University

Volatility. Gerald P. Dwyer. February Clemson University Volatility Gerald P. Dwyer Clemson University February 2016 Outline 1 Volatility Characteristics of Time Series Heteroskedasticity Simpler Estimation Strategies Exponentially Weighted Moving Average Use

More information

Heteroskedasticity in Time Series

Heteroskedasticity in Time Series Heteroskedasticity in Time Series Figure: Time Series of Daily NYSE Returns. 206 / 285 Key Fact 1: Stock Returns are Approximately Serially Uncorrelated Figure: Correlogram of Daily Stock Market Returns.

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

Final Exam Financial Data Analysis at the University of Freiburg (Winter Semester 2008/2009) Friday, November 14, 2008,

Final Exam Financial Data Analysis at the University of Freiburg (Winter Semester 2008/2009) Friday, November 14, 2008, Professor Dr. Roman Liesenfeld Final Exam Financial Data Analysis at the University of Freiburg (Winter Semester 2008/2009) Friday, November 14, 2008, 10.00 11.30am 1 Part 1 (38 Points) Consider the following

More information

in the time series. The relation between y and x is contemporaneous.

in the time series. The relation between y and x is contemporaneous. 9 Regression with Time Series 9.1 Some Basic Concepts Static Models (1) y t = β 0 + β 1 x t + u t t = 1, 2,..., T, where T is the number of observation in the time series. The relation between y and x

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

GARCH Models Estimation and Inference

GARCH Models Estimation and Inference GARCH Models Estimation and Inference Eduardo Rossi University of Pavia December 013 Rossi GARCH Financial Econometrics - 013 1 / 1 Likelihood function The procedure most often used in estimating θ 0 in

More information

GARCH Models Estimation and Inference

GARCH Models Estimation and Inference Università di Pavia GARCH Models Estimation and Inference Eduardo Rossi Likelihood function The procedure most often used in estimating θ 0 in ARCH models involves the maximization of a likelihood function

More information

Financial Time Series Analysis: Part II

Financial Time Series Analysis: Part II Department of Mathematics and Statistics, University of Vaasa, Finland Spring 2017 1 Unit root Deterministic trend Stochastic trend Testing for unit root ADF-test (Augmented Dickey-Fuller test) Testing

More information

GARCH Models Estimation and Inference. Eduardo Rossi University of Pavia

GARCH Models Estimation and Inference. Eduardo Rossi University of Pavia GARCH Models Estimation and Inference Eduardo Rossi University of Pavia Likelihood function The procedure most often used in estimating θ 0 in ARCH models involves the maximization of a likelihood function

More information

Arma-Arch Modeling Of The Returns Of First Bank Of Nigeria

Arma-Arch Modeling Of The Returns Of First Bank Of Nigeria Arma-Arch Modeling Of The Returns Of First Bank Of Nigeria Emmanuel Alphonsus Akpan Imoh Udo Moffat Department of Mathematics and Statistics University of Uyo, Nigeria Ntiedo Bassey Ekpo Department of

More information

End-Semester Examination MA 373 : Statistical Analysis on Financial Data

End-Semester Examination MA 373 : Statistical Analysis on Financial Data End-Semester Examination MA 373 : Statistical Analysis on Financial Data Instructor: Dr. Arabin Kumar Dey, Department of Mathematics, IIT Guwahati Note: Use the results in Section- III: Data Analysis using

More information

The GARCH Analysis of YU EBAO Annual Yields Weiwei Guo1,a

The GARCH Analysis of YU EBAO Annual Yields Weiwei Guo1,a 2nd Workshop on Advanced Research and Technology in Industry Applications (WARTIA 2016) The GARCH Analysis of YU EBAO Annual Yields Weiwei Guo1,a 1 Longdong University,Qingyang,Gansu province,745000 a

More information

THE UNIVERSITY OF CHICAGO Graduate School of Business Business 41202, Spring Quarter 2003, Mr. Ruey S. Tsay

THE UNIVERSITY OF CHICAGO Graduate School of Business Business 41202, Spring Quarter 2003, Mr. Ruey S. Tsay THE UNIVERSITY OF CHICAGO Graduate School of Business Business 41202, Spring Quarter 2003, Mr. Ruey S. Tsay Solutions to Homework Assignment #4 May 9, 2003 Each HW problem is 10 points throughout this

More information

10. Time series regression and forecasting

10. Time series regression and forecasting 10. Time series regression and forecasting Key feature of this section: Analysis of data on a single entity observed at multiple points in time (time series data) Typical research questions: What is the

More information

7. Integrated Processes

7. Integrated Processes 7. Integrated Processes Up to now: Analysis of stationary processes (stationary ARMA(p, q) processes) Problem: Many economic time series exhibit non-stationary patterns over time 226 Example: We consider

More information

Romanian Economic and Business Review Vol. 3, No. 3 THE EVOLUTION OF SNP PETROM STOCK LIST - STUDY THROUGH AUTOREGRESSIVE MODELS

Romanian Economic and Business Review Vol. 3, No. 3 THE EVOLUTION OF SNP PETROM STOCK LIST - STUDY THROUGH AUTOREGRESSIVE MODELS THE EVOLUTION OF SNP PETROM STOCK LIST - STUDY THROUGH AUTOREGRESSIVE MODELS Marian Zaharia, Ioana Zaheu, and Elena Roxana Stan Abstract Stock exchange market is one of the most dynamic and unpredictable

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

Univariate linear models

Univariate linear models Univariate linear models The specification process of an univariate ARIMA model is based on the theoretical properties of the different processes and it is also important the observation and interpretation

More information

ECON3327: Financial Econometrics, Spring 2016

ECON3327: Financial Econometrics, Spring 2016 ECON3327: Financial Econometrics, Spring 2016 Wooldridge, Introductory Econometrics (5th ed, 2012) Chapter 11: OLS with time series data Stationary and weakly dependent time series The notion of a stationary

More information

Econ 427, Spring Problem Set 3 suggested answers (with minor corrections) Ch 6. Problems and Complements:

Econ 427, Spring Problem Set 3 suggested answers (with minor corrections) Ch 6. Problems and Complements: Econ 427, Spring 2010 Problem Set 3 suggested answers (with minor corrections) Ch 6. Problems and Complements: 1. (page 132) In each case, the idea is to write these out in general form (without the lag

More information

7. Integrated Processes

7. Integrated Processes 7. Integrated Processes Up to now: Analysis of stationary processes (stationary ARMA(p, q) processes) Problem: Many economic time series exhibit non-stationary patterns over time 226 Example: We consider

More information

APPLIED MACROECONOMETRICS Licenciatura Universidade Nova de Lisboa Faculdade de Economia. FINAL EXAM JUNE 3, 2004 Starts at 14:00 Ends at 16:30

APPLIED MACROECONOMETRICS Licenciatura Universidade Nova de Lisboa Faculdade de Economia. FINAL EXAM JUNE 3, 2004 Starts at 14:00 Ends at 16:30 APPLIED MACROECONOMETRICS Licenciatura Universidade Nova de Lisboa Faculdade de Economia FINAL EXAM JUNE 3, 2004 Starts at 14:00 Ends at 16:30 I In Figure I.1 you can find a quarterly inflation rate series

More information

Lecture 14: Conditional Heteroscedasticity Bus 41910, Time Series Analysis, Mr. R. Tsay

Lecture 14: Conditional Heteroscedasticity Bus 41910, Time Series Analysis, Mr. R. Tsay Lecture 14: Conditional Heteroscedasticity Bus 41910, Time Series Analysis, Mr. R. Tsay The introduction of conditional heteroscedastic autoregressive (ARCH) models by Engle (198) popularizes conditional

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

Analytical derivates of the APARCH model

Analytical derivates of the APARCH model Analytical derivates of the APARCH model Sébastien Laurent Forthcoming in Computational Economics October 24, 2003 Abstract his paper derives analytical expressions for the score of the APARCH model of

More information

13. Time Series Analysis: Asymptotics Weakly Dependent and Random Walk Process. Strict Exogeneity

13. Time Series Analysis: Asymptotics Weakly Dependent and Random Walk Process. Strict Exogeneity Outline: Further Issues in Using OLS with Time Series Data 13. Time Series Analysis: Asymptotics Weakly Dependent and Random Walk Process I. Stationary and Weakly Dependent Time Series III. Highly Persistent

More information

Diagnostic Test for GARCH Models Based on Absolute Residual Autocorrelations

Diagnostic Test for GARCH Models Based on Absolute Residual Autocorrelations Diagnostic Test for GARCH Models Based on Absolute Residual Autocorrelations Farhat Iqbal Department of Statistics, University of Balochistan Quetta-Pakistan farhatiqb@gmail.com Abstract In this paper

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

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

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

Univariate Volatility Modeling

Univariate Volatility Modeling Univariate Volatility Modeling Kevin Sheppard http://www.kevinsheppard.com Oxford MFE This version: January 10, 2013 January 14, 2013 Financial Econometrics (Finally) This term Volatility measurement and

More information

Practical Econometrics. for. Finance and Economics. (Econometrics 2)

Practical Econometrics. for. Finance and Economics. (Econometrics 2) Practical Econometrics for Finance and Economics (Econometrics 2) Seppo Pynnönen and Bernd Pape Department of Mathematics and Statistics, University of Vaasa 1. Introduction 1.1 Econometrics Econometrics

More information

M-estimators for augmented GARCH(1,1) processes

M-estimators for augmented GARCH(1,1) processes M-estimators for augmented GARCH(1,1) processes Freiburg, DAGStat 2013 Fabian Tinkl 19.03.2013 Chair of Statistics and Econometrics FAU Erlangen-Nuremberg Outline Introduction The augmented GARCH(1,1)

More information

Stationary Time Series, Conditional Heteroscedasticity, Random Walk, Test for a Unit Root, Endogenity, Causality and IV Estimation

Stationary Time Series, Conditional Heteroscedasticity, Random Walk, Test for a Unit Root, Endogenity, Causality and IV Estimation 1 / 67 Stationary Time Series, Conditional Heteroscedasticity, Random Walk, Test for a Unit Root, Endogenity, Causality and IV Estimation Chapter 1 Financial Econometrics Michael Hauser WS18/19 2 / 67

More information

13. Estimation and Extensions in the ARCH model. MA6622, Ernesto Mordecki, CityU, HK, References for this Lecture:

13. Estimation and Extensions in the ARCH model. MA6622, Ernesto Mordecki, CityU, HK, References for this Lecture: 13. Estimation and Extensions in the ARCH model MA6622, Ernesto Mordecki, CityU, HK, 2006. References for this Lecture: Robert F. Engle. GARCH 101: The Use of ARCH/GARCH Models in Applied Econometrics,

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

Financial Econometrics

Financial Econometrics Financial Econometrics Topic 5: Modelling Volatility Lecturer: Nico Katzke nicokatzke@sun.ac.za Department of Economics Texts used The notes and code in R were created using many references. Intuitively,

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

Time Series Models of Heteroskedasticity

Time Series Models of Heteroskedasticity Chapter 21 Time Series Models of Heteroskedasticity There are no worked examples in the text, so we will work with the Federal Funds rate as shown on page 658 and below in Figure 21.1. It will turn out

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

NANYANG TECHNOLOGICAL UNIVERSITY SEMESTER II EXAMINATION MAS451/MTH451 Time Series Analysis TIME ALLOWED: 2 HOURS

NANYANG TECHNOLOGICAL UNIVERSITY SEMESTER II EXAMINATION MAS451/MTH451 Time Series Analysis TIME ALLOWED: 2 HOURS NANYANG TECHNOLOGICAL UNIVERSITY SEMESTER II EXAMINATION 2012-2013 MAS451/MTH451 Time Series Analysis May 2013 TIME ALLOWED: 2 HOURS INSTRUCTIONS TO CANDIDATES 1. This examination paper contains FOUR (4)

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

Symmetric btw positive & negative prior returns. where c is referred to as risk premium, which is expected to be positive.

Symmetric btw positive & negative prior returns. where c is referred to as risk premium, which is expected to be positive. Advantages of GARCH model Simplicity Generates volatility clustering Heavy tails (high kurtosis) Weaknesses of GARCH model Symmetric btw positive & negative prior returns Restrictive Provides no explanation

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

Circle a single answer for each multiple choice question. Your choice should be made clearly.

Circle a single answer for each multiple choice question. Your choice should be made clearly. TEST #1 STA 4853 March 4, 215 Name: Please read the following directions. DO NOT TURN THE PAGE UNTIL INSTRUCTED TO DO SO Directions This exam is closed book and closed notes. There are 31 questions. Circle

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

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

ECONOMICS 7200 MODERN TIME SERIES ANALYSIS Econometric Theory and Applications

ECONOMICS 7200 MODERN TIME SERIES ANALYSIS Econometric Theory and Applications ECONOMICS 7200 MODERN TIME SERIES ANALYSIS Econometric Theory and Applications Yongmiao Hong Department of Economics & Department of Statistical Sciences Cornell University Spring 2019 Time and uncertainty

More information

Generalized Autoregressive Score Models

Generalized Autoregressive Score Models Generalized Autoregressive Score Models by: Drew Creal, Siem Jan Koopman, André Lucas To capture the dynamic behavior of univariate and multivariate time series processes, we can allow parameters to be

More information

The Simple Regression Model. Part II. The Simple Regression Model

The Simple Regression Model. Part II. The Simple Regression Model Part II The Simple Regression Model As of Sep 22, 2015 Definition 1 The Simple Regression Model Definition Estimation of the model, OLS OLS Statistics Algebraic properties Goodness-of-Fit, the R-square

More information

Autocorrelation or Serial Correlation

Autocorrelation or Serial Correlation Chapter 6 Autocorrelation or Serial Correlation Section 6.1 Introduction 2 Evaluating Econometric Work How does an analyst know when the econometric work is completed? 3 4 Evaluating Econometric Work Econometric

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

Brief Sketch of Solutions: Tutorial 3. 3) unit root tests

Brief Sketch of Solutions: Tutorial 3. 3) unit root tests Brief Sketch of Solutions: Tutorial 3 3) unit root tests.5.4.4.3.3.2.2.1.1.. -.1 -.1 -.2 -.2 -.3 -.3 -.4 -.4 21 22 23 24 25 26 -.5 21 22 23 24 25 26.8.2.4. -.4 - -.8 - - -.12 21 22 23 24 25 26 -.2 21 22

More information

ISSN Article. Selection Criteria in Regime Switching Conditional Volatility Models

ISSN Article. Selection Criteria in Regime Switching Conditional Volatility Models Econometrics 2015, 3, 289-316; doi:10.3390/econometrics3020289 OPEN ACCESS econometrics ISSN 2225-1146 www.mdpi.com/journal/econometrics Article Selection Criteria in Regime Switching Conditional Volatility

More information

Frequency Forecasting using Time Series ARIMA model

Frequency Forecasting using Time Series ARIMA model Frequency Forecasting using Time Series ARIMA model Manish Kumar Tikariha DGM(O) NSPCL Bhilai Abstract In view of stringent regulatory stance and recent tariff guidelines, Deviation Settlement mechanism

More information

DynamicAsymmetricGARCH

DynamicAsymmetricGARCH DynamicAsymmetricGARCH Massimiliano Caporin Dipartimento di Scienze Economiche Università Ca Foscari di Venezia Michael McAleer School of Economics and Commerce University of Western Australia Revised:

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

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

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

Econometrics I. Professor William Greene Stern School of Business Department of Economics 25-1/25. Part 25: Time Series

Econometrics I. Professor William Greene Stern School of Business Department of Economics 25-1/25. Part 25: Time Series Econometrics I Professor William Greene Stern School of Business Department of Economics 25-1/25 Econometrics I Part 25 Time Series 25-2/25 Modeling an Economic Time Series Observed y 0, y 1,, y t, What

More information

Variance stabilization and simple GARCH models. Erik Lindström

Variance stabilization and simple GARCH models. Erik Lindström Variance stabilization and simple GARCH models Erik Lindström Simulation, GBM Standard model in math. finance, the GBM ds t = µs t dt + σs t dw t (1) Solution: S t = S 0 exp ) ) ((µ σ2 t + σw t 2 (2) Problem:

More information

GARCH processes probabilistic properties (Part 1)

GARCH processes probabilistic properties (Part 1) GARCH processes probabilistic properties (Part 1) Alexander Lindner Centre of Mathematical Sciences Technical University of Munich D 85747 Garching Germany lindner@ma.tum.de http://www-m1.ma.tum.de/m4/pers/lindner/

More information

July 31, 2009 / Ben Kedem Symposium

July 31, 2009 / Ben Kedem Symposium ing The s ing The Department of Statistics North Carolina State University July 31, 2009 / Ben Kedem Symposium Outline ing The s 1 2 s 3 4 5 Ben Kedem ing The s Ben has made many contributions to time

More information

9. AUTOCORRELATION. [1] Definition of Autocorrelation (AUTO) 1) Model: y t = x t β + ε t. We say that AUTO exists if cov(ε t,ε s ) 0, t s.

9. AUTOCORRELATION. [1] Definition of Autocorrelation (AUTO) 1) Model: y t = x t β + ε t. We say that AUTO exists if cov(ε t,ε s ) 0, t s. 9. AUTOCORRELATION [1] Definition of Autocorrelation (AUTO) 1) Model: y t = x t β + ε t. We say that AUTO exists if cov(ε t,ε s ) 0, t s. ) Assumptions: All of SIC except SIC.3 (the random sample assumption).

More information

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

ARDL Cointegration Tests for Beginner

ARDL Cointegration Tests for Beginner ARDL Cointegration Tests for Beginner Tuck Cheong TANG Department of Economics, Faculty of Economics & Administration University of Malaya Email: tangtuckcheong@um.edu.my DURATION: 3 HOURS On completing

More information

Forecasting Seasonal Time Series 1. Introduction. Philip Hans Franses Econometric Institute Erasmus University Rotterdam

Forecasting Seasonal Time Series 1. Introduction. Philip Hans Franses Econometric Institute Erasmus University Rotterdam Forecasting Seasonal Time Series 1. Introduction Philip Hans Franses Econometric Institute Erasmus University Rotterdam SMU and NUS, Singapore, April-May 2004 1 Outline of tutorial lectures 1 Introduction

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

Location Multiplicative Error Model. Asymptotic Inference and Empirical Analysis

Location Multiplicative Error Model. Asymptotic Inference and Empirical Analysis : Asymptotic Inference and Empirical Analysis Qian Li Department of Mathematics and Statistics University of Missouri-Kansas City ql35d@mail.umkc.edu October 29, 2015 Outline of Topics Introduction GARCH

More information

ARCH and GARCH Processes

ARCH and GARCH Processes Chapter 8 ARCH and GARCH Processes 8.1 Introduction When modelling time series, there are broadly speaking two approaches, the fundamentalist and the data analyst. The first of these aims to construct

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

Univariate Nonstationary Time Series 1

Univariate Nonstationary Time Series 1 Univariate Nonstationary Time Series 1 Sebastian Fossati University of Alberta 1 These slides are based on Eric Zivot s time series notes available at: http://faculty.washington.edu/ezivot Introduction

More information

x = 1 n (x = 1 (x n 1 ι(ι ι) 1 ι x) (x ι(ι ι) 1 ι x) = 1

x = 1 n (x = 1 (x n 1 ι(ι ι) 1 ι x) (x ι(ι ι) 1 ι x) = 1 Estimation and Inference in Econometrics Exercises, January 24, 2003 Solutions 1. a) cov(wy ) = E [(WY E[WY ])(WY E[WY ]) ] = E [W(Y E[Y ])(Y E[Y ]) W ] = W [(Y E[Y ])(Y E[Y ]) ] W = WΣW b) Let Σ be a

More information

1 Quantitative Techniques in Practice

1 Quantitative Techniques in Practice 1 Quantitative Techniques in Practice 1.1 Lecture 2: Stationarity, spurious regression, etc. 1.1.1 Overview In the rst part we shall look at some issues in time series economics. In the second part we

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

9) Time series econometrics

9) Time series econometrics 30C00200 Econometrics 9) Time series econometrics Timo Kuosmanen Professor Management Science http://nomepre.net/index.php/timokuosmanen 1 Macroeconomic data: GDP Inflation rate Examples of time series

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

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

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

Circle the single best answer for each multiple choice question. Your choice should be made clearly.

Circle the single best answer for each multiple choice question. Your choice should be made clearly. TEST #1 STA 4853 March 6, 2017 Name: Please read the following directions. DO NOT TURN THE PAGE UNTIL INSTRUCTED TO DO SO Directions This exam is closed book and closed notes. There are 32 multiple choice

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

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. Chapter Time Series Data

Time Series. Chapter Time Series Data Chapter 10 Time Series 10.1 Time Series Data The main difference between time series data and cross-sectional data is the temporal ordering. To emphasize the proper ordering of the observations, Table

More information

Multivariate GARCH models.

Multivariate GARCH models. Multivariate GARCH models. Financial market volatility moves together over time across assets and markets. Recognizing this commonality through a multivariate modeling framework leads to obvious gains

More information

Introduction to Estimation Methods for Time Series models Lecture 2

Introduction to Estimation Methods for Time Series models Lecture 2 Introduction to Estimation Methods for Time Series models Lecture 2 Fulvio Corsi SNS Pisa Fulvio Corsi Introduction to Estimation () Methods for Time Series models Lecture 2 SNS Pisa 1 / 21 Estimators:

More information

Heteroskedasticity. Part VII. Heteroskedasticity

Heteroskedasticity. Part VII. Heteroskedasticity Part VII Heteroskedasticity As of Oct 15, 2015 1 Heteroskedasticity Consequences Heteroskedasticity-robust inference Testing for Heteroskedasticity Weighted Least Squares (WLS) Feasible generalized Least

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

The autocorrelation and autocovariance functions - helpful tools in the modelling problem

The autocorrelation and autocovariance functions - helpful tools in the modelling problem The autocorrelation and autocovariance functions - helpful tools in the modelling problem J. Nowicka-Zagrajek A. Wy lomańska Institute of Mathematics and Computer Science Wroc law University of Technology,

More information

Problem set 1 - Solutions

Problem set 1 - Solutions EMPIRICAL FINANCE AND FINANCIAL ECONOMETRICS - MODULE (8448) Problem set 1 - Solutions Exercise 1 -Solutions 1. The correct answer is (a). In fact, the process generating daily prices is usually assumed

More information

Oil price volatility in the Philippines using generalized autoregressive conditional heteroscedasticity

Oil price volatility in the Philippines using generalized autoregressive conditional heteroscedasticity Oil price volatility in the Philippines using generalized autoregressive conditional heteroscedasticity Carl Ceasar F. Talungon University of Southern Mindanao, Cotabato Province, Philippines Email: carlceasar04@gmail.com

More information

Economics 618B: Time Series Analysis Department of Economics State University of New York at Binghamton

Economics 618B: Time Series Analysis Department of Economics State University of New York at Binghamton Problem Set #1 1. Generate n =500random numbers from both the uniform 1 (U [0, 1], uniformbetween zero and one) and exponential λ exp ( λx) (set λ =2and let x U [0, 1]) b a distributions. Plot the histograms

More information

Stock index returns density prediction using GARCH models: Frequentist or Bayesian estimation?

Stock index returns density prediction using GARCH models: Frequentist or Bayesian estimation? MPRA Munich Personal RePEc Archive Stock index returns density prediction using GARCH models: Frequentist or Bayesian estimation? Ardia, David; Lennart, Hoogerheide and Nienke, Corré aeris CAPITAL AG,

More information

Bayesian Semiparametric GARCH Models

Bayesian Semiparametric GARCH Models Bayesian Semiparametric GARCH Models Xibin (Bill) Zhang and Maxwell L. King Department of Econometrics and Business Statistics Faculty of Business and Economics xibin.zhang@monash.edu Quantitative Methods

More information

2. Linear regression with multiple regressors

2. Linear regression with multiple regressors 2. Linear regression with multiple regressors Aim of this section: Introduction of the multiple regression model OLS estimation in multiple regression Measures-of-fit in multiple regression Assumptions

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

Bayesian Semiparametric GARCH Models

Bayesian Semiparametric GARCH Models Bayesian Semiparametric GARCH Models Xibin (Bill) Zhang and Maxwell L. King Department of Econometrics and Business Statistics Faculty of Business and Economics xibin.zhang@monash.edu Quantitative Methods

More information

4. Examples. Results: Example 4.1 Implementation of the Example 3.1 in SAS. In SAS we can use the Proc Model procedure.

4. Examples. Results: Example 4.1 Implementation of the Example 3.1 in SAS. In SAS we can use the Proc Model procedure. 4. Examples Example 4.1 Implementation of the Example 3.1 in SAS. In SAS we can use the Proc Model procedure. Simulate data from t-distribution with ν = 6. SAS: data tdist; do i = 1 to 500; y = tinv(ranuni(158),6);

More information