STAT 526 Advanced Statistical Methodology

Size: px
Start display at page:

Download "STAT 526 Advanced Statistical Methodology"

Transcription

1 STAT 526 Advanced Statistical Methodology Fall 2017 Lecture Note 10 Analyzing Clustered/Repeated Categorical Data 0-0

2 Outline Clustered/Repeated Categorical Data Generalized Linear Mixed Models Generalized Estimating Equations Dabao Zhang Page 1

3 Clustered/Repeated Categorical Data Example: Effects of Surface and Vision on Balance An experiment was conducted to study the effects of surface and vision on balance. Forty subjects were studied, twenty males and twenty females. Each subject was tested twice in each of the surface (foam or a normal surface) and eye combinations (with eyes closed or open or with a dome placed over the head) for a total of 12 measures per subject. > data(ctsib, package="faraway"); > str(ctsib) data.frame : 480 obs. of 8 variables: $ Subject: int $ Sex : Factor w/ 2 levels "female","male": $ Age : int $ Height : num $ Weight : num $ Surface: Factor w/ 2 levels "foam","norm": $ Vision : Factor w/ 3 levels "closed","dome",..: $ CTSIB : int > ctsib$stable <- ifelse(ctsib$ctsib==1,1,0); > sum(ctsib$stable); [1] 114 Dabao Zhang Page 2

4 > csglm1 <- glm(stable~sex+age+height+weight+surface+vision,binomial,data=ctsib); > csglm2 <- glm(stable~sex+age+height+weight+surface+vision+factor(subject), binomial,data=ctsib); Warning message: fitted probabilities numerically 0 or 1 occurred in: glm.fit(x = X, y = Y, weights = weights, start = start, etastart = etastart, > anova(csglm1,csglm2,test="chi"); Analysis of Deviance Table... Resid. Df Resid. Dev Df Deviance P(> Chi ) e-20 The small p-value implies a significant subject effect. Note that the fixed subject effects confound these effects of subject-specific variables. When studying y ij = stable ij, i.e., whether the j-th measure of subject i is completely stable, we would rather consider unobserved, along with observed, subject-specific variables which affect y ij. Let x ij be the observed predictors for the j-th measure of subject i. Then the generalized linear model for subject i can be g(e[y ij γ i,x ij ]) = η ij = γ i + x ij β γ i accounts for the effect of unobserved subject-specific variables. x ij includes those observed subject-specific varaibles. Dabao Zhang Page 3

5 Example: Seizure Rates of Epileptics under Treatment In a clinical trial of 59 epileptics, patients were observed for 8 weeks and the number of seizures recorded for a baseline. Then the patients were randomized to treatment by the drug Progabide (31 patients) or the the placebo group (28 patients), and were observed for four 2-week periods with the number of seizures recorded. > data(epilepsy, package="faraway"); > str(epilepsy) data.frame : 295 obs. of 6 variables: $ seizures: num $ id : int $ treat : num $ expind : num $ timeadj : num $ age : num expind: indicates the baseline period by 0 and the treatment period by 1 timeadj: length of the time period Dabao Zhang Page 4

6 ># use matplot (x,y,...) to plot the columns of x against the columns of y > y <- matrix(epilepsy$seizures,nrow=5); > matplot(0:4,sqrt(y),type="l",lty=epilepsy$treat[5*(1:59)]+1, xlab="period",ylab="sqrt(seizures)"); > sepil <- epilepsy[(epilepsy$id<=5) (epilepsy$id<=33&epilepsy$id>=29),]; > sy <- matrix(sepil$seizures,nrow=5); > matplot(0:4,sqrt(sy),type="l",lty=sepil$treat[5*(1:20)]+1, xlab="period",ylab="sqrt(seizures)"); Sqrt(Seizures) Sqrt(Seizures) Period Q: How to model the correlated within-group responses for longitudinal data? Period Dabao Zhang Page 5

7 Generalized Linear Mixed Models For j-th observation of i-th subject, y ij γ i EFD(θ ij,φ), γ i iid N(0,Σ γ ) j = 1,,n i ; i = 1,,m θ ij is the canonical parameter φ is the (known) dispersion parameter E[y ij γ i ] = µ ij = b (θ ij ) var(y ij γ i ) = φb (θ ij ) = φv(µ ij ), assuming a ij (φ) = φ Generalized Linear Mixed Model: (Conditional Models) g(µ ij ) = η ij x ij β + z ij γ i, γ i iid N(0,Σ γ ) subject-wise: g(µ i ) = η i x i β + z i γ i, where g(µ i ) = (g(µ i1 ),,g(µ ini )) T sample-wise: g(µ) = η Xβ + Zγ, where γ = (γ 1,,γ m ) T For Y = (y 11 y 1n1 y m1 y mn m )T E[Y] = E{E[Y γ]} = E[µ ij ] = E[g 1 (Xβ + Zγ)] var(y) = var(e[y γ]) + E[var(Y γ)] = var(g 1 (Xβ + Zγ)) + φe[v(g 1 (Xβ + Zγ))] Dabao Zhang Page 6

8 Fitting GLMMs with Maximum Likelihood Approach The likelihood of the GLMM is L Σ γ m/2 m i=1 R q exp Σ γ m/2 R mq exp { ni { m i=1 j=1 n i j=1 Y ij θ ij b(θ ij ) a(φ) Y ij θ ij b(θ ij ) a(φ) Each γ i is assumed to be a q-dimensional column vector; D = diag{σ γ Σ γ } is mq mq; How to calculate the (possibly high-dimensional) integrals? 1 2 γt i Σ 1 γ γ i } dγ i, 1 2 γt Σ 1 γ γ }dγ, Laplace s method can be applied to approximate the integrals (Wolfinger, 1993); Alternative numerical methods are available to calculate the integrals, see Sinha (2004). Function lmer of package lme4 in R applies Laplace s method. Dabao Zhang Page 7

9 > library(lme4); > csglmm2 <- lmer(stable~sex+age+height+weight+surface+vision+(1 Subject),family=binomial,data=ctsib) > summary(csglmm2) Generalized linear mixed model fit using Laplace Formula: stable ~ Sex + Age + Height + Weight + Surface + Vision + (1 Subject) Data: ctsib Family: binomial(logit link) AIC BIC loglik deviance Random effects: Groups Name Variance Std.Dev. Subject (Intercept) number of obs: 480, groups: Subject, 40 Estimated scale (compare to 1 ) Fixed effects: Estimate Std. Error z value Pr(> z ) (Intercept) Sexmale Age Height Weight Surfacenorm < 2e-16 *** Visiondome Visionopen e-14 ***... > #try: lmer(stable~sex+age+height+weight+surface+vision+(1 Subject),method="PQL",family=binomial,data=ctsib) Dabao Zhang Page 8

10 Fitting GLMMs with Penalized Quasi-Likelihood Approach Since E[y ij γ i ] = µ ij, var(y ij γ i ) = φv(µ ij ), the log quasi-likelihood for y i is (assuming γ i is known) Q i = n i j=1 µij y ij y ij t φv(t) dt The integrated quasi-likelihood for the GLMM is L Σ γ m/2 m i=1 R q exp { } Q i 1 2 γt i Σ 1 γ γ i dγ i { m } = Σ γ m/2 R mq exp Q i 1 2 γt D 1 γ dγ i=1 Each γ i is assumed to be a q-dimensional column vector D = diag{σ γ Σ γ } is mq mq 1 2 γt D 1 γ can be considered as a penalty to the quasi-likelihood = penalized quasi-likelihood (PQL; Breslow and Clayton, 1993) Dabao Zhang Page 9

11 PQL is an approximate method of inference in GLMMs On the basis of current estimates (ˆβ,ˆγ), generate the working observation ỹ ij = ˆη ij + g (ˆµ ij )(y ij ˆµ ij ) update the estimates of (β,γ) from the following linear mixed models ỹ ij = x ij β + z ij γ i + ǫ ij γ i N(0,Σ γ ), ǫ ij N(0,φ[g (ˆµ ij )] 2 V(ˆµ ij )) PQL is implemented in package MASS of R > library(mass); help(glmmpql); glmmpql(fixed, random, family, data, correlation, weights, niter = 10,...) fixed: a two-sided linear formula giving fixed-effects part of the model. random: a formula or list of formulae describing the random effects. family: a GLM family. correlation: an optional correlation structure. weights: optional case weights as in glm. niter: maximum number of iterations....: Further arguments for lme. Dabao Zhang Page 10

12 PQL may sometimes yield badly biased estimates of variance components, especially in binary outcomes. An alternative algorithm is to apply Laplace s method to the integrals of the likelihood function for the GLMM, e.g., function lmer of package lme4 in R Example: Effects of Surface and Vision on Balance (Continued) > csglmm1 <- glmmpql(stable~sex+age+height+weight+surface+vision,random=~1 Subject,family=binomial,data=ctsib) > summary(csglmm1);... Random effects: Formula: ~1 Subject (Intercept) Residual StdDev: Variance function: Structure: fixed weights Formula: ~invwt Fixed effects: stable ~ Sex + Age + Height + Weight + Surface + Vision Value Std.Error DF t-value p-value (Intercept) Sexmale Age Height Weight Surfacenorm Visiondome Visionopen Dabao Zhang Page 11

13 Generalized Estimating Equations Instead of explicitly specifying random effects as in GLMM, we can directly model the correlation between within-group observations (marginal models) = Generalized Estimation Equations (GEE; Liang and Zeger, 1986) models Need to specify a link function, i.e., g(µ ij ) = x ij β where µ ij = E[y ij ] Need to specify a variance function V(µ ij ) Need to specify the correlation matrix R(α) = corr(y i ) GEE provides consistent estimates of the fixed effects in β even if the proposed correlation structure R(α) is incorrect! GEE is used to iteratively get an estimate of β by solving the following equations m ( ) T µi V 1 i (y i µ i ) = 0 β µ i = (µ i1 µ ini ) T y i = (y i1 y ini ) T i=1 V i = φa 1/2 i R(α)A 1/2 i where A i = diag{v(µ i1 ) V(µ ini )} GEE does not estimate the dispersion parameter φ, which can be estimated through Pearson s residuals. Dabao Zhang Page 12

14 The correlation matrix R(α) is generally unknown, so a working correlation matrix is specified and used instead. Examples of the working correlation matrix AR(1), i.e., corr(y ij,y ik ) = α j k Exchangle (compound symmetry), i.e., corr(y ij,y ik ) equals to 1 if j = k, α otherwise Unstructured, i.e., corr(y ij,y ik ) = α jk Independent, i.e., corr(y ij,y ik ) equals to 1 if j = k, 0 otherwise The sandwich estimator of the covariance of ˆβ Ĉov(ˆβ) = I 1 0 I 1I 1 ( µi I 0 = β i ( µi I 1 = β i ) T ( ) µi V i 0, β, ) T ( V 1 i (Y i ˆµ i )(Y i ˆµ i ) T µi β I 1 0 is a naive estimate of Cov(ˆβ) and may be very misleading. The sandwich estimator (sometimes called the robust or empirical estimator) provide a consistent estimate of Cov(ˆβ) even if the working correlation is misspecified. Dabao Zhang Page 13 ).

15 GEE in R Package gee ( > library(gee); help(gee); gee(formula, id, data, subset, family = gaussian, corstr = "independence", Mv = 1, contrasts = NULL, scale.fix = FALSE, scale.value = 1) id: a vector which identifies the clusters. Physically contiguous records possessing the same value are assumed to be in the same cluster. The following vector specifies 4 clusters of size 4: c(0,0,0,0,1,1,1,1,0,0,0,0,1,1,1,1). corstr: specifying the correlation structure with "independence", "fixed", "stat M dep", "non stat M dep", "exchangeable", "AR-M" or "unstructured" Mv: must be specified for corstr = "stat M dep", "non stat M dep", or "AR-M". contrasts: a list giving contrasts for some or all of the factors appearing in the model formula. scale.fix: a logical variable; if true, the scale parameter is fixed at the value of scale.value. scale.value: numeric variable giving the value to which the scale parameter should be fixed; used only if scale.fix == TRUE. Dabao Zhang Page 13

16 Example: Effects of Surface and Vision on Balance (Continued) > csgee <- gee(stable~sex+age+height+weight+surface+vision,id=subject,corstr="exchangeable",family=binomial,data=ctsib); > summary(csgee); GEE: GENERALIZED LINEAR MODELS FOR DEPENDENT DATA gee S-function, version 4.13 modified 98/01/27 (1998) Model: Link: Logit Variance to Mean Relation: Binomial Correlation Structure: Exchangeable... Coefficients: Estimate Naive S.E. Naive z Robust S.E. Robust z (Intercept) Sexmale Age Height Weight Surfacenorm Visiondome Visionopen Estimated Scale Parameter: Working Correlation [,1] [,2] [,3] [,4] [,5] [,6] [,7] [1,] [2,] [3,] Dabao Zhang Page 14

17 Example: Seizure Rates of Epileptics under Treatment (Continued) > segee <- gee(seizures~offset(log(timeadj))+expind+treat+i(expind*treat),id=id,corstr="ar-m",mv=1, family=poisson,data=sepil,subset=(id!=49)); > summary(segee);... Model: Link: Logarithm Variance to Mean Relation: Poisson Correlation Structure: AR-M, M = 1... Coefficients: Estimate Naive S.E. Naive z Robust S.E. Robust z (Intercept) expind treat I(expind * treat) Estimated Scale Parameter: Number of Iterations: 4 Working Correlation [,1] [,2] [,3] [,4] [,5] [1,] [2,] [3,] [4,] [5,] Dabao Zhang Page 15

18 GLMM or GEE? The parameter β may have different interpretations In a GLMM, β measures the effect of the covariates for an individual In a GEE, β measures the effect of the covariates for a population, usually smaller. If a GLMM is a good model, then often so is a GEE model but for substantially different parameter estimates (Zeger et al., 1988) For log-linear models, only the intercepts will differ For logistic models, the slopes will be attenuated Zeger et al. (1988) pointed out that GLMM models can also be fitted by GEE methods, provided the latter are extended to estimate the variance components of the random effects. Dabao Zhang Page 16

HW 2 due March 6 random effects and mixed effects models ELM Ch. 8 R Studio Cheatsheets In the News: homeopathic vaccines

HW 2 due March 6 random effects and mixed effects models ELM Ch. 8 R Studio Cheatsheets In the News: homeopathic vaccines Today HW 2 due March 6 random effects and mixed effects models ELM Ch. 8 R Studio Cheatsheets In the News: homeopathic vaccines STA 2201: Applied Statistics II March 4, 2015 1/35 A general framework y

More information

Bayesian analysis of logistic regression

Bayesian analysis of logistic regression Today Bayesian analysis of logistic regression Generalized linear mixed models CD on fixed and random effects HW 2 due February 28 Case Studies SSC 2014 Toronto March/April: Semi-parametric regression

More information

I r j Binom(m j, p j ) I L(, ; y) / exp{ y j + (x j y j ) m j log(1 + e + x j. I (, y) / L(, ; y) (, )

I r j Binom(m j, p j ) I L(, ; y) / exp{ y j + (x j y j ) m j log(1 + e + x j. I (, y) / L(, ; y) (, ) Today I Bayesian analysis of logistic regression I Generalized linear mixed models I CD on fixed and random effects I HW 2 due February 28 I Case Studies SSC 2014 Toronto I March/April: Semi-parametric

More information

Generalized Estimating Equations (gee) for glm type data

Generalized Estimating Equations (gee) for glm type data Generalized Estimating Equations (gee) for glm type data Søren Højsgaard mailto:sorenh@agrsci.dk Biometry Research Unit Danish Institute of Agricultural Sciences January 23, 2006 Printed: January 23, 2006

More information

Lecture 9 STK3100/4100

Lecture 9 STK3100/4100 Lecture 9 STK3100/4100 27. October 2014 Plan for lecture: 1. Linear mixed models cont. Models accounting for time dependencies (Ch. 6.1) 2. Generalized linear mixed models (GLMM, Ch. 13.1-13.3) Examples

More information

Stat 579: Generalized Linear Models and Extensions

Stat 579: Generalized Linear Models and Extensions Stat 579: Generalized Linear Models and Extensions Linear Mixed Models for Longitudinal Data Yan Lu April, 2018, week 15 1 / 38 Data structure t1 t2 tn i 1st subject y 11 y 12 y 1n1 Experimental 2nd subject

More information

Mixed models in R using the lme4 package Part 7: Generalized linear mixed models

Mixed models in R using the lme4 package Part 7: Generalized linear mixed models Mixed models in R using the lme4 package Part 7: Generalized linear mixed models Douglas Bates University of Wisconsin - Madison and R Development Core Team University of

More information

Package HGLMMM for Hierarchical Generalized Linear Models

Package HGLMMM for Hierarchical Generalized Linear Models Package HGLMMM for Hierarchical Generalized Linear Models Marek Molas Emmanuel Lesaffre Erasmus MC Erasmus Universiteit - Rotterdam The Netherlands ERASMUSMC - Biostatistics 20-04-2010 1 / 52 Outline General

More information

Non-maximum likelihood estimation and statistical inference for linear and nonlinear mixed models

Non-maximum likelihood estimation and statistical inference for linear and nonlinear mixed models Optimum Design for Mixed Effects Non-Linear and generalized Linear Models Cambridge, August 9-12, 2011 Non-maximum likelihood estimation and statistical inference for linear and nonlinear mixed models

More information

9 Generalized Linear Models

9 Generalized Linear Models 9 Generalized Linear Models The Generalized Linear Model (GLM) is a model which has been built to include a wide range of different models you already know, e.g. ANOVA and multiple linear regression models

More information

Review. Timothy Hanson. Department of Statistics, University of South Carolina. Stat 770: Categorical Data Analysis

Review. Timothy Hanson. Department of Statistics, University of South Carolina. Stat 770: Categorical Data Analysis Review Timothy Hanson Department of Statistics, University of South Carolina Stat 770: Categorical Data Analysis 1 / 22 Chapter 1: background Nominal, ordinal, interval data. Distributions: Poisson, binomial,

More information

Outline. Mixed models in R using the lme4 package Part 5: Generalized linear mixed models. Parts of LMMs carried over to GLMMs

Outline. Mixed models in R using the lme4 package Part 5: Generalized linear mixed models. Parts of LMMs carried over to GLMMs Outline Mixed models in R using the lme4 package Part 5: Generalized linear mixed models Douglas Bates University of Wisconsin - Madison and R Development Core Team UseR!2009,

More information

Generalized Estimating Equations

Generalized Estimating Equations Outline Review of Generalized Linear Models (GLM) Generalized Linear Model Exponential Family Components of GLM MLE for GLM, Iterative Weighted Least Squares Measuring Goodness of Fit - Deviance and Pearson

More information

UNIVERSITY OF TORONTO. Faculty of Arts and Science APRIL 2010 EXAMINATIONS STA 303 H1S / STA 1002 HS. Duration - 3 hours. Aids Allowed: Calculator

UNIVERSITY OF TORONTO. Faculty of Arts and Science APRIL 2010 EXAMINATIONS STA 303 H1S / STA 1002 HS. Duration - 3 hours. Aids Allowed: Calculator UNIVERSITY OF TORONTO Faculty of Arts and Science APRIL 2010 EXAMINATIONS STA 303 H1S / STA 1002 HS Duration - 3 hours Aids Allowed: Calculator LAST NAME: FIRST NAME: STUDENT NUMBER: There are 27 pages

More information

GEE for Longitudinal Data - Chapter 8

GEE for Longitudinal Data - Chapter 8 GEE for Longitudinal Data - Chapter 8 GEE: generalized estimating equations (Liang & Zeger, 1986; Zeger & Liang, 1986) extension of GLM to longitudinal data analysis using quasi-likelihood estimation method

More information

Non-Gaussian Response Variables

Non-Gaussian Response Variables Non-Gaussian Response Variables What is the Generalized Model Doing? The fixed effects are like the factors in a traditional analysis of variance or linear model The random effects are different A generalized

More information

Mixed models in R using the lme4 package Part 5: Generalized linear mixed models

Mixed models in R using the lme4 package Part 5: Generalized linear mixed models Mixed models in R using the lme4 package Part 5: Generalized linear mixed models Douglas Bates 2011-03-16 Contents 1 Generalized Linear Mixed Models Generalized Linear Mixed Models When using linear mixed

More information

Overdispersion Workshop in generalized linear models Uppsala, June 11-12, Outline. Overdispersion

Overdispersion Workshop in generalized linear models Uppsala, June 11-12, Outline. Overdispersion Biostokastikum Overdispersion is not uncommon in practice. In fact, some would maintain that overdispersion is the norm in practice and nominal dispersion the exception McCullagh and Nelder (1989) Overdispersion

More information

Generalized Linear Models. Kurt Hornik

Generalized Linear Models. Kurt Hornik Generalized Linear Models Kurt Hornik Motivation Assuming normality, the linear model y = Xβ + e has y = β + ε, ε N(0, σ 2 ) such that y N(μ, σ 2 ), E(y ) = μ = β. Various generalizations, including general

More information

Mixed models in R using the lme4 package Part 5: Generalized linear mixed models

Mixed models in R using the lme4 package Part 5: Generalized linear mixed models Mixed models in R using the lme4 package Part 5: Generalized linear mixed models Douglas Bates Madison January 11, 2011 Contents 1 Definition 1 2 Links 2 3 Example 7 4 Model building 9 5 Conclusions 14

More information

Statistical Methods III Statistics 212. Problem Set 2 - Answer Key

Statistical Methods III Statistics 212. Problem Set 2 - Answer Key Statistical Methods III Statistics 212 Problem Set 2 - Answer Key 1. (Analysis to be turned in and discussed on Tuesday, April 24th) The data for this problem are taken from long-term followup of 1423

More information

Figure 36: Respiratory infection versus time for the first 49 children.

Figure 36: Respiratory infection versus time for the first 49 children. y BINARY DATA MODELS We devote an entire chapter to binary data since such data are challenging, both in terms of modeling the dependence, and parameter interpretation. We again consider mixed effects

More information

SCHOOL OF MATHEMATICS AND STATISTICS. Linear and Generalised Linear Models

SCHOOL OF MATHEMATICS AND STATISTICS. Linear and Generalised Linear Models SCHOOL OF MATHEMATICS AND STATISTICS Linear and Generalised Linear Models Autumn Semester 2017 18 2 hours Attempt all the questions. The allocation of marks is shown in brackets. RESTRICTED OPEN BOOK EXAMINATION

More information

Contrasting Marginal and Mixed Effects Models Recall: two approaches to handling dependence in Generalized Linear Models:

Contrasting Marginal and Mixed Effects Models Recall: two approaches to handling dependence in Generalized Linear Models: Contrasting Marginal and Mixed Effects Models Recall: two approaches to handling dependence in Generalized Linear Models: Marginal models: based on the consequences of dependence on estimating model parameters.

More information

Chapter 4: Generalized Linear Models-II

Chapter 4: Generalized Linear Models-II : Generalized Linear Models-II Dipankar Bandyopadhyay Department of Biostatistics, Virginia Commonwealth University BIOS 625: Categorical Data & GLM [Acknowledgements to Tim Hanson and Haitao Chu] D. Bandyopadhyay

More information

PQL Estimation Biases in Generalized Linear Mixed Models

PQL Estimation Biases in Generalized Linear Mixed Models PQL Estimation Biases in Generalized Linear Mixed Models Woncheol Jang Johan Lim March 18, 2006 Abstract The penalized quasi-likelihood (PQL) approach is the most common estimation procedure for the generalized

More information

STAT 705 Generalized linear mixed models

STAT 705 Generalized linear mixed models STAT 705 Generalized linear mixed models Timothy Hanson Department of Statistics, University of South Carolina Stat 705: Data Analysis II 1 / 24 Generalized Linear Mixed Models We have considered random

More information

Generalized linear models

Generalized linear models Generalized linear models Douglas Bates November 01, 2010 Contents 1 Definition 1 2 Links 2 3 Estimating parameters 5 4 Example 6 5 Model building 8 6 Conclusions 8 7 Summary 9 1 Generalized Linear Models

More information

Conditional Inference Functions for Mixed-Effects Models with Unspecified Random-Effects Distribution

Conditional Inference Functions for Mixed-Effects Models with Unspecified Random-Effects Distribution Conditional Inference Functions for Mixed-Effects Models with Unspecified Random-Effects Distribution Peng WANG, Guei-feng TSAI and Annie QU 1 Abstract In longitudinal studies, mixed-effects models are

More information

Model and Working Correlation Structure Selection in GEE Analyses of Longitudinal Data

Model and Working Correlation Structure Selection in GEE Analyses of Longitudinal Data The 3rd Australian and New Zealand Stata Users Group Meeting, Sydney, 5 November 2009 1 Model and Working Correlation Structure Selection in GEE Analyses of Longitudinal Data Dr Jisheng Cui Public Health

More information

Repeated ordinal measurements: a generalised estimating equation approach

Repeated ordinal measurements: a generalised estimating equation approach Repeated ordinal measurements: a generalised estimating equation approach David Clayton MRC Biostatistics Unit 5, Shaftesbury Road Cambridge CB2 2BW April 7, 1992 Abstract Cumulative logit and related

More information

Log-linear Models for Contingency Tables

Log-linear Models for Contingency Tables Log-linear Models for Contingency Tables Statistics 149 Spring 2006 Copyright 2006 by Mark E. Irwin Log-linear Models for Two-way Contingency Tables Example: Business Administration Majors and Gender A

More information

Lecture 3.1 Basic Logistic LDA

Lecture 3.1 Basic Logistic LDA y Lecture.1 Basic Logistic LDA 0.2.4.6.8 1 Outline Quick Refresher on Ordinary Logistic Regression and Stata Women s employment example Cross-Over Trial LDA Example -100-50 0 50 100 -- Longitudinal Data

More information

ST3241 Categorical Data Analysis I Generalized Linear Models. Introduction and Some Examples

ST3241 Categorical Data Analysis I Generalized Linear Models. Introduction and Some Examples ST3241 Categorical Data Analysis I Generalized Linear Models Introduction and Some Examples 1 Introduction We have discussed methods for analyzing associations in two-way and three-way tables. Now we will

More information

Generalized Linear Mixed-Effects Models. Copyright c 2015 Dan Nettleton (Iowa State University) Statistics / 58

Generalized Linear Mixed-Effects Models. Copyright c 2015 Dan Nettleton (Iowa State University) Statistics / 58 Generalized Linear Mixed-Effects Models Copyright c 2015 Dan Nettleton (Iowa State University) Statistics 510 1 / 58 Reconsideration of the Plant Fungus Example Consider again the experiment designed to

More information

Outline. Linear OLS Models vs: Linear Marginal Models Linear Conditional Models. Random Intercepts Random Intercepts & Slopes

Outline. Linear OLS Models vs: Linear Marginal Models Linear Conditional Models. Random Intercepts Random Intercepts & Slopes Lecture 2.1 Basic Linear LDA 1 Outline Linear OLS Models vs: Linear Marginal Models Linear Conditional Models Random Intercepts Random Intercepts & Slopes Cond l & Marginal Connections Empirical Bayes

More information

PAPER 218 STATISTICAL LEARNING IN PRACTICE

PAPER 218 STATISTICAL LEARNING IN PRACTICE MATHEMATICAL TRIPOS Part III Thursday, 7 June, 2018 9:00 am to 12:00 pm PAPER 218 STATISTICAL LEARNING IN PRACTICE Attempt no more than FOUR questions. There are SIX questions in total. The questions carry

More information

Review: what is a linear model. Y = β 0 + β 1 X 1 + β 2 X 2 + A model of the following form:

Review: what is a linear model. Y = β 0 + β 1 X 1 + β 2 X 2 + A model of the following form: Outline for today What is a generalized linear model Linear predictors and link functions Example: fit a constant (the proportion) Analysis of deviance table Example: fit dose-response data using logistic

More information

Semiparametric Generalized Linear Models

Semiparametric Generalized Linear Models Semiparametric Generalized Linear Models North American Stata Users Group Meeting Chicago, Illinois Paul Rathouz Department of Health Studies University of Chicago prathouz@uchicago.edu Liping Gao MS Student

More information

Linear Regression Models P8111

Linear Regression Models P8111 Linear Regression Models P8111 Lecture 25 Jeff Goldsmith April 26, 2016 1 of 37 Today s Lecture Logistic regression / GLMs Model framework Interpretation Estimation 2 of 37 Linear regression Course started

More information

Generalized linear models

Generalized linear models Generalized linear models Outline for today What is a generalized linear model Linear predictors and link functions Example: estimate a proportion Analysis of deviance Example: fit dose- response data

More information

An R # Statistic for Fixed Effects in the Linear Mixed Model and Extension to the GLMM

An R # Statistic for Fixed Effects in the Linear Mixed Model and Extension to the GLMM An R Statistic for Fixed Effects in the Linear Mixed Model and Extension to the GLMM Lloyd J. Edwards, Ph.D. UNC-CH Department of Biostatistics email: Lloyd_Edwards@unc.edu Presented to the Department

More information

Introduction (Alex Dmitrienko, Lilly) Web-based training program

Introduction (Alex Dmitrienko, Lilly) Web-based training program Web-based training Introduction (Alex Dmitrienko, Lilly) Web-based training program http://www.amstat.org/sections/sbiop/webinarseries.html Four-part web-based training series Geert Verbeke (Katholieke

More information

E[Y i θ i, α] = µ i = b (θ i ) and var(y i θ i, α) = b (θ i )α, for i = 1,..., n, with cov(y i, Y j θ i, θ j, α) = 0 for i j.

E[Y i θ i, α] = µ i = b (θ i ) and var(y i θ i, α) = b (θ i )α, for i = 1,..., n, with cov(y i, Y j θ i, θ j, α) = 0 for i j. 29 Jon Wakefield, Stat/Biostat 57 GENERAL REGRESSION MODELS We consider the class of Generalized Linear Mixed Models (GLMMs) and non-linear mixed effects models (NLMEMs). In this chapter we will again

More information

Lecture 3 Linear random intercept models

Lecture 3 Linear random intercept models Lecture 3 Linear random intercept models Example: Weight of Guinea Pigs Body weights of 48 pigs in 9 successive weeks of follow-up (Table 3.1 DLZ) The response is measures at n different times, or under

More information

A brief introduction to mixed models

A brief introduction to mixed models A brief introduction to mixed models University of Gothenburg Gothenburg April 6, 2017 Outline An introduction to mixed models based on a few examples: Definition of standard mixed models. Parameter estimation.

More information

Correlated Data: Linear Mixed Models with Random Intercepts

Correlated Data: Linear Mixed Models with Random Intercepts 1 Correlated Data: Linear Mixed Models with Random Intercepts Mixed Effects Models This lecture introduces linear mixed effects models. Linear mixed models are a type of regression model, which generalise

More information

Modeling the scale parameter ϕ A note on modeling correlation of binary responses Using marginal odds ratios to model association for binary responses

Modeling the scale parameter ϕ A note on modeling correlation of binary responses Using marginal odds ratios to model association for binary responses Outline Marginal model Examples of marginal model GEE1 Augmented GEE GEE1.5 GEE2 Modeling the scale parameter ϕ A note on modeling correlation of binary responses Using marginal odds ratios to model association

More information

,..., θ(2),..., θ(n)

,..., θ(2),..., θ(n) Likelihoods for Multivariate Binary Data Log-Linear Model We have 2 n 1 distinct probabilities, but we wish to consider formulations that allow more parsimonious descriptions as a function of covariates.

More information

Part IV: Marginal models

Part IV: Marginal models Part IV: Marginal models 246 BIO 245, Spring 2018 Indonesian Children s Health Study (ICHS) Study conducted to determine the effects of vitamin A deficiency in preschool children Data on K=275 children

More information

STA 4504/5503 Sample Exam 1 Spring 2011 Categorical Data Analysis. 1. Indicate whether each of the following is true (T) or false (F).

STA 4504/5503 Sample Exam 1 Spring 2011 Categorical Data Analysis. 1. Indicate whether each of the following is true (T) or false (F). STA 4504/5503 Sample Exam 1 Spring 2011 Categorical Data Analysis 1. Indicate whether each of the following is true (T) or false (F). (a) T In 2 2 tables, statistical independence is equivalent to a population

More information

Analysis of Longitudinal Data. Patrick J. Heagerty PhD Department of Biostatistics University of Washington

Analysis of Longitudinal Data. Patrick J. Heagerty PhD Department of Biostatistics University of Washington Analsis of Longitudinal Data Patrick J. Heagert PhD Department of Biostatistics Universit of Washington 1 Auckland 2008 Session Three Outline Role of correlation Impact proper standard errors Used to weight

More information

Models for Clustered Data

Models for Clustered Data Models for Clustered Data Edps/Psych/Soc 589 Carolyn J Anderson Department of Educational Psychology c Board of Trustees, University of Illinois Spring 2019 Outline Notation NELS88 data Fixed Effects ANOVA

More information

Subject-specific observed profiles of log(fev1) vs age First 50 subjects in Six Cities Study

Subject-specific observed profiles of log(fev1) vs age First 50 subjects in Six Cities Study Subject-specific observed profiles of log(fev1) vs age First 50 subjects in Six Cities Study 1.4 0.0-6 7 8 9 10 11 12 13 14 15 16 17 18 19 age Model 1: A simple broken stick model with knot at 14 fit with

More information

Generalized Linear Models Introduction

Generalized Linear Models Introduction Generalized Linear Models Introduction Statistics 135 Autumn 2005 Copyright c 2005 by Mark E. Irwin Generalized Linear Models For many problems, standard linear regression approaches don t work. Sometimes,

More information

Models for Clustered Data

Models for Clustered Data Models for Clustered Data Edps/Psych/Stat 587 Carolyn J Anderson Department of Educational Psychology c Board of Trustees, University of Illinois Fall 2017 Outline Notation NELS88 data Fixed Effects ANOVA

More information

Lab 3: Two levels Poisson models (taken from Multilevel and Longitudinal Modeling Using Stata, p )

Lab 3: Two levels Poisson models (taken from Multilevel and Longitudinal Modeling Using Stata, p ) Lab 3: Two levels Poisson models (taken from Multilevel and Longitudinal Modeling Using Stata, p. 376-390) BIO656 2009 Goal: To see if a major health-care reform which took place in 1997 in Germany was

More information

Logistic Regression. James H. Steiger. Department of Psychology and Human Development Vanderbilt University

Logistic Regression. James H. Steiger. Department of Psychology and Human Development Vanderbilt University Logistic Regression James H. Steiger Department of Psychology and Human Development Vanderbilt University James H. Steiger (Vanderbilt University) Logistic Regression 1 / 38 Logistic Regression 1 Introduction

More information

Linear, Generalized Linear, and Mixed-Effects Models in R. Linear and Generalized Linear Models in R Topics

Linear, Generalized Linear, and Mixed-Effects Models in R. Linear and Generalized Linear Models in R Topics Linear, Generalized Linear, and Mixed-Effects Models in R John Fox McMaster University ICPSR 2018 John Fox (McMaster University) Statistical Models in R ICPSR 2018 1 / 19 Linear and Generalized Linear

More information

Statistics 203: Introduction to Regression and Analysis of Variance Course review

Statistics 203: Introduction to Regression and Analysis of Variance Course review Statistics 203: Introduction to Regression and Analysis of Variance Course review Jonathan Taylor - p. 1/?? Today Review / overview of what we learned. - p. 2/?? General themes in regression models Specifying

More information

Two Hours. Mathematical formula books and statistical tables are to be provided THE UNIVERSITY OF MANCHESTER. 26 May :00 16:00

Two Hours. Mathematical formula books and statistical tables are to be provided THE UNIVERSITY OF MANCHESTER. 26 May :00 16:00 Two Hours MATH38052 Mathematical formula books and statistical tables are to be provided THE UNIVERSITY OF MANCHESTER GENERALISED LINEAR MODELS 26 May 2016 14:00 16:00 Answer ALL TWO questions in Section

More information

Regression models. Generalized linear models in R. Normal regression models are not always appropriate. Generalized linear models. Examples.

Regression models. Generalized linear models in R. Normal regression models are not always appropriate. Generalized linear models. Examples. Regression models Generalized linear models in R Dr Peter K Dunn http://www.usq.edu.au Department of Mathematics and Computing University of Southern Queensland ASC, July 00 The usual linear regression

More information

Outline. Statistical inference for linear mixed models. One-way ANOVA in matrix-vector form

Outline. Statistical inference for linear mixed models. One-way ANOVA in matrix-vector form Outline Statistical inference for linear mixed models Rasmus Waagepetersen Department of Mathematics Aalborg University Denmark general form of linear mixed models examples of analyses using linear mixed

More information

Linear Mixed Models. One-way layout REML. Likelihood. Another perspective. Relationship to classical ideas. Drawbacks.

Linear Mixed Models. One-way layout REML. Likelihood. Another perspective. Relationship to classical ideas. Drawbacks. Linear Mixed Models One-way layout Y = Xβ + Zb + ɛ where X and Z are specified design matrices, β is a vector of fixed effect coefficients, b and ɛ are random, mean zero, Gaussian if needed. Usually think

More information

Longitudinal Modeling with Logistic Regression

Longitudinal Modeling with Logistic Regression Newsom 1 Longitudinal Modeling with Logistic Regression Longitudinal designs involve repeated measurements of the same individuals over time There are two general classes of analyses that correspond to

More information

Chapter 5: Generalized Linear Models

Chapter 5: Generalized Linear Models w w w. I C A 0 1 4. o r g Chapter 5: Generalized Linear Models b Curtis Gar Dean, FCAS, MAAA, CFA Ball State Universit: Center for Actuarial Science and Risk Management M Interest in Predictive Modeling

More information

McGill University. Faculty of Science. Department of Mathematics and Statistics. Statistics Part A Comprehensive Exam Methodology Paper

McGill University. Faculty of Science. Department of Mathematics and Statistics. Statistics Part A Comprehensive Exam Methodology Paper Student Name: ID: McGill University Faculty of Science Department of Mathematics and Statistics Statistics Part A Comprehensive Exam Methodology Paper Date: Friday, May 13, 2016 Time: 13:00 17:00 Instructions

More information

Faculty of Health Sciences. Correlated data. Count variables. Lene Theil Skovgaard & Julie Lyng Forman. December 6, 2016

Faculty of Health Sciences. Correlated data. Count variables. Lene Theil Skovgaard & Julie Lyng Forman. December 6, 2016 Faculty of Health Sciences Correlated data Count variables Lene Theil Skovgaard & Julie Lyng Forman December 6, 2016 1 / 76 Modeling count outcomes Outline The Poisson distribution for counts Poisson models,

More information

Introduction to mtm: An R Package for Marginalized Transition Models

Introduction to mtm: An R Package for Marginalized Transition Models Introduction to mtm: An R Package for Marginalized Transition Models Bryan A. Comstock and Patrick J. Heagerty Department of Biostatistics University of Washington 1 Introduction Marginalized transition

More information

Proportional Odds Logistic Regression. stat 557 Heike Hofmann

Proportional Odds Logistic Regression. stat 557 Heike Hofmann Proportional Odds Logistic Regression stat 557 Heike Hofmann Outline Proportional Odds Logistic Regression Model Definition Properties Latent Variables Intro to Loglinear Models Ordinal Response Y is categorical

More information

Mixed-effects Maximum Likelihood Difference Scaling

Mixed-effects Maximum Likelihood Difference Scaling Mixed-effects Maximum Likelihood Difference Scaling Kenneth Knoblauch Inserm U 846 Stem Cell and Brain Research Institute Dept. Integrative Neurosciences Bron, France Laurence T. Maloney Department of

More information

Generalized Linear and Nonlinear Mixed-Effects Models

Generalized Linear and Nonlinear Mixed-Effects Models Generalized Linear and Nonlinear Mixed-Effects Models Douglas Bates University of Wisconsin - Madison and R Development Core Team University of Potsdam August 8, 2008 Outline

More information

Introduction to lnmle: An R Package for Marginally Specified Logistic-Normal Models for Longitudinal Binary Data

Introduction to lnmle: An R Package for Marginally Specified Logistic-Normal Models for Longitudinal Binary Data Introduction to lnmle: An R Package for Marginally Specified Logistic-Normal Models for Longitudinal Binary Data Bryan A. Comstock and Patrick J. Heagerty Department of Biostatistics University of Washington

More information

Outline of GLMs. Definitions

Outline of GLMs. Definitions Outline of GLMs Definitions This is a short outline of GLM details, adapted from the book Nonparametric Regression and Generalized Linear Models, by Green and Silverman. The responses Y i have density

More information

if n is large, Z i are weakly dependent 0-1-variables, p i = P(Z i = 1) small, and Then n approx i=1 i=1 n i=1

if n is large, Z i are weakly dependent 0-1-variables, p i = P(Z i = 1) small, and Then n approx i=1 i=1 n i=1 Count models A classical, theoretical argument for the Poisson distribution is the approximation Binom(n, p) Pois(λ) for large n and small p and λ = np. This can be extended considerably to n approx Z

More information

36-463/663: Multilevel & Hierarchical Models

36-463/663: Multilevel & Hierarchical Models 36-463/663: Multilevel & Hierarchical Models (P)review: in-class midterm Brian Junker 132E Baker Hall brian@stat.cmu.edu 1 In-class midterm Closed book, closed notes, closed electronics (otherwise I have

More information

MSH3 Generalized linear model

MSH3 Generalized linear model Contents MSH3 Generalized linear model 7 Log-Linear Model 231 7.1 Equivalence between GOF measures........... 231 7.2 Sampling distribution................... 234 7.3 Interpreting Log-Linear models..............

More information

Estimating prediction error in mixed models

Estimating prediction error in mixed models Estimating prediction error in mixed models benjamin saefken, thomas kneib georg-august university goettingen sonja greven ludwig-maximilians-university munich 1 / 12 GLMM - Generalized linear mixed models

More information

Estimation in Generalized Linear Models with Heterogeneous Random Effects. Woncheol Jang Johan Lim. May 19, 2004

Estimation in Generalized Linear Models with Heterogeneous Random Effects. Woncheol Jang Johan Lim. May 19, 2004 Estimation in Generalized Linear Models with Heterogeneous Random Effects Woncheol Jang Johan Lim May 19, 2004 Abstract The penalized quasi-likelihood (PQL) approach is the most common estimation procedure

More information

20. REML Estimation of Variance Components. Copyright c 2018 (Iowa State University) 20. Statistics / 36

20. REML Estimation of Variance Components. Copyright c 2018 (Iowa State University) 20. Statistics / 36 20. REML Estimation of Variance Components Copyright c 2018 (Iowa State University) 20. Statistics 510 1 / 36 Consider the General Linear Model y = Xβ + ɛ, where ɛ N(0, Σ) and Σ is an n n positive definite

More information

Class Notes. Examining Repeated Measures Data on Individuals

Class Notes. Examining Repeated Measures Data on Individuals Ronald Heck Week 12: Class Notes 1 Class Notes Examining Repeated Measures Data on Individuals Generalized linear mixed models (GLMM) also provide a means of incorporang longitudinal designs with categorical

More information

Generalized linear models

Generalized linear models Generalized linear models Christopher F Baum ECON 8823: Applied Econometrics Boston College, Spring 2016 Christopher F Baum (BC / DIW) Generalized linear models Boston College, Spring 2016 1 / 1 Introduction

More information

Generalized Quasi-likelihood versus Hierarchical Likelihood Inferences in Generalized Linear Mixed Models for Count Data

Generalized Quasi-likelihood versus Hierarchical Likelihood Inferences in Generalized Linear Mixed Models for Count Data Sankhyā : The Indian Journal of Statistics 2009, Volume 71-B, Part 1, pp. 55-78 c 2009, Indian Statistical Institute Generalized Quasi-likelihood versus Hierarchical Likelihood Inferences in Generalized

More information

Outline. Mixed models in R using the lme4 package Part 3: Longitudinal data. Sleep deprivation data. Simple longitudinal data

Outline. Mixed models in R using the lme4 package Part 3: Longitudinal data. Sleep deprivation data. Simple longitudinal data Outline Mixed models in R using the lme4 package Part 3: Longitudinal data Douglas Bates Longitudinal data: sleepstudy A model with random effects for intercept and slope University of Wisconsin - Madison

More information

Topic 17 - Single Factor Analysis of Variance. Outline. One-way ANOVA. The Data / Notation. One way ANOVA Cell means model Factor effects model

Topic 17 - Single Factor Analysis of Variance. Outline. One-way ANOVA. The Data / Notation. One way ANOVA Cell means model Factor effects model Topic 17 - Single Factor Analysis of Variance - Fall 2013 One way ANOVA Cell means model Factor effects model Outline Topic 17 2 One-way ANOVA Response variable Y is continuous Explanatory variable is

More information

Parametric Modelling of Over-dispersed Count Data. Part III / MMath (Applied Statistics) 1

Parametric Modelling of Over-dispersed Count Data. Part III / MMath (Applied Statistics) 1 Parametric Modelling of Over-dispersed Count Data Part III / MMath (Applied Statistics) 1 Introduction Poisson regression is the de facto approach for handling count data What happens then when Poisson

More information

12 Modelling Binomial Response Data

12 Modelling Binomial Response Data c 2005, Anthony C. Brooms Statistical Modelling and Data Analysis 12 Modelling Binomial Response Data 12.1 Examples of Binary Response Data Binary response data arise when an observation on an individual

More information

Classification. Chapter Introduction. 6.2 The Bayes classifier

Classification. Chapter Introduction. 6.2 The Bayes classifier Chapter 6 Classification 6.1 Introduction Often encountered in applications is the situation where the response variable Y takes values in a finite set of labels. For example, the response Y could encode

More information

Modeling Longitudinal Count Data with Excess Zeros and Time-Dependent Covariates: Application to Drug Use

Modeling Longitudinal Count Data with Excess Zeros and Time-Dependent Covariates: Application to Drug Use Modeling Longitudinal Count Data with Excess Zeros and : Application to Drug Use University of Northern Colorado November 17, 2014 Presentation Outline I and Data Issues II Correlated Count Regression

More information

Generalized Linear Models

Generalized Linear Models Generalized Linear Models 1/37 The Kelp Data FRONDS 0 20 40 60 20 40 60 80 100 HLD_DIAM FRONDS are a count variable, cannot be < 0 2/37 Nonlinear Fits! FRONDS 0 20 40 60 log NLS 20 40 60 80 100 HLD_DIAM

More information

Generalized Linear Models I

Generalized Linear Models I Statistics 203: Introduction to Regression and Analysis of Variance Generalized Linear Models I Jonathan Taylor - p. 1/16 Today s class Poisson regression. Residuals for diagnostics. Exponential families.

More information

Random and Mixed Effects Models - Part II

Random and Mixed Effects Models - Part II Random and Mixed Effects Models - Part II Statistics 149 Spring 2006 Copyright 2006 by Mark E. Irwin Two-Factor Random Effects Model Example: Miles per Gallon (Neter, Kutner, Nachtsheim, & Wasserman, problem

More information

R code and output of examples in text. Contents. De Jong and Heller GLMs for Insurance Data R code and output. 1 Poisson regression 2

R code and output of examples in text. Contents. De Jong and Heller GLMs for Insurance Data R code and output. 1 Poisson regression 2 R code and output of examples in text Contents 1 Poisson regression 2 2 Negative binomial regression 5 3 Quasi likelihood regression 6 4 Logistic regression 6 5 Ordinal regression 10 6 Nominal regression

More information

NATIONAL UNIVERSITY OF SINGAPORE EXAMINATION (SOLUTIONS) ST3241 Categorical Data Analysis. (Semester II: )

NATIONAL UNIVERSITY OF SINGAPORE EXAMINATION (SOLUTIONS) ST3241 Categorical Data Analysis. (Semester II: ) NATIONAL UNIVERSITY OF SINGAPORE EXAMINATION (SOLUTIONS) Categorical Data Analysis (Semester II: 2010 2011) April/May, 2011 Time Allowed : 2 Hours Matriculation No: Seat No: Grade Table Question 1 2 3

More information

BIOS 2083 Linear Models c Abdus S. Wahed

BIOS 2083 Linear Models c Abdus S. Wahed Chapter 5 206 Chapter 6 General Linear Model: Statistical Inference 6.1 Introduction So far we have discussed formulation of linear models (Chapter 1), estimability of parameters in a linear model (Chapter

More information

Package mmm. R topics documented: February 20, Type Package

Package mmm. R topics documented: February 20, Type Package Package mmm February 20, 2015 Type Package Title an R package for analyzing multivariate longitudinal data with multivariate marginal models Version 1.4 Date 2014-01-01 Author Ozgur Asar, Ozlem Ilk Depends

More information

PAPER 206 APPLIED STATISTICS

PAPER 206 APPLIED STATISTICS MATHEMATICAL TRIPOS Part III Thursday, 1 June, 2017 9:00 am to 12:00 pm PAPER 206 APPLIED STATISTICS Attempt no more than FOUR questions. There are SIX questions in total. The questions carry equal weight.

More information

1. Hypothesis testing through analysis of deviance. 3. Model & variable selection - stepwise aproaches

1. Hypothesis testing through analysis of deviance. 3. Model & variable selection - stepwise aproaches Sta 216, Lecture 4 Last Time: Logistic regression example, existence/uniqueness of MLEs Today s Class: 1. Hypothesis testing through analysis of deviance 2. Standard errors & confidence intervals 3. Model

More information

Generalized Linear Models: An Introduction

Generalized Linear Models: An Introduction Applied Statistics With R Generalized Linear Models: An Introduction John Fox WU Wien May/June 2006 2006 by John Fox Generalized Linear Models: An Introduction 1 A synthesis due to Nelder and Wedderburn,

More information

Stat 579: Generalized Linear Models and Extensions

Stat 579: Generalized Linear Models and Extensions Stat 579: Generalized Linear Models and Extensions Yan Lu Jan, 2018, week 3 1 / 67 Hypothesis tests Likelihood ratio tests Wald tests Score tests 2 / 67 Generalized Likelihood ratio tests Let Y = (Y 1,

More information