Linear Regression. Junhui Qian. October 27, 2014

Size: px
Start display at page:

Download "Linear Regression. Junhui Qian. October 27, 2014"

Transcription

1 Linear Regression Junhui Qian October 27, 2014

2 Outline The Model Estimation Ordinary Least Square Method of Moments Maximum Likelihood Estimation Properties of OLS Estimator Unbiasedness Consistency Efficiency

3 What is linear regression? We want to explain an economic variable y using x, which is usually a vector. For example, y may be the wage of an individual, and x include factors such as experience, education, gender, and so on. Let x = (1, x 1,..., x k ), and let its realization for ith-individual be x i = (1, x i1,..., x ik ), we may write: y = β 0 + β 1 x β k x k + u. (1)

4 Some Terminologies Now we have y = β 0 + β 1 x β k x k + u. (2) y is called the dependent variable, the explained variable, or the regressand The elements in x are called the independent variables, explanatory variables, covariates, or the regressors. β s are coefficients. In particular, β 0 is usually called intercept parameter or simply called constant term, and (β j, 1 j k) are usually called slope parameters. u is called the error term, residuals, or disturbances and represents factors other than x that affect y.

5 An Example We may have an econometric model of wages: wage i = β 0 + β 1 edu i + β 2 expr i + u i edu i denotes the education level of individual i in terms of years of schooling and expr i denotes the working experience of individual i. β 0 is the constant term or the intercept. It measures what a male worker would expect to get if he has zero education and zero experience. β 1 is the slope parameter for the explanatory variable edu. It measure the marginal increase in wage if a worker gains additional year of schooling, holding other factors fixed, or controlling for other factors. u i may include the gender, the luck, or the family background of the individual, etc.

6 Partial Effects (β j, j = 1,.., k) can be interpreted as partial effects. For example, for the wage equation, we have wage = β 1 edu + β 2 expr + u. If we hold all factors other than edu fixed, then wage = β 1 edu. So β 1 is the partial effect of education on wage. We say: With one unit of increase in edu, an individual s wage increases by β 1, holding other factors fixed, or controlling for other factors.

7 Econometric Clear Thinking Whenever we make comparisons or inferences, we should hold relevant factors fixed. This is achieved in econometrics by multiple linear regression. The partial effects interpretation is not without problem. It is partial equilibrium analysis. We may have the socalled general equilibrium problem, which happens when a change in a variable leads to changes in the structure of regression equation. In most cases, however, partial effects analysis is a good approximation, or, the best alternative.

8 Classical Linear Regression Assumptions (1) Linearity (2) Random sampling (x i, y i ) are iid across i (3) No perfect collinearity Any element in x cannot be represented by the linear combination of other elements. (4) Zero conditional mean E(u x) = E(u x 1, x 2,..., x k ) = 0. (5) Homoscedasticity (6) Normality var(u x) = σ 2. u x N(0, σ 2 ).

9 More on Linearity Linearity can be achieved by transformation. For example, we may have log(wage i ) = β 0 +β 1 log(exper i )+β 2 log(educ i )+β 3 female i +u i. Now the parameter β 1 represents the elasticity of wage with respect to changes in experiences: β 1 = log(wage i) log(exper i ) = wage i/wage i exper i /exper i wage i/wage i exper i /exper i.

10 More on No Perfect Collinearity True or False? (1) No Perfect Collinearity does not allow correlation. For example, the following is perfect collinearity: testscore = β 0 + β 1 eduexpend + β 2 familyincome + u. (2) The following model suffers from perfect collinearity: cons = β 0 + β 1 income + β 2 income 2 + u. (3) The following model suffers from perfect collinearity: log(cons) = β 0 + β 1 log(income) + β 2 log(income 2 ) + u. (4) The following model suffers from perfect collinearity: cons = β 0 +β 1 husbincome+β 2 wifeincome+β 3 familyincome+u.

11 More on Zero Conditional Mean If E(u x) = 0, we call x exogenous. If E(u x) 0, we call x endogenous. The notion of being exogenous or endogenous can be understood in the following model, L = αw + γx + u, where both the employment level (L) and the average wage (W ) are endogenous variables, while the foreign exchange rate (X ) can be considered exogenous. The residual u should contain shocks from both supply and demand sides.

12 Endogenous Wage If the employment level and the average wage are determined by L s = bw + v s L d = aw + cx + v d L d = L s, Then we can solve for the equilibrium employment and wage rate: W = L = c b a X v s v d b a bc b a X av s bv d. b a It is obvious that cov(w, v d ) 0 and cov(w, v s ) 0. Thus W should be correlated with u, hence the endogeneity in econometric sense.

13 More on Zero Conditional Mean In econometrics, we call an explanatory variable x endogenous as long as E(u x) 0. Usually, nonzero conditional mean is due to Endogeneity Missing variables (e.g., ability in wage equation) Wrong functional form (e.g., missing quadratic term)

14 More on Homoscedasticity If var(u i x i ) = σ 2, we call the model homoscedastic. If not, we call it heteroscedastic. Note that var(u i x i ) = var(y i x i ). If var(y i x i ) is a function of some regressor, then there would be heteroscedasticity. Examples of heteroscedasticity Income v.s. Expenditure on meals Gender v.s. Wage.

15 Ordinary Least Square We have y i = β 0 + β 1 x i1 + + β k x ik + u i. The OLS method is to find beta s such that the sum of squared residuals (SSR) is minimized: SSR(β 0,..., β k ) = n [(y i (β 0 + β 1 x i1 + + β k x ik )] 2. i=1 OLS minimizes a measure of fitting error.

16 First Order Conditions of OLS To minimize SSR, we find the first-order conditions of the minimization problem: SSR β 0 = 0 SSR β 1 = 0. SSR β k = 0

17 First Order Conditions of OLS We obtain: n ((y i ( ˆβ 0 + ˆβ 1 x i1 + + ˆβ k x ik )) = 0 i=1 n ((y i ( ˆβ 0 + ˆβ 1 x i1 + + ˆβ k x ik ))x i1 = 0 i=1. n ((y i ( ˆβ 0 + ˆβ 1 x i1 + + ˆβ k x ik ))x ik = 0. i=1 We have (1 + k) equations for (1 + k) unknowns. If there is no perfect collinearity, we can solve for these equations.

18 OLS for Naive Regression We may have the following model y i = βx i + u. Then the first-order condition is: n (y i ˆβx i )x i = 0 i=1 We obtain ˆβ = n i=1 y ix i n i=1 x 2 i

19 OLS for Simple Regression The following is called a simple regression : y i = β 0 + β 1 x i + u i. Then the first-order conditions are: n (y i ( ˆβ 0 + ˆβ 1 x i )) = 0 i=1 n (y i ( ˆβ 0 + ˆβ 1 x i ))x i = 0 i=1

20 OLS for Simple Regression, Continued From the first-order conditions, we obtain ˆβ 1 = n i=1 (y i ȳ)(x i x) n i=1 (x i x) 2 and ˆβ 0 = ȳ x ˆβ 1, where x = 1/n n i=1 x i and ȳ = 1/n n i=1 y i.

21 More on OLS for Simple Regression From y = β 0 + β 1 x + u, we have β 1 = cov(x, y) var(x). And we have obtained n i=1 ˆβ 1 = (y 1 n i ȳ)(x i x) n i=1 n i=1 (x i x) 2 = (y i ȳ)(x i x) cov(x, n i=1 (x = ˆ y) i x) 2 var(x) ˆ Hence β 1 measures the correlation between y and x. 1 n

22 True or False? In the simple regression model, y = β 0 + β 1 x + u. β 0 is the mean of y β 1 is the correlation coefficient between x and y

23 Estimated Residual Let û i = y i ( ˆβ 0 + ˆβ 1 x i ). From the first-order conditions we have û = 1 n n û i = 0, i=1 and 1 n n x i û i = 0. i=1

24 Connection between Simple and Naive We have Hence { yi = ˆβ 0 + ˆβ 1 x i + û i ȳ = ˆβ 0 + ˆβ 1 x + 0. y i ȳ = ˆβ 1 (x i x) + û i. Using the formula for the naive regression, we obtain: ˆβ 1 = n i=1 (y i ȳ)(x i x) n i=1 (x i x) 2.

25 Regression Line For the simple regression model, y = β 0 + β 1 x + u. We can define a regression line : y = ˆβ 0 + ˆβ 1 x. It is easy to show that ȳ = ˆβ 0 + ˆβ 1 x.

26 In Matrix Language For models with two or more regressors, the expression for ˆβ i are very complicated. However, we can use matrix language to obtain more beautiful and more memorable expressions. Let Y = y 1 y 2. y n 1 x 11 x 1k 1 x 21 x 2k., X =.., β = 1 x n1 x nk Then we may write the multiple regression as Y = X β + u. β 0 β 1. β k, u = u 1 u 2. u n

27 Some Special Vectors and Matrices Vector of ones, ι = (1, 1,..., 1). For a vector of the same length, we have n x i = x ι = ι x, i=1 and 1 n n x i = (ι ι) 1 ι x. i=1 Vector of standard basis, e 1 = (1, 0, 0,..., 0),e 2 = (0, 1, 0,..., 0), etc. Identity matrix, I. Projection matrix, square matrices that satisfy P 2 = P. If P is symmetric, it is called an orthogonal projection (e.g., P = X (X X ) 1 X ) [ ] 0 0 Oblique projection, e.g., P = X (W X ) 1 W, P =. α 1 If P is an orthogonal projection, so is I P.

28 Range of Matrix The span of a set of vectors is the set of all linear combinations of the vectors. The range of a matrix X, R(X ), is the span of the columns of X. R(X ) is the orthogonal complement R(X ), which contains all vectors that is orthogonal to R(X ). Two vectors, x and y, are orthogonal if x y = x y = 0. A vector y is orthogonal to a subspace U if for all x U, x ([ y = 0. ]) 1 R is the x-axis. 0

29 Orthogonal Projection on R(X ) By definition, the orthogonal projection of y on R(X ) can be represented by X β, where β is a vector. We denote proj(y X ) P X y = X β. y X β should be orthogonal to every element in R(X ), which include every column of X. Then we may solve X (y X β) = 0 and obtain β = (X X ) 1 X y. Hence P X = X (X X ) 1 X is the orthogonal projection on R(X ). I P X is the orthogonal projection on R(X ), or equivalently, N (X ).

30 Vector Differentiation Let z = (z 1,..., z k ) be a vector of variables and f (z) be a function of z. Then f z = f z 1 f z 2. f z k.

31 Vector Differentiation In particular, if f (z) = a z, where a is a vector of constants. Then z (a z) = a = z (z a) If f (z) = Az is a vector-valued function, where A is a matrix, then z (Az) = A.

32 Vector Differentiation of Quadratic Form If f (z) = z Az, where A is a matrix, then z (z Az) = (A + A )z. If A is symmetric, ie, A = A, then z (z Az) = 2Az. In particular, when A = I, the identity matrix, then z (z z) = 2z.

33 OLS in Matrix The least square problem can be written as min(y X β) (Y X β). β The first-order condition in matrix form: 2X (Y X ˆβ) = 0. Solving for β, ˆβ = (X X ) 1 X Y. The matrix of X X is invertible since we rule out perfect collinearity. X ˆβ is nothing but the orthogonal projection of Y on R(X ). If there is only one regressor and there is no constant term, X is a vector. Then the above expression reduces to the naive linear regression estimator.

34 An Equivalent Derivation The least square problem can be written as min β n (y i x i β) 2, i=1 where x i = (1, x i1,..., x ik ) and β = (β 0, β 1,..., β k ). The first-order condition in matrix form: n 2x i (y i x i ˆβ) = 0. i=1 Solving for β, ( n ) 1 ( n ) ˆβ = x i x i x i y i. i=1 i=1

35 Equivalence We can check that X X = n x i x i, and X Y = i=1 n x i y i. i=1 If there is only one regressor and there is no constant term, x i is a scalar. Then the above expression reduces to the naive linear regression estimator.

36 The Population Moments From the assumption E(u x) = 0, we have E(u) = 0, and E(ux j ) = 0, j = 1,..., k. This is E(y (β 0 + β 1 x β k x k )) = 0 E((y (β 0 + β 1 x β k x k ))x 1 ) = 0. E((y (β 0 + β 1 x β k x k ))x k ) = 0 The above equations are called moment conditions.

37 The Sample Moments We can estimate population moments by sample moments. For example, the sample moment of E(u) is 1 n n u i = 1 n i=1 n (y i (β 0 + β 1 x i1 + + β k x ik )). i=1 Similarly, the sample counterpart of E(ux j ) = 0 is 1 n n u i x ij = 1 n i=1 n (y i (β 0 + β 1 x i1 + + β k x ik ))x ij = 0. i=1

38 Method of Moments (MM) Plug the sample moments into the moment conditions, we obtain 1 n n (y i ( ˆβ 0 + ˆβ 1 x i1 + + ˆβ k x ik )) = 0, i=1 and 1 n n (y i ( ˆβ 0 + ˆβ 1 x i1 + + ˆβ k x ik ))x ij = 0, j = 1,..., k. i=1 We can see that these equations are the same as those in the first-order conditions of the OLS.

39 The Distribution Assumption Under CLR Assumption (6), u is normally distributed with mean 0 and variance σ 2. The density function of u is given by p(u; σ) = 1 ) exp ( u2 2πσ 2σ 2. Then we can estimate the linear regression model using MLE. More generally, we can assume other distributional function for u, t-distribution for example.

40 Likelihood Function By the Assumption (2), random sampling, the joint distribution of (u 1,..., u n ) is p(u 1,..., u n ; θ) = p(u 1 ; θ)p(u 2 ; θ) p(u n ; θ). Given observations (Y, X ), the likelihood function is defined as p(β, θ y, X ) = p(y 1 x 1β,..., y n x nβ; θ) = p(y 1 x 1β; θ)p(y 2 x 2 β; θ) p(y n x nβ; θ).

41 Maximum Likelihood Estimation MLE implicitly assumes that what happens should most likely happen. MLE is to solve for ˆβ and ˆθ such that the likelihood function is maximized, max p(β, θ y, X ). β,θ In practice, we usually maximize the log likelihood function: log(p(β, θ y, X )) = n log(p(y i x i β; θ)). i=1

42 MLE of Classical Linear Regression We assume u i iid N(0, σ 2 ). The log likelihood function is log(p(β, σ y, X )) = n 2 The first-order condition for β is log(2π) n log(σ) 1 2σ 2 n x i (y i x i ˆβ) = 0. i=1 This yields the same ˆβ as in OLS. n (y i x i β) 2. i=1

43 Definition We call an estimator ˆβ is unbiased if E ˆβ = β. ˆβ is a random variable. For example, the OLS estimator ˆβ = (X X ) 1 X Y is random since both X and Y are sampled from a population. Given a sample, however, ˆβ is determined. So unbiasedness is NOT a measure of how good a particular estimate is, but a property of a good procedure.

44 The Unbiasedness of OLS Estimator Theorem: Under Assumptions (1) through (4), we have E( ˆβ j ) = β j, j = 0, 1,..., k. Proof: E( ˆβ) = E(X X ) 1 X Y = E(X X ) 1 X (X β+u) = β+e(x X ) 1 X U = β.

45 Omitted Variable Bias When we, mistakenly or due to lack of data, exclude one or more relevant variables, OLS yields biased estimates. This bias is called omitted variable bias. For example, suppose the wage of a worker is determined by both his education and his innate ability: wage = β 0 + β 1 education + β 2 abililty + u. The ability, however, is not observable. We may have to estimate the following model, where v = β 2 abililty + u. wage = β 0 + β 1 education + v,

46 The General Case Suppose the true model, in matrix form, is Y = X 1 β 1 + X 2 β 2 + U, (3) where β 1 is the parameter of interest. However, we omit X 2 and estimate Y = X 1 β 1 + V. (4) Denote the OLS estimator of β 1 in (3) as ˆβ 1 and the OLS estimator of β 1 in (4) as β 1. Then E( β 1 X 1, X 2 ) = β 1 + (X 1X 1 ) 1 X 1X 2 β 2.

47 Formula of Omitted-Variable Bias Suppose we only omit one relevant variable, ie, X 2 is a vector. Then (X 1 X 1) 1 X 1 X 2 is the OLS estimator of the following regression: X 2 = X 1 δ + W. So we have E( β 1 X 1, X 2 ) = β 1 + ˆδβ 2.

48 A Special Case Suppose the true model is y = β 0 + β 1 x 1 + β 2 x 2 + u. But we estimated y = β 0 + β 1 x 1 + ṽ. From the formula of omitted-variable bias, E( β 1 x 1, x 2 ) = β 1 + ˆδ 1 β 2, where ˆδ 1 is the OLS estimate of δ 1 in x 2 = δ 0 + δ 1 x 1 + w.

49 Bias Up or Down? We have E( β 1 x 1, x 2 ) = β 1 + ˆδ 1 β 2. Recall that δ 1 measures the correlation between x 1 and x 2. Hence we have OLS Bias corr(x 1, x 2 ) > 0 corr(x 1, x 2 ) < 0 β 2 > 0 β 2 < 0

50 Return to Education Back to our example, suppose the wage of a worker is determined by both his education and his innate ability: wage = β 0 + β 1 education + β 2 abililty + u. The ability, however, is not observable. We may have to estimate the following model, where v = β 2 abililty + u. wage = β 0 + β 1 education + v, Are we going to overestimate or underestimate the return to education?

51 Definition We say ˆβ is consistent if ˆβ β as n. This basically says, if we observe more and more, we can estimate our model more and more accurately till exactness.

52 Law of Large Number Let x 1, x 2,..., x n be iid random variables with mean µ. Then 1 n n x i p µ. i=1

53 LLN for Vectors and Matrices The x i in LLN can be vectors. And if x i,1 x i,2 Ex = E. = µ = then x i,k 1 n n x i p µ. i=1 The same is also true for matrices. µ 1 µ 2. µ k,

54 Consistency of OLS Estimator We have ˆβ = β + ( 1 n ) 1 ( n x i x i 1 n i=1 ) n x i u i. i=1 If Ex i x i = Q, and Ex i u i = 0, then by LLN we have ˆβ p β.

55 Inconsistency of OLS Estimator When Ex i u i = 0, then ˆβ p β + Q. Inconsistency occurs when x i is correlated with u i, or, x is endogenous. Q is called asymptotic bias.

56 Relative Efficiency If ˆθ and θ are two unbiased estimators of θ, ˆθ is efficient relative to θ if var(ˆθ) var( θ) for all θ, with strict inequality for at least one θ. Relative efficiency compares preciseness of estimators. Example: Suppose we want to estimate the population mean µ of an i.i.d. sample {x i, i = 1,..., n}. Both x and x 1 are unbiased estimators, however, x is more efficient since var ( x) = var(x 1) n var(x 1 ). If θ is a vector, we compare the covariance matrices of ˆθ and θ in the sense of positive definiteness.

57 Covariance Matrix of A Random Vector The variance of a scalar random variable x is var(x) = E(x Ex) 2. If x is a vector with two elements, x = ( x1 x 2 ), then the variance of x is a 2-by-2 matrix (we call covariance matrix ): Σ x = ( var(x1 ) cov(x 1, x 2 ) cov(x 2, x 1 ) var(x 2 ) ), where cov(x 1, x 2 ) is the covariance between x 1 and x 2 : cov(x 1, x 2 ) = E(x 1 Ex 1 )(x 2 Ex 2 ).

58 Covariance Matrix of A Random Vector More generally, if x is a vector with n elements, x 1 x 2 x =., x n then the covariance matrix of x is a n-by-n matrix: var(x 1 ) cov(x 1, x 2 ) cov(x 1, x n ) cov(x 2, x 1 ) var(x 2 ) cov(x 2, x n ) Σ x =.... cov(x n, x 1 ) cov(x n, x 2 ) var(x n )

59 Covariance Matrix of A Random Vector The covariance matrix is the second moment of a random vector: Σ x = E(x Ex)(x Ex). It is obvious that Σ x is a symmetric matrix.

60 The Formula of Covariance Matrix Given random vectors x and y, if y = Ax, where A is a matrix. Then Σ y = AΣ x A.

61 Covariance Matrix of the Residual Write the original linear regression model as y i = x i β + u i, where x i = (1, x i1,..., x ik ) β = (β 0, β 1,..., β k ). Eu i = 0 Assumption (4) zero conditional mean Eu 2 i = σ 2 Assumption (5) homoscedasticity Eu i u j = 0 for i j Assumption (2) random sampling What is the covariance matrix for U = (u 1, u 2,..., u n )?

62 Covariance Matrix of the OLS Estimator The covariance matrix for U = (u 1, u 2,..., u n ) is Σ u = σ 2 I, where I is the identity matrix. We have ˆβ = β + (X X ) 1 X U. The covariance matrix of ˆβ is then Σ ˆβ = σ2 (X X ) 1. The diagonal elements of Σ ˆβ give the standard error of ˆβ. If β is another unbiased estimator of β with covariance matrix Σ β, we say ˆβ is more efficient relative to β if Σ β Σ ˆβ is semi-positive definite for all β, with strict positive definiteness for at least one β.

63 Simple Regression For a simple regression, We can obtain Σ = y = β 0 + β 1 x + u. σ 2 ( n i (x i x) 2 i x i 2 i x i i x i n ). The variance of ˆβ 1 is var( ˆβ 1 ) = σ 2 i (x i x) 2. The less σ 2, the more accurate ˆβ 1 is. The more variation in x, the more accurate ˆβ 1 is. And the more sample size, the more accurate ˆβ 1 is.

64 Is OLS A Good Estimator? Define what is good : Is it unbiased? Is it consistent? Does it have a small variance?

65 Gauss-Markov Theorem Theorem: Under Assumption 1-5, OLS is BLUE (Best Linear Unbiased Estimator). Define best : smallest variance. Define linear : β j = And unbiasedness: E β = β. n w ij y i. (5) i=1 The message: We need not look for alternatives that are unbiased and are in the form of (5).

66 Time Series Regression Assumptions (1) Linearity y t = β 0 + β 1 x 1t + β k x kt + u t. (2) (x t, y t ) are jointly stationary and ergodic. (3) No perfect collinearity. (4) Past and contemporary exogeneity E(u t x t, x t 1,...) = 0.

67 Stationarity Weak stationarity. Ex t = µ, cov(x t, x t τ ) = γ τ, τ =..., 2, 1, 0, 1, 2,.... Strict stationarity. F (X t,..., X T ) = F (X t+τ,..., X T +τ ), where F is the joint distribution function.

68 Ergodicity An ergodic time series (x t ) has the property that x t and x t k are independent if k is large. If (x t ) is stationary and ergodic, then a law of large number holds, 1 n x t Ex a.s.. n t=1

69 Exogeneity in Time Series Context Strict exogeneity. E(u t X ) = E(u t..., x t+1, x t, x t 1,...) = 0. Past and Contemporary exogeneity. E(u t x t, x t 1,...) = 0.

70 Consistency of OLS Under the Time Series Regression Assumptions (1)-(4), the OLS estimator of the time series regression is consistent.

71 Special Cases Autoregressive models (AR), y t = β 0 + β 1 y t β p y t p + u t. Autoregressive distributed lag models (ARDL) y t = β 0 + β 1 y t β p y t p + γ 1 x t γ q x t q + u t. Autoregressive models with exogenous variable (ARX) y t = β 0 + β 1 y t β p y t p + γ 1 x t + + γ q x t q+1 + u t, where (x t ) is past and contemporary exogenous.

72 Beat OLS in Efficiency OLS is consistent, but is not efficient in general. u t may be serially correlated and/or heteroscedastic. In such cases, GLS would be a better alternative. A simple way to account for serial correlation is to explicitly model u t as an ARMA process: y t = x β + u t, where u t ARMA(p, q). But OLS is no longer able to estimate this model. Instead, nonlinear least square or MLE should be used.

73 Granger Causality Granger causality means that if x causes y, the x is a useful predictor of y t. Granger Causality Test. In the model y t = β 0 + β 1 y t β p y t p + γ 1 x t γ q x t q + u t. We test: H 0 : γ 1 = = γ q = 0. The above test should be more appropriately called a non-causality test. Or even more precisely, a non-predicting test. Example: Monetary cause of inflation. π t = β 0 +β 1 π t 1 + +β p π t p +γ 1 M1 t 1 + +γ q M1 t q +u t.

Dealing With Endogeneity

Dealing With Endogeneity Dealing With Endogeneity Junhui Qian December 22, 2014 Outline Introduction Instrumental Variable Instrumental Variable Estimation Two-Stage Least Square Estimation Panel Data Endogeneity in Econometrics

More information

Sample Problems. Note: If you find the following statements true, you should briefly prove them. If you find them false, you should correct them.

Sample Problems. Note: If you find the following statements true, you should briefly prove them. If you find them false, you should correct them. Sample Problems 1. True or False Note: If you find the following statements true, you should briefly prove them. If you find them false, you should correct them. (a) The sample average of estimated residuals

More information

Econometrics I KS. Module 2: Multivariate Linear Regression. Alexander Ahammer. This version: April 16, 2018

Econometrics I KS. Module 2: Multivariate Linear Regression. Alexander Ahammer. This version: April 16, 2018 Econometrics I KS Module 2: Multivariate Linear Regression Alexander Ahammer Department of Economics Johannes Kepler University of Linz This version: April 16, 2018 Alexander Ahammer (JKU) Module 2: Multivariate

More information

Linear models. Linear models are computationally convenient and remain widely used in. applied econometric research

Linear models. Linear models are computationally convenient and remain widely used in. applied econometric research Linear models Linear models are computationally convenient and remain widely used in applied econometric research Our main focus in these lectures will be on single equation linear models of the form y

More information

Multiple Regression Analysis. Part III. Multiple Regression Analysis

Multiple Regression Analysis. Part III. Multiple Regression Analysis Part III Multiple Regression Analysis As of Sep 26, 2017 1 Multiple Regression Analysis Estimation Matrix form Goodness-of-Fit R-square Adjusted R-square Expected values of the OLS estimators Irrelevant

More information

Least Squares Estimation-Finite-Sample Properties

Least Squares Estimation-Finite-Sample Properties Least Squares Estimation-Finite-Sample Properties Ping Yu School of Economics and Finance The University of Hong Kong Ping Yu (HKU) Finite-Sample 1 / 29 Terminology and Assumptions 1 Terminology and Assumptions

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

LECTURE 2 LINEAR REGRESSION MODEL AND OLS

LECTURE 2 LINEAR REGRESSION MODEL AND OLS SEPTEMBER 29, 2014 LECTURE 2 LINEAR REGRESSION MODEL AND OLS Definitions A common question in econometrics is to study the effect of one group of variables X i, usually called the regressors, on another

More information

Econometrics - 30C00200

Econometrics - 30C00200 Econometrics - 30C00200 Lecture 11: Heteroskedasticity Antti Saastamoinen VATT Institute for Economic Research Fall 2015 30C00200 Lecture 11: Heteroskedasticity 12.10.2015 Aalto University School of Business

More information

Multiple Linear Regression CIVL 7012/8012

Multiple Linear Regression CIVL 7012/8012 Multiple Linear Regression CIVL 7012/8012 2 Multiple Regression Analysis (MLR) Allows us to explicitly control for many factors those simultaneously affect the dependent variable This is important for

More information

Diagnostics of Linear Regression

Diagnostics of Linear Regression Diagnostics of Linear Regression Junhui Qian October 7, 14 The Objectives After estimating a model, we should always perform diagnostics on the model. In particular, we should check whether the assumptions

More information

Final Exam. Economics 835: Econometrics. Fall 2010

Final Exam. Economics 835: Econometrics. Fall 2010 Final Exam Economics 835: Econometrics Fall 2010 Please answer the question I ask - no more and no less - and remember that the correct answer is often short and simple. 1 Some short questions a) For each

More information

Review of Econometrics

Review of Econometrics Review of Econometrics Zheng Tian June 5th, 2017 1 The Essence of the OLS Estimation Multiple regression model involves the models as follows Y i = β 0 + β 1 X 1i + β 2 X 2i + + β k X ki + u i, i = 1,...,

More information

Lecture: Simultaneous Equation Model (Wooldridge s Book Chapter 16)

Lecture: Simultaneous Equation Model (Wooldridge s Book Chapter 16) Lecture: Simultaneous Equation Model (Wooldridge s Book Chapter 16) 1 2 Model Consider a system of two regressions y 1 = β 1 y 2 + u 1 (1) y 2 = β 2 y 1 + u 2 (2) This is a simultaneous equation model

More information

Multivariate Regression Analysis

Multivariate Regression Analysis Matrices and vectors The model from the sample is: Y = Xβ +u with n individuals, l response variable, k regressors Y is a n 1 vector or a n l matrix with the notation Y T = (y 1,y 2,...,y n ) 1 x 11 x

More information

The general linear regression with k explanatory variables is just an extension of the simple regression as follows

The general linear regression with k explanatory variables is just an extension of the simple regression as follows 3. Multiple Regression Analysis The general linear regression with k explanatory variables is just an extension of the simple regression as follows (1) y i = β 0 + β 1 x i1 + + β k x ik + u i. Because

More information

Statistics 910, #5 1. Regression Methods

Statistics 910, #5 1. Regression Methods Statistics 910, #5 1 Overview Regression Methods 1. Idea: effects of dependence 2. Examples of estimation (in R) 3. Review of regression 4. Comparisons and relative efficiencies Idea Decomposition Well-known

More information

The Simple Linear Regression Model

The Simple Linear Regression Model The Simple Linear Regression Model Lesson 3 Ryan Safner 1 1 Department of Economics Hood College ECON 480 - Econometrics Fall 2017 Ryan Safner (Hood College) ECON 480 - Lesson 3 Fall 2017 1 / 77 Bivariate

More information

Intermediate Econometrics

Intermediate Econometrics Intermediate Econometrics Heteroskedasticity Text: Wooldridge, 8 July 17, 2011 Heteroskedasticity Assumption of homoskedasticity, Var(u i x i1,..., x ik ) = E(u 2 i x i1,..., x ik ) = σ 2. That is, the

More information

Intermediate Econometrics

Intermediate Econometrics Intermediate Econometrics Markus Haas LMU München Summer term 2011 15. Mai 2011 The Simple Linear Regression Model Considering variables x and y in a specific population (e.g., years of education and wage

More information

Econometrics I Lecture 3: The Simple Linear Regression Model

Econometrics I Lecture 3: The Simple Linear Regression Model Econometrics I Lecture 3: The Simple Linear Regression Model Mohammad Vesal Graduate School of Management and Economics Sharif University of Technology 44716 Fall 1397 1 / 32 Outline Introduction Estimating

More information

ECON The Simple Regression Model

ECON The Simple Regression Model ECON 351 - The Simple Regression Model Maggie Jones 1 / 41 The Simple Regression Model Our starting point will be the simple regression model where we look at the relationship between two variables In

More information

Applied Health Economics (for B.Sc.)

Applied Health Economics (for B.Sc.) Applied Health Economics (for B.Sc.) Helmut Farbmacher Department of Economics University of Mannheim Autumn Semester 2017 Outlook 1 Linear models (OLS, Omitted variables, 2SLS) 2 Limited and qualitative

More information

Chapter 2: simple regression model

Chapter 2: simple regression model Chapter 2: simple regression model Goal: understand how to estimate and more importantly interpret the simple regression Reading: chapter 2 of the textbook Advice: this chapter is foundation of econometrics.

More information

The Statistical Property of Ordinary Least Squares

The Statistical Property of Ordinary Least Squares The Statistical Property of Ordinary Least Squares The linear equation, on which we apply the OLS is y t = X t β + u t Then, as we have derived, the OLS estimator is ˆβ = [ X T X] 1 X T y Then, substituting

More information

Econometrics I KS. Module 1: Bivariate Linear Regression. Alexander Ahammer. This version: March 12, 2018

Econometrics I KS. Module 1: Bivariate Linear Regression. Alexander Ahammer. This version: March 12, 2018 Econometrics I KS Module 1: Bivariate Linear Regression Alexander Ahammer Department of Economics Johannes Kepler University of Linz This version: March 12, 2018 Alexander Ahammer (JKU) Module 1: Bivariate

More information

Econometrics Summary Algebraic and Statistical Preliminaries

Econometrics Summary Algebraic and Statistical Preliminaries Econometrics Summary Algebraic and Statistical Preliminaries Elasticity: The point elasticity of Y with respect to L is given by α = ( Y/ L)/(Y/L). The arc elasticity is given by ( Y/ L)/(Y/L), when L

More information

Review of Classical Least Squares. James L. Powell Department of Economics University of California, Berkeley

Review of Classical Least Squares. James L. Powell Department of Economics University of California, Berkeley Review of Classical Least Squares James L. Powell Department of Economics University of California, Berkeley The Classical Linear Model The object of least squares regression methods is to model and estimate

More information

Problem Set #6: OLS. Economics 835: Econometrics. Fall 2012

Problem Set #6: OLS. Economics 835: Econometrics. Fall 2012 Problem Set #6: OLS Economics 835: Econometrics Fall 202 A preliminary result Suppose we have a random sample of size n on the scalar random variables (x, y) with finite means, variances, and covariance.

More information

Linear Regression With Special Variables

Linear Regression With Special Variables Linear Regression With Special Variables Junhui Qian December 21, 2014 Outline Standardized Scores Quadratic Terms Interaction Terms Binary Explanatory Variables Binary Choice Models Standardized Scores:

More information

Introductory Econometrics

Introductory Econometrics Based on the textbook by Wooldridge: : A Modern Approach Robert M. Kunst robert.kunst@univie.ac.at University of Vienna and Institute for Advanced Studies Vienna November 23, 2013 Outline Introduction

More information

Introduction to Econometrics

Introduction to Econometrics Introduction to Econometrics T H I R D E D I T I O N Global Edition James H. Stock Harvard University Mark W. Watson Princeton University Boston Columbus Indianapolis New York San Francisco Upper Saddle

More information

Econometrics Honor s Exam Review Session. Spring 2012 Eunice Han

Econometrics Honor s Exam Review Session. Spring 2012 Eunice Han Econometrics Honor s Exam Review Session Spring 2012 Eunice Han Topics 1. OLS The Assumptions Omitted Variable Bias Conditional Mean Independence Hypothesis Testing and Confidence Intervals Homoskedasticity

More information

ECNS 561 Multiple Regression Analysis

ECNS 561 Multiple Regression Analysis ECNS 561 Multiple Regression Analysis Model with Two Independent Variables Consider the following model Crime i = β 0 + β 1 Educ i + β 2 [what else would we like to control for?] + ε i Here, we are taking

More information

Wooldridge, Introductory Econometrics, 4th ed. Chapter 2: The simple regression model

Wooldridge, Introductory Econometrics, 4th ed. Chapter 2: The simple regression model Wooldridge, Introductory Econometrics, 4th ed. Chapter 2: The simple regression model Most of this course will be concerned with use of a regression model: a structure in which one or more explanatory

More information

Summer School in Statistics for Astronomers V June 1 - June 6, Regression. Mosuk Chow Statistics Department Penn State University.

Summer School in Statistics for Astronomers V June 1 - June 6, Regression. Mosuk Chow Statistics Department Penn State University. Summer School in Statistics for Astronomers V June 1 - June 6, 2009 Regression Mosuk Chow Statistics Department Penn State University. Adapted from notes prepared by RL Karandikar Mean and variance Recall

More information

Applied Quantitative Methods II

Applied Quantitative Methods II Applied Quantitative Methods II Lecture 4: OLS and Statistics revision Klára Kaĺıšková Klára Kaĺıšková AQM II - Lecture 4 VŠE, SS 2016/17 1 / 68 Outline 1 Econometric analysis Properties of an estimator

More information

Introduction to Estimation Methods for Time Series models. Lecture 1

Introduction to Estimation Methods for Time Series models. Lecture 1 Introduction to Estimation Methods for Time Series models Lecture 1 Fulvio Corsi SNS Pisa Fulvio Corsi Introduction to Estimation () Methods for Time Series models Lecture 1 SNS Pisa 1 / 19 Estimation

More information

Econ 510 B. Brown Spring 2014 Final Exam Answers

Econ 510 B. Brown Spring 2014 Final Exam Answers Econ 510 B. Brown Spring 2014 Final Exam Answers Answer five of the following questions. You must answer question 7. The question are weighted equally. You have 2.5 hours. You may use a calculator. Brevity

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

ECON3150/4150 Spring 2015

ECON3150/4150 Spring 2015 ECON3150/4150 Spring 2015 Lecture 3&4 - The linear regression model Siv-Elisabeth Skjelbred University of Oslo January 29, 2015 1 / 67 Chapter 4 in S&W Section 17.1 in S&W (extended OLS assumptions) 2

More information

ECON2228 Notes 2. Christopher F Baum. Boston College Economics. cfb (BC Econ) ECON2228 Notes / 47

ECON2228 Notes 2. Christopher F Baum. Boston College Economics. cfb (BC Econ) ECON2228 Notes / 47 ECON2228 Notes 2 Christopher F Baum Boston College Economics 2014 2015 cfb (BC Econ) ECON2228 Notes 2 2014 2015 1 / 47 Chapter 2: The simple regression model Most of this course will be concerned with

More information

ECONOMETRICS HONOR S EXAM REVIEW SESSION

ECONOMETRICS HONOR S EXAM REVIEW SESSION ECONOMETRICS HONOR S EXAM REVIEW SESSION Eunice Han ehan@fas.harvard.edu March 26 th, 2013 Harvard University Information 2 Exam: April 3 rd 3-6pm @ Emerson 105 Bring a calculator and extra pens. Notes

More information

Advanced Econometrics I

Advanced Econometrics I Lecture Notes Autumn 2010 Dr. Getinet Haile, University of Mannheim 1. Introduction Introduction & CLRM, Autumn Term 2010 1 What is econometrics? Econometrics = economic statistics economic theory mathematics

More information

Linear Models in Econometrics

Linear Models in Econometrics Linear Models in Econometrics Nicky Grant At the most fundamental level econometrics is the development of statistical techniques suited primarily to answering economic questions and testing economic theories.

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

Economics 308: Econometrics Professor Moody

Economics 308: Econometrics Professor Moody Economics 308: Econometrics Professor Moody References on reserve: Text Moody, Basic Econometrics with Stata (BES) Pindyck and Rubinfeld, Econometric Models and Economic Forecasts (PR) Wooldridge, Jeffrey

More information

Economics 113. Simple Regression Assumptions. Simple Regression Derivation. Changing Units of Measurement. Nonlinear effects

Economics 113. Simple Regression Assumptions. Simple Regression Derivation. Changing Units of Measurement. Nonlinear effects Economics 113 Simple Regression Models Simple Regression Assumptions Simple Regression Derivation Changing Units of Measurement Nonlinear effects OLS and unbiased estimates Variance of the OLS estimates

More information

Homoskedasticity. Var (u X) = σ 2. (23)

Homoskedasticity. Var (u X) = σ 2. (23) Homoskedasticity How big is the difference between the OLS estimator and the true parameter? To answer this question, we make an additional assumption called homoskedasticity: Var (u X) = σ 2. (23) This

More information

Environmental Econometrics

Environmental Econometrics Environmental Econometrics Syngjoo Choi Fall 2008 Environmental Econometrics (GR03) Fall 2008 1 / 37 Syllabus I This is an introductory econometrics course which assumes no prior knowledge on econometrics;

More information

1. The Multivariate Classical Linear Regression Model

1. The Multivariate Classical Linear Regression Model Business School, Brunel University MSc. EC550/5509 Modelling Financial Decisions and Markets/Introduction to Quantitative Methods Prof. Menelaos Karanasos (Room SS69, Tel. 08956584) Lecture Notes 5. The

More information

Applied Econometrics (QEM)

Applied Econometrics (QEM) Applied Econometrics (QEM) based on Prinicples of Econometrics Jakub Mućk Department of Quantitative Economics Jakub Mućk Applied Econometrics (QEM) Meeting #3 1 / 42 Outline 1 2 3 t-test P-value Linear

More information

1. You have data on years of work experience, EXPER, its square, EXPER2, years of education, EDUC, and the log of hourly wages, LWAGE

1. You have data on years of work experience, EXPER, its square, EXPER2, years of education, EDUC, and the log of hourly wages, LWAGE 1. You have data on years of work experience, EXPER, its square, EXPER, years of education, EDUC, and the log of hourly wages, LWAGE You estimate the following regressions: (1) LWAGE =.00 + 0.05*EDUC +

More information

Introductory Econometrics

Introductory Econometrics Based on the textbook by Wooldridge: : A Modern Approach Robert M. Kunst robert.kunst@univie.ac.at University of Vienna and Institute for Advanced Studies Vienna October 16, 2013 Outline Introduction Simple

More information

Outline. Nature of the Problem. Nature of the Problem. Basic Econometrics in Transportation. Autocorrelation

Outline. Nature of the Problem. Nature of the Problem. Basic Econometrics in Transportation. Autocorrelation 1/30 Outline Basic Econometrics in Transportation Autocorrelation Amir Samimi What is the nature of autocorrelation? What are the theoretical and practical consequences of autocorrelation? Since the assumption

More information

7 Introduction to Time Series

7 Introduction to Time Series Econ 495 - Econometric Review 1 7 Introduction to Time Series 7.1 Time Series vs. Cross-Sectional Data Time series data has a temporal ordering, unlike cross-section data, we will need to changes some

More information

Quantitative Methods I: Regression diagnostics

Quantitative Methods I: Regression diagnostics Quantitative Methods I: Regression University College Dublin 10 December 2014 1 Assumptions and errors 2 3 4 Outline Assumptions and errors 1 Assumptions and errors 2 3 4 Assumptions: specification Linear

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

08 Endogenous Right-Hand-Side Variables. Andrius Buteikis,

08 Endogenous Right-Hand-Side Variables. Andrius Buteikis, 08 Endogenous Right-Hand-Side Variables Andrius Buteikis, andrius.buteikis@mif.vu.lt http://web.vu.lt/mif/a.buteikis/ Introduction Consider a simple regression model: Y t = α + βx t + u t Under the classical

More information

1 Appendix A: Matrix Algebra

1 Appendix A: Matrix Algebra Appendix A: Matrix Algebra. Definitions Matrix A =[ ]=[A] Symmetric matrix: = for all and Diagonal matrix: 6=0if = but =0if 6= Scalar matrix: the diagonal matrix of = Identity matrix: the scalar matrix

More information

Introduction to Regression Analysis. Dr. Devlina Chatterjee 11 th August, 2017

Introduction to Regression Analysis. Dr. Devlina Chatterjee 11 th August, 2017 Introduction to Regression Analysis Dr. Devlina Chatterjee 11 th August, 2017 What is regression analysis? Regression analysis is a statistical technique for studying linear relationships. One dependent

More information

Multiple Regression Analysis

Multiple Regression Analysis Multiple Regression Analysis y = 0 + 1 x 1 + x +... k x k + u 6. Heteroskedasticity What is Heteroskedasticity?! Recall the assumption of homoskedasticity implied that conditional on the explanatory variables,

More information

Econometrics. Week 8. Fall Institute of Economic Studies Faculty of Social Sciences Charles University in Prague

Econometrics. Week 8. Fall Institute of Economic Studies Faculty of Social Sciences Charles University in Prague Econometrics Week 8 Institute of Economic Studies Faculty of Social Sciences Charles University in Prague Fall 2012 1 / 25 Recommended Reading For the today Instrumental Variables Estimation and Two Stage

More information

Economics 536 Lecture 7. Introduction to Specification Testing in Dynamic Econometric Models

Economics 536 Lecture 7. Introduction to Specification Testing in Dynamic Econometric Models University of Illinois Fall 2016 Department of Economics Roger Koenker Economics 536 Lecture 7 Introduction to Specification Testing in Dynamic Econometric Models In this lecture I want to briefly describe

More information

Regression diagnostics

Regression diagnostics Regression diagnostics Kerby Shedden Department of Statistics, University of Michigan November 5, 018 1 / 6 Motivation When working with a linear model with design matrix X, the conventional linear model

More information

Lecture 4: Multivariate Regression, Part 2

Lecture 4: Multivariate Regression, Part 2 Lecture 4: Multivariate Regression, Part 2 Gauss-Markov Assumptions 1) Linear in Parameters: Y X X X i 0 1 1 2 2 k k 2) Random Sampling: we have a random sample from the population that follows the above

More information

Applied Statistics and Econometrics

Applied Statistics and Econometrics Applied Statistics and Econometrics Lecture 6 Saul Lach September 2017 Saul Lach () Applied Statistics and Econometrics September 2017 1 / 53 Outline of Lecture 6 1 Omitted variable bias (SW 6.1) 2 Multiple

More information

Econometrics. Week 4. Fall Institute of Economic Studies Faculty of Social Sciences Charles University in Prague

Econometrics. Week 4. Fall Institute of Economic Studies Faculty of Social Sciences Charles University in Prague Econometrics Week 4 Institute of Economic Studies Faculty of Social Sciences Charles University in Prague Fall 2012 1 / 23 Recommended Reading For the today Serial correlation and heteroskedasticity in

More information

Short Questions (Do two out of three) 15 points each

Short Questions (Do two out of three) 15 points each Econometrics Short Questions Do two out of three) 5 points each ) Let y = Xβ + u and Z be a set of instruments for X When we estimate β with OLS we project y onto the space spanned by X along a path orthogonal

More information

Multivariate Regression: Part I

Multivariate Regression: Part I Topic 1 Multivariate Regression: Part I ARE/ECN 240 A Graduate Econometrics Professor: Òscar Jordà Outline of this topic Statement of the objective: we want to explain the behavior of one variable as a

More information

Econometrics of Panel Data

Econometrics of Panel Data Econometrics of Panel Data Jakub Mućk Meeting # 6 Jakub Mućk Econometrics of Panel Data Meeting # 6 1 / 36 Outline 1 The First-Difference (FD) estimator 2 Dynamic panel data models 3 The Anderson and Hsiao

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

Regression and Statistical Inference

Regression and Statistical Inference Regression and Statistical Inference Walid Mnif wmnif@uwo.ca Department of Applied Mathematics The University of Western Ontario, London, Canada 1 Elements of Probability 2 Elements of Probability CDF&PDF

More information

Making sense of Econometrics: Basics

Making sense of Econometrics: Basics Making sense of Econometrics: Basics Lecture 2: Simple Regression Egypt Scholars Economic Society Happy Eid Eid present! enter classroom at http://b.socrative.com/login/student/ room name c28efb78 Outline

More information

A Guide to Modern Econometric:

A Guide to Modern Econometric: A Guide to Modern Econometric: 4th edition Marno Verbeek Rotterdam School of Management, Erasmus University, Rotterdam B 379887 )WILEY A John Wiley & Sons, Ltd., Publication Contents Preface xiii 1 Introduction

More information

Lesson 17: Vector AutoRegressive Models

Lesson 17: Vector AutoRegressive Models Dipartimento di Ingegneria e Scienze dell Informazione e Matematica Università dell Aquila, umberto.triacca@ec.univaq.it Vector AutoRegressive models The extension of ARMA models into a multivariate framework

More information

EC212: Introduction to Econometrics Review Materials (Wooldridge, Appendix)

EC212: Introduction to Econometrics Review Materials (Wooldridge, Appendix) 1 EC212: Introduction to Econometrics Review Materials (Wooldridge, Appendix) Taisuke Otsu London School of Economics Summer 2018 A.1. Summation operator (Wooldridge, App. A.1) 2 3 Summation operator For

More information

Basic econometrics. Tutorial 3. Dipl.Kfm. Johannes Metzler

Basic econometrics. Tutorial 3. Dipl.Kfm. Johannes Metzler Basic econometrics Tutorial 3 Dipl.Kfm. Introduction Some of you were asking about material to revise/prepare econometrics fundamentals. First of all, be aware that I will not be too technical, only as

More information

Advanced Quantitative Methods: ordinary least squares

Advanced Quantitative Methods: ordinary least squares Advanced Quantitative Methods: Ordinary Least Squares University College Dublin 31 January 2012 1 2 3 4 5 Terminology y is the dependent variable referred to also (by Greene) as a regressand X are the

More information

IV Estimation and its Limitations: Weak Instruments and Weakly Endogeneous Regressors

IV Estimation and its Limitations: Weak Instruments and Weakly Endogeneous Regressors IV Estimation and its Limitations: Weak Instruments and Weakly Endogeneous Regressors Laura Mayoral IAE, Barcelona GSE and University of Gothenburg Gothenburg, May 2015 Roadmap of the course Introduction.

More information

Applied Econometrics Lecture 1

Applied Econometrics Lecture 1 Lecture 1 1 1 Università di Urbino Università di Urbino PhD Programme in Global Studies Spring 2018 Outline of this module Beyond OLS (very brief sketch) Regression and causality: sources of endogeneity

More information

Quick Review on Linear Multiple Regression

Quick Review on Linear Multiple Regression Quick Review on Linear Multiple Regression Mei-Yuan Chen Department of Finance National Chung Hsing University March 6, 2007 Introduction for Conditional Mean Modeling Suppose random variables Y, X 1,

More information

Wooldridge, Introductory Econometrics, 4th ed. Chapter 15: Instrumental variables and two stage least squares

Wooldridge, Introductory Econometrics, 4th ed. Chapter 15: Instrumental variables and two stage least squares Wooldridge, Introductory Econometrics, 4th ed. Chapter 15: Instrumental variables and two stage least squares Many economic models involve endogeneity: that is, a theoretical relationship does not fit

More information

Lecture 5: Omitted Variables, Dummy Variables and Multicollinearity

Lecture 5: Omitted Variables, Dummy Variables and Multicollinearity Lecture 5: Omitted Variables, Dummy Variables and Multicollinearity R.G. Pierse 1 Omitted Variables Suppose that the true model is Y i β 1 + β X i + β 3 X 3i + u i, i 1,, n (1.1) where β 3 0 but that the

More information

HT Introduction. P(X i = x i ) = e λ λ x i

HT Introduction. P(X i = x i ) = e λ λ x i MODS STATISTICS Introduction. HT 2012 Simon Myers, Department of Statistics (and The Wellcome Trust Centre for Human Genetics) myers@stats.ox.ac.uk We will be concerned with the mathematical framework

More information

THE MULTIVARIATE LINEAR REGRESSION MODEL

THE MULTIVARIATE LINEAR REGRESSION MODEL THE MULTIVARIATE LINEAR REGRESSION MODEL Why multiple regression analysis? Model with more than 1 independent variable: y 0 1x1 2x2 u It allows : -Controlling for other factors, and get a ceteris paribus

More information

AUTOCORRELATION. Phung Thanh Binh

AUTOCORRELATION. Phung Thanh Binh AUTOCORRELATION Phung Thanh Binh OUTLINE Time series Gauss-Markov conditions The nature of autocorrelation Causes of autocorrelation Consequences of autocorrelation Detecting autocorrelation Remedial measures

More information

Making sense of Econometrics: Basics

Making sense of Econometrics: Basics Making sense of Econometrics: Basics Lecture 4: Qualitative influences and Heteroskedasticity Egypt Scholars Economic Society November 1, 2014 Assignment & feedback enter classroom at http://b.socrative.com/login/student/

More information

Time Series Analysis. James D. Hamilton PRINCETON UNIVERSITY PRESS PRINCETON, NEW JERSEY

Time Series Analysis. James D. Hamilton PRINCETON UNIVERSITY PRESS PRINCETON, NEW JERSEY Time Series Analysis James D. Hamilton PRINCETON UNIVERSITY PRESS PRINCETON, NEW JERSEY & Contents PREFACE xiii 1 1.1. 1.2. Difference Equations First-Order Difference Equations 1 /?th-order Difference

More information

Topic 12 Overview of Estimation

Topic 12 Overview of Estimation Topic 12 Overview of Estimation Classical Statistics 1 / 9 Outline Introduction Parameter Estimation Classical Statistics Densities and Likelihoods 2 / 9 Introduction In the simplest possible terms, the

More information

Simple Linear Regression: The Model

Simple Linear Regression: The Model Simple Linear Regression: The Model task: quantifying the effect of change X in X on Y, with some constant β 1 : Y = β 1 X, linear relationship between X and Y, however, relationship subject to a random

More information

ECO375 Tutorial 8 Instrumental Variables

ECO375 Tutorial 8 Instrumental Variables ECO375 Tutorial 8 Instrumental Variables Matt Tudball University of Toronto Mississauga November 16, 2017 Matt Tudball (University of Toronto) ECO375H5 November 16, 2017 1 / 22 Review: Endogeneity Instrumental

More information

Motivation for multiple regression

Motivation for multiple regression Motivation for multiple regression 1. Simple regression puts all factors other than X in u, and treats them as unobserved. Effectively the simple regression does not account for other factors. 2. The slope

More information

The Simple Regression Model. Simple Regression Model 1

The Simple Regression Model. Simple Regression Model 1 The Simple Regression Model Simple Regression Model 1 Simple regression model: Objectives Given the model: - where y is earnings and x years of education - Or y is sales and x is spending in advertising

More information

3. Linear Regression With a Single Regressor

3. Linear Regression With a Single Regressor 3. Linear Regression With a Single Regressor Econometrics: (I) Application of statistical methods in empirical research Testing economic theory with real-world data (data analysis) 56 Econometrics: (II)

More information

Regression with time series

Regression with time series Regression with time series Class Notes Manuel Arellano February 22, 2018 1 Classical regression model with time series Model and assumptions The basic assumption is E y t x 1,, x T = E y t x t = x tβ

More information

Statistics II. Management Degree Management Statistics IIDegree. Statistics II. 2 nd Sem. 2013/2014. Management Degree. Simple Linear Regression

Statistics II. Management Degree Management Statistics IIDegree. Statistics II. 2 nd Sem. 2013/2014. Management Degree. Simple Linear Regression Model 1 2 Ordinary Least Squares 3 4 Non-linearities 5 of the coefficients and their to the model We saw that econometrics studies E (Y x). More generally, we shall study regression analysis. : The regression

More information

Regression with a Single Regressor: Hypothesis Tests and Confidence Intervals

Regression with a Single Regressor: Hypothesis Tests and Confidence Intervals Regression with a Single Regressor: Hypothesis Tests and Confidence Intervals (SW Chapter 5) Outline. The standard error of ˆ. Hypothesis tests concerning β 3. Confidence intervals for β 4. Regression

More information

Ch.10 Autocorrelated Disturbances (June 15, 2016)

Ch.10 Autocorrelated Disturbances (June 15, 2016) Ch10 Autocorrelated Disturbances (June 15, 2016) In a time-series linear regression model setting, Y t = x tβ + u t, t = 1, 2,, T, (10-1) a common problem is autocorrelation, or serial correlation of the

More information

Applied Microeconometrics (L5): Panel Data-Basics

Applied Microeconometrics (L5): Panel Data-Basics Applied Microeconometrics (L5): Panel Data-Basics Nicholas Giannakopoulos University of Patras Department of Economics ngias@upatras.gr November 10, 2015 Nicholas Giannakopoulos (UPatras) MSc Applied Economics

More information