Survival Analysis. STAT 526 Professor Olga Vitek

Size: px
Start display at page:

Download "Survival Analysis. STAT 526 Professor Olga Vitek"

Transcription

1 Survival Analysis STAT 526 Professor Olga Vitek May 4,

2 Survival Data and Survival Functions Statistical analysis of time-to-event data Lifetime of machines and/or parts (called failure time analysis in engineering) Time to default on bonds or credit card (called duration analysis in economics) Patients survival time under different treatment (called survival analysis in clinical trial) Event-history analysis (sociology) Why a special topic on survival analysis? Non-normal and skewed distribution Need to answer questions related to P (X > t + t 0 X t 0 ) Censored/truncated data Here we only focus on right-censored data 9-1

3 Survival Function Continuous survival time T its probability density function is f(t) its cumulative probability function is F (t) F (t) = P (T t) = t 0 f(s)ds The survival function of T is S(t) = P (T > t) = 1 F (t) also called survival rate steeper curve shorter survival S (t) = f(t) Mean survival time 0 0 µ = E{T } = tf(t) dt = 0 0 [ t ] = dx d[1 S(t)] = = 0 S(x) dx t df (t) = t d[1 S(t)] [ 0 ] d[1 S(t)] dx 0 x 9-2

4 Hazard Function The hazard function of T is λ(t) = lim t 0 P (t T < t + t T t) t proportion of subjects with the event per unit time, around time t; λ(t) 0 measure of proneness to the even as function of time λ(t) f(t): λ(t) is conditional on survival to t Relates to the survival function F (t + t) F (t)/ f(t) λ(t) = lim S(t) = t 0 t S(t) = (t) S S(t) = d dt log S(t) (negative slope of log-survival) The cumulative hazard function of T is defined as Λ(t) = t 0 λ(s)ds Λ(t) = log S(t) S(t) = exp{ Λ(t)} λ(t), Λ(t) or S(t) define the distribution 9-3

5 Parametric Survival Models Exponential distribution: λ(t) = ρ, where ρ > 0 is a constant, and t > 0 S(t) = e ρt, f(t) = S (t) = ρe ρt Weibull distribution: λ(t) = λp(λt) p 1 ; λ, p > 0 are constants, t > 0 S(t) = e (λt)p, f(t) = S (t) = e (λt)p λp(λt) p 1 is the Exponential distribution when p = 1 Gompertz distribution: λ(t) = αe βt ; α, β > 0 are constants, t > 0 is the Exponential distribution when β = 0 Gompertz-Makeham distribution: λ(t) = λ + αe βt ; α, β > 0 are constants, t > 0 adds an initial fixed component to the hazard 9-4

6 Non-Parametric Survival Models Approximate time by discrete intervals f(x i ) = { P {T = xi } 0 otherwise S(x i ) = j: x j t f(x j) λ(x i ) = f(x i ) / S(x i ) After substitution: f(x i ) = λ(x i ) i 1 j=1 (1 λ j) S(x i ) = i 1 j=1 (1 λ j) S(t) = j:x j <t (1 λ j), t > 0 9-5

7 Right-Censored Data Survival time of i-th subject T i, i = 1,, n. Censoring time of i-th subject C i, i = 1,, n. Observed event for ith subject: Y i = min(t i, C i ), δ i = 1 {Ti C i } = { 1, if Ti C i 0, if T i > C i Data are reported in pairs (Y i, δ i ) = (observedtime, hasevent) Assumption: C i are predetermined and fixed, or C i are random, mutually independent, and independent of T i 9-6

8 Non-parametric Estimation of Survival Function And Comparison Between Groups With Censoring 9-7

9 Example: Remission Times of Leukaemia Patients 21 leukemia patients treated with drug (6-mercaptopurine) 21 matched controls, no covariates. > library(mass) #Described in Venable & Ripley, Ch.13 > data(gehan) > gehan pair time cens treat control MP control MP control MP control MP control MP control MP control MP control MP control

10 Kaplan-Meier Estimator of Survival Function Also called product limit estimator Re-organize the data Distinct Event Times t 1 t i t k # of Events d 1 d i d k # Survivors Right Before t i n 1 n i n k Kaplan-Meier estimator Ŝ(t) : Estimate P (T > t 1 ) by ˆp 1 = (n 1 d 1 )/n 1 Estimate P (T > t i T > t i 1 ) by ˆp i = (n i d i )/n i, i = 2,, k If t i 1 < t < t i, S(t) = P (T > t) = P (T > t 1 )P (T > t T > t 1 ) = i 1 P (T > t 1 ){ P (T > t m T > t m 1 )}P (T > t T > t i 1 ) m=2 Estimate S(t) by Ŝ(t) = Ŝ(t i 1 ) n i d i n i (Kaplan & Meier, 1958, JASA) = i:t i t n i d i n i, 9-9

11 Non-Parametric Fit of Survival Curves Represent data in the censored survival form create a data structure Surv + represents censored time > library(survival) > Surv(gehan$time, gehan$cens) K-M estimation of survival function subset of results for the treatment group: > fit <- survfit(surv(time, cens) ~ treat, data=gehan) > summary(fit) treat=6-mp time n.risk n.event survival std.err lower95%ci upper95%ci

12 Interval K-M Estimator of Survival Function Direct interval estimation of S(t) The variance of Ŝ(t) can be estimated by var(ŝ(t)) = [Ŝ(t)] 2 d i n i (n i d i ) i:t i t This is Greenwood s formula (Greenwood, 1926) CI for S(t) is Ŝ(t) ± 1.96 var[ŝ(t)], S(t) [0, 1], but var(ŝ(t)) may be large enough that the usual CI will exceed this interval Interval estimation using log S(t) (preferred) The variance of log Ŝ(t) can be estimated as d i var[ log Ŝ(t) ] = n i (n i d i ) i:t i t Construct the CI for log S(t) [L, U] = log Ŝ(t) ± 1.96 var[log Ŝ(t)], For CI of S(t), transform the limits with [e L, e U ]. 9-11

13 Estimate the Cumulative Hazard Function Λ(t) = log S(t) Using the Kaplan-Meier estimator of Ŝ(t): ˆΛ(t) = log Ŝ(t) Alternatively, the Nelson-Aalen Estimator: Λ(t) = V ar( Λ(t) = { 0, if t t1 i:t i t d i n 2 i:t i t i d i n i, if t t i better small-sample-size performance than based on the K-M procedure useful in comparing the fit of a parametric model to its non-parametric alternative 9-12

14 Non-Parametric Fit of Survival Curves >plot(fit, conf.int=true, lty=3:2, log=true, xlab="remission (weeks)", ylab="log-survival", main="gehan") Plot curves and CI; default CI are on the log scale log=true plots y axis (i.e. S(t)) on the log scale (i.e. y axis shows the hegative cumulative hazard) Gehan Survival control 6 MP Remission (weeks) 9-13

15 Log-Rank Test for Homogeneity Non-parametric test Compare two populations with hazard functions λ i (t), i = 1, 2. Collect two samples from each population. Construct a pooled sample with k distinct event times Distinct Failure t 1 t i t k Time Pool # of Failures d 1 d i d k Sample # survivors n 1 n i n k right before t i Sample # of Failures d 11 d 1i d 1k 1 # survivors t i n 11 n 1i n 1k right before t i Sample # of Failures d 21 d 2i d 2k 2 # survivors n 21 n 2i n 2k right before t i Note d i = d 1i + d 2i, n i = n 1i + n 2i, i = 1,, k Test the hypotheses vs. H 0 : λ 1 (t) = λ 2 (t), t τ H a : λ 1 (t) λ 2 (t) for some t τ 9-14

16 Log-Rank Test for Homogeneity: Procedure Consider [t i, t i + ) for small Sample Sample Pooled 1 2 Sample # failures d 1i d 2i d i # survivors at t i n 1i d 1i n 2i d 2i n i d i # of survivors t i n 1i n 2i n i right before t i If λ 1 (t) λ 2 (t) around t i, there should be association between sample and event in this 2 2 table d 1i (n i, d i, n 1i ) H 0 Hypergeometric(n i, d i, n 1i ): ( ) ( di ni d i x n 1i x P (d 1i = x n i, d i, n 1i ) = = E[d 1i n i, d i, n 1i ] = d in 1i n i Define U = [ ] k i=1 d 1i d in 1i n i ( ni n 1i ) ) E[U] = 0, var(u) = k i=1 U/ var(u) 1/2 H 0, asy N(0, 1) d i n 1i (n i d i )(n i n 1i ) n 2 i (n i 1) 9-15

17 Log-Rank Test in R (Venable & Ripley Sec.13.2) >?survdiff > survdiff(surv(time,cens)~treat,data=gehan) N Observed Expected (O-E)^2/E (O-E)^2/V treat=6-mp treat=control Chisq= 16.8 on 1 degrees of freedom, p= 4.17e-05 Conclusion: Reject H 0 Warning: this test does not adjust for covariates, and may often be inappropriate Appropriate for this study, since the individuals are matched pairs 9-16

18 Parametric Estimation of Survival Function and Comparison Between Groups 9-17

19 The Likelihood Function The likelihood of i-th observation (y i, δ i, x i ): { f(yi X i ), if δ i = 1, (not censored) S(y i X i ), if δ i = 0, (right censored) The likelihood of the data is L(β) n i=1 { [f(yi X i )] δ i[s(y i X i )] 1 δ i} The inference approaches based on the likelihood function can be applied. See chapter by Lee on ML parameter estimation Use AIC or BIC to compare nested models. Graphical check of model adequacy Plot Λ(t) vs. t for exponential models; Plot log( Λ) vs. log(t) for Weibull models; Can also plot deviance residuals. 9-18

20 Accounting for Covariates: Models for Hazard Function General form: λ(t) = λ 0 (t)e x β λ 0 (t): the baseline hazard e x β : multiplicative effect, independent of time Implications for the Survival Function: S(t) = e Λ(t) = e t 0 λ(s) ds = e Λ 0 (t)e x β log Λ(t) = log[ log S(t)] = log Λ 0 + x β If the model is appropriate, a plot of log[ log S(t) KM ] for different groups yields roughly parallel lines 9-19

21 Accounting for Covariates: Models for Hazard Function Exponential distribution, no predictors: λ(t) = ρ - constant hazard function S(t) = e ρ t - survival function Exponential distribution, one predictor: λ(t) = e β 0+β 1 X = e β 0 eβ 1X, e β 0 plays the role of λ 0, i.e. the constant baseline hazard Weibull distribution, no predictors: λ(t) = λ p p t p 1 - hazard function S(t) = e (λ t)p - survival function Weibull distribution, one predictor: λ(t) = p t p 1 e (β 0+β 1 X) p = p t p 1 e βp 0 e pβ 1 X e β 0+β 1 X plays the role of λ in overall hazard p t p 1 e βp 0 is the baseline hazard e β 0 plays the role of λ in the baseline hazard 9-20

22 More on Proportional Hazard Assumption of proportional hazard implies: The hazard ratio for two subjects i and j with different covariates, at a gven time is λ i (t) λ j (t) = λ 0(t) λ 0 (t) eβ0+β1xi e β 0+β 1 X j = e (X i X j ) β constant over time only function of covariates Can graphically verify the assumption of proportional hazard. Check for parallel lines of Ŝ KM (t) on the complementary log-log scale For the gehan dataset: > plot(fit, lty=3:4, col=2:3, fun="cloglog", xlab="remission (weeks)", ylab="log Lambda(t)") > legend("topleft", c("control", "6-MP"), lty=4:3, col=3:2) 9-21

23 Verify the Assumption of Proportional Hazard: Gehan Study log Lambda(t) control 6 MP Remission (weeks) Good agreement with the additive structure on the log-log scale The assumption of proportional hazard is plausible 9-22

24 Accounting for Covariates: Models fot Survival Function Also called Accelerated Failure Models S(t) = S 0 (t e x β ) S 0 is the baseline survival function Covariates accelerate or contract the time to event Survival time T 0 = T e x β has a fixed distribution log T 0 = log T + X β, log T = log T 0 X β Weibull (and its special case Exponential) are the only distributions that can be simultaneously (and equivalently) specified as proportional hazard and accelerated failure models. 9-23

25 Accelerated Failure: Exponential Exponential distribution: λ(t) = ρ, S(t) = e ρ t S 0 (t) = e t - survival of the standard exponential Effect of the covariates: S(t) = S 0 (t e β 0+β 1 X ), e β 0+β 1 X = ρ If T 0 exp(1), and T are the observed times T 0 = T e β 0+β 1 X log T 0 = log T + β 0 + β 1 X, and log T = β 0 β 1 X + log T 0 In R: log T = β 0 + β 1 X + σ log ε, σ is a scale parameter fixed at σ = 1 ε Exp(1) use opposite sign of ˆβ to estimate survival: Ŝ(t) = S 0 (t e ˆβ 0 ˆβ X 1 ) 9-24

26 Accelerated Failure: Exponential > fit.exponential <- survreg(surv(time,cens) ~ treat, data=gehan, dist="exponential") > summary(fit.exponential) Value Std. Error z p (Intercept) e-28 treatcontrol e-04 Scale fixed at 1 Exponential distribution Loglik(model)= Loglik(intercept only)= Chisq= on 1 degrees of freedom, p= 4.9e-05 Parameter interpretation: β treatcontrol = 1.53 > 0 time until remission is longer for controls Predicted survival above T = 10 for trt: exp(-10*exp(-3.69))= comparable to ŜKM trt (10) =

27 Accelerated Failure: Weibull Weibull distribution: λ(t) = λ p p t p 1 - hazard function S(t) = e (λ t)p - survival function Can be viewed as the survival function of the exponential random variable T = T p Exp(λ p ) Effect of the covariates: Identical to the exponential: S(t ) = S 0 (t e β 0+β 1 X ), e β 0+β 1 X = λ p If T 0 exp(1), and T are the observed times T 0 = T e β 0+β 1 X log T 0 = log T + β 0 + β 1 X Returning to the original notation T = T p : log T 0 = p logt + β 0 + β 1 X log T = 1 p β 0 1 p β 1X + 1 p log T

28 Accelerated Failure: Weibull In R Weibull is the default distribution: log T = β 0 + β 1 X + σ log ε, σ is a scale parameter, σ = 1 p, ε Exp(1) use ˆβ/ˆσ to estimate survival: Ŝ(t) = S 0 (t 1/σ e ˆβ 0 /σ ˆβ /σx 1 ) > fit.weibull <- survreg(surv(time,cens)~treat, data=gehan) > summary(fit.weibull) Value Std. Error z p (Intercept) e-44 treatcontrol e-05 Log(scale) e-02 Scale= Weibull distribution Loglik(model)= Loglik(intercept only)= Chisq= on 1 degrees of freedom, p= 9.3e-06 Predicted survival above T = 10 for trt: exp(-10^(1/0.732)*exp( /0.732))= comparable to ŜKM trt (10) =

29 Variable Selection and Prediction Compare models with and without pair as blocking factor anova( survreg(surv(time,cens) ~ treat, data=gehan), survreg(surv(time,cens)~factor(pair)+treat, data=gehan)) Terms Res.Df -2*LL TestDf Deviance P(> Chi ) treat NA NA NA (pair)+treat (pair) Prediction for the median survival On the linear predictor scale > fit.weibull.nopairs <- survreg(surv(time,cens)~treat, data=gehan) >?predict.survreg > pred.contr <- predict(fit.weibull.nopairs, data.frame(treat= control ), type="uquantile", p=0.5, se=true) On the survival function scale > exp( c(l=pred.contr$fit - 2*pred.contr$se.fit, U=pred.contr$fit + 2*pred.contr$se.fit) ) L.1 U

30 Cox Proportional Hazards Model A semi-parametric approach 9-29

31 Cox Proportional Hazards (Relative Risk) Model Assume: C i and T i conditionally independent, given X i. Observe k distinct exact failure times (i.e. δ i = 1); t 1 < t 2 < < t k. No ties in observed exact failure times (i.e., if δ i = δ j = 1, then y i y j for i j). Define the risk set at time t R(t) = {i : y i t} = {individuals alive right before time t} Cox (1975) considered the conditional probability Probability of event in a small interval around t j, given that the individual is in the risk set P (ind. i failed at [t j, t j + ) i R(t j )) λ(t j ) k R(t j ) λ(t j) 9-30

32 Partial Likelihood Approach to Estimate β (Cox, 1975) With covariate X i (t), assume a proportional hazards model λ(t) = λ 0 (t) exp X i (t) β(t) where λ 0 (t) is a baseline hazard and e X i β(t) is the relative risk. Treating λ 0 (t) as a nuisance parameter, one may estimate β(t) by maximizing the partial likelihood L(β) = j exp X i (t j ) β(t j ) l R(t j ) exp X l(t) β(t j ), where the i(j)th item fails at t j and R(t j ) is the risk set at t j. Conditional on the history up to t j and the fact that one item fails at t j, each term within the product is proportional to the likelihood of a multinomial model. λ 0 (t) is not specified, which is the non-parametric part of the model. X l (t) β(t j ) is the parametric part of the model. 9-31

33 Partial Likelihood Approach to Estimate β (Cox, 1975) The partial likelihood function by Cox (1975) is { } n obs e X β i n L(β) = k R(t j ) β = e X β δi i ex k i=1 i=1 k R(y i ) ex k β Cox argued that the partial likelihood has all properties of an usual likelihood, e.g., maximizing it for an optimal β = maximum partial likelihood estimator (MPLE) ˆβ Breslow s Estimator of the Baseline Cumulative Hazard Rate: ˆΛ 1 0 (t) = i R(t) ˆβ = ex j j:t j t i:y i t δ i j R(y i ) ex j ˆβ There are different ways to relax Assumption 3 to handle tied failure times, e.g., exact method, Efron s method, and Breslow s method. Method R Options Comment Exact method="exact" accurate, long Efron s method="efron" approximate, better Breslow s method="breslow" approximate 9-32

34 Cox Proportional Hazard Use exact method to account for ties ˆβ > 0 as expected > fit.cox1 <-coxph(surv(time,cens)~treat, method="exact", data=gehan) > summary(fit.cox1) n= 42, number of events= 30 coef exp(coef) se(coef) z Pr(> z ) treatcontrol *** exp(coef) exp(-coef) lower.95 upper.95 treatcontrol Rsquare= (max possible= 0.98 ) Likelihood ratio test= on 1 df, p=5.544e-05 Wald test = on 1 df, p= Score (logrank) test = on 1 df, p=4.169e

35 Cox Proportional Hazard Add pair as block > fit.cox2 <- coxph(surv(time,cens)~treat+factor(pair), method="exact", data=gehan) > summary(fit.cox2) coef exp(coef) se(coef) z Pr(> z ) treatcontrol e-06 *** factor(pair) ** factor(pair) *... Rsquare= (max possible= 0.98 ) Likelihood ratio test= on 21 df, p= Wald test = on 21 df, p= Score (logrank) test = on 21 df, p= LR test compares log(partial likelihoods), but the test has similar properties > anova(fit.cox1, fit.cox2, test="chisq") Analysis of Deviance Table Cox model: response is Surv(time, cens) Model 1: ~ treat Model 2: ~ treat + factor(pair) loglik Chisq Df P(> Chi )

36 Visualize Model Fit Survival curve and CI for an individual with average covariates K-M curves refer to unadjusted populations, Cox curves refer to an average patient can make survival curves for the Cox model for specific values of covariates by providing newdata >plot(survfit(fit.cox1),lty=2:3,xlab="remission (weeks)", ylab="survival", main="gehan", cex=1.5) Gehan Survival Remission (weeks) 9-35

37 Model Diagnostics Cox-Snell residuals are most useful for examining the overall fit of a model r c,i = log[ŝ(y i x i )] = ˆΛ(y i x i ) = ˆΛ 0 (y i )e X i ˆβ Λ 0 (t) is estimated by the Breslow s estimator. If the estimates ˆΛ 0 (t) and ˆβ were accurate, {(r c,i, δ i ), i = 1,, n} are right-censored observations of Exponential(1). For the right-censored data {(r c,i, δ i ), i = 1,, n}, construct the Nelson-Aalen estimator Λ(t) and plot Λ(t) vs. t. Martingale residuals can be used to determine the functional form of a covariate r m,i = δ j r c,j Fit the Cox model with all covariates except the one of interest, and plot the martingale residuals against the covariate of interest. Deviance residuals are approximately symmetrically distributed about zero and large values may indicate outliers. r d,i = sign(r m,i ) 2[r m,i + δ i log(r c,j )] 9-36

Survival Analysis. Stat 526. April 13, 2018

Survival Analysis. Stat 526. April 13, 2018 Survival Analysis Stat 526 April 13, 2018 1 Functions of Survival Time Let T be the survival time for a subject Then P [T < 0] = 0 and T is a continuous random variable The Survival function is defined

More information

Survival Regression Models

Survival Regression Models Survival Regression Models David M. Rocke May 18, 2017 David M. Rocke Survival Regression Models May 18, 2017 1 / 32 Background on the Proportional Hazards Model The exponential distribution has constant

More information

Typical Survival Data Arising From a Clinical Trial. Censoring. The Survivor Function. Mathematical Definitions Introduction

Typical Survival Data Arising From a Clinical Trial. Censoring. The Survivor Function. Mathematical Definitions Introduction Outline CHL 5225H Advanced Statistical Methods for Clinical Trials: Survival Analysis Prof. Kevin E. Thorpe Defining Survival Data Mathematical Definitions Non-parametric Estimates of Survival Comparing

More information

Lecture 7. Proportional Hazards Model - Handling Ties and Survival Estimation Statistics Survival Analysis. Presented February 4, 2016

Lecture 7. Proportional Hazards Model - Handling Ties and Survival Estimation Statistics Survival Analysis. Presented February 4, 2016 Proportional Hazards Model - Handling Ties and Survival Estimation Statistics 255 - Survival Analysis Presented February 4, 2016 likelihood - Discrete Dan Gillen Department of Statistics University of

More information

In contrast, parametric techniques (fitting exponential or Weibull, for example) are more focussed, can handle general covariates, but require

In contrast, parametric techniques (fitting exponential or Weibull, for example) are more focussed, can handle general covariates, but require Chapter 5 modelling Semi parametric We have considered parametric and nonparametric techniques for comparing survival distributions between different treatment groups. Nonparametric techniques, such as

More information

Chapter 4 Regression Models

Chapter 4 Regression Models 23.August 2010 Chapter 4 Regression Models The target variable T denotes failure time We let x = (x (1),..., x (m) ) represent a vector of available covariates. Also called regression variables, regressors,

More information

Survival analysis in R

Survival analysis in R Survival analysis in R Niels Richard Hansen This note describes a few elementary aspects of practical analysis of survival data in R. For further information we refer to the book Introductory Statistics

More information

Survival analysis in R

Survival analysis in R Survival analysis in R Niels Richard Hansen This note describes a few elementary aspects of practical analysis of survival data in R. For further information we refer to the book Introductory Statistics

More information

Lecture 8 Stat D. Gillen

Lecture 8 Stat D. Gillen Statistics 255 - Survival Analysis Presented February 23, 2016 Dan Gillen Department of Statistics University of California, Irvine 8.1 Example of two ways to stratify Suppose a confounder C has 3 levels

More information

MAS3301 / MAS8311 Biostatistics Part II: Survival

MAS3301 / MAS8311 Biostatistics Part II: Survival MAS3301 / MAS8311 Biostatistics Part II: Survival M. Farrow School of Mathematics and Statistics Newcastle University Semester 2, 2009-10 1 13 The Cox proportional hazards model 13.1 Introduction In the

More information

β j = coefficient of x j in the model; β = ( β1, β2,

β j = coefficient of x j in the model; β = ( β1, β2, Regression Modeling of Survival Time Data Why regression models? Groups similar except for the treatment under study use the nonparametric methods discussed earlier. Groups differ in variables (covariates)

More information

Survival Analysis Math 434 Fall 2011

Survival Analysis Math 434 Fall 2011 Survival Analysis Math 434 Fall 2011 Part IV: Chap. 8,9.2,9.3,11: Semiparametric Proportional Hazards Regression Jimin Ding Math Dept. www.math.wustl.edu/ jmding/math434/fall09/index.html Basic Model Setup

More information

Part [1.0] Measures of Classification Accuracy for the Prediction of Survival Times

Part [1.0] Measures of Classification Accuracy for the Prediction of Survival Times Part [1.0] Measures of Classification Accuracy for the Prediction of Survival Times Patrick J. Heagerty PhD Department of Biostatistics University of Washington 1 Biomarkers Review: Cox Regression Model

More information

Power and Sample Size Calculations with the Additive Hazards Model

Power and Sample Size Calculations with the Additive Hazards Model Journal of Data Science 10(2012), 143-155 Power and Sample Size Calculations with the Additive Hazards Model Ling Chen, Chengjie Xiong, J. Philip Miller and Feng Gao Washington University School of Medicine

More information

STAT 6350 Analysis of Lifetime Data. Failure-time Regression Analysis

STAT 6350 Analysis of Lifetime Data. Failure-time Regression Analysis STAT 6350 Analysis of Lifetime Data Failure-time Regression Analysis Explanatory Variables for Failure Times Usually explanatory variables explain/predict why some units fail quickly and some units survive

More information

Chapter 4 Fall Notations: t 1 < t 2 < < t D, D unique death times. d j = # deaths at t j = n. Y j = # at risk /alive at t j = n

Chapter 4 Fall Notations: t 1 < t 2 < < t D, D unique death times. d j = # deaths at t j = n. Y j = # at risk /alive at t j = n Bios 323: Applied Survival Analysis Qingxia (Cindy) Chen Chapter 4 Fall 2012 4.2 Estimators of the survival and cumulative hazard functions for RC data Suppose X is a continuous random failure time with

More information

Beyond GLM and likelihood

Beyond GLM and likelihood Stat 6620: Applied Linear Models Department of Statistics Western Michigan University Statistics curriculum Core knowledge (modeling and estimation) Math stat 1 (probability, distributions, convergence

More information

Lecture 22 Survival Analysis: An Introduction

Lecture 22 Survival Analysis: An Introduction University of Illinois Department of Economics Spring 2017 Econ 574 Roger Koenker Lecture 22 Survival Analysis: An Introduction There is considerable interest among economists in models of durations, which

More information

UNIVERSITY OF CALIFORNIA, SAN DIEGO

UNIVERSITY OF CALIFORNIA, SAN DIEGO UNIVERSITY OF CALIFORNIA, SAN DIEGO Estimation of the primary hazard ratio in the presence of a secondary covariate with non-proportional hazards An undergraduate honors thesis submitted to the Department

More information

Analysis of Time-to-Event Data: Chapter 6 - Regression diagnostics

Analysis of Time-to-Event Data: Chapter 6 - Regression diagnostics Analysis of Time-to-Event Data: Chapter 6 - Regression diagnostics Steffen Unkel Department of Medical Statistics University Medical Center Göttingen, Germany Winter term 2018/19 1/25 Residuals for the

More information

Accelerated Failure Time Models

Accelerated Failure Time Models Accelerated Failure Time Models Patrick Breheny October 12 Patrick Breheny University of Iowa Survival Data Analysis (BIOS 7210) 1 / 29 The AFT model framework Last time, we introduced the Weibull distribution

More information

Survival Analysis: Weeks 2-3. Lu Tian and Richard Olshen Stanford University

Survival Analysis: Weeks 2-3. Lu Tian and Richard Olshen Stanford University Survival Analysis: Weeks 2-3 Lu Tian and Richard Olshen Stanford University 2 Kaplan-Meier(KM) Estimator Nonparametric estimation of the survival function S(t) = pr(t > t) The nonparametric estimation

More information

REGRESSION ANALYSIS FOR TIME-TO-EVENT DATA THE PROPORTIONAL HAZARDS (COX) MODEL ST520

REGRESSION ANALYSIS FOR TIME-TO-EVENT DATA THE PROPORTIONAL HAZARDS (COX) MODEL ST520 REGRESSION ANALYSIS FOR TIME-TO-EVENT DATA THE PROPORTIONAL HAZARDS (COX) MODEL ST520 Department of Statistics North Carolina State University Presented by: Butch Tsiatis, Department of Statistics, NCSU

More information

TMA 4275 Lifetime Analysis June 2004 Solution

TMA 4275 Lifetime Analysis June 2004 Solution TMA 4275 Lifetime Analysis June 2004 Solution Problem 1 a) Observation of the outcome is censored, if the time of the outcome is not known exactly and only the last time when it was observed being intact,

More information

Other Survival Models. (1) Non-PH models. We briefly discussed the non-proportional hazards (non-ph) model

Other Survival Models. (1) Non-PH models. We briefly discussed the non-proportional hazards (non-ph) model Other Survival Models (1) Non-PH models We briefly discussed the non-proportional hazards (non-ph) model λ(t Z) = λ 0 (t) exp{β(t) Z}, where β(t) can be estimated by: piecewise constants (recall how);

More information

Exercises. (a) Prove that m(t) =

Exercises. (a) Prove that m(t) = Exercises 1. Lack of memory. Verify that the exponential distribution has the lack of memory property, that is, if T is exponentially distributed with parameter λ > then so is T t given that T > t for

More information

Lecture 6 PREDICTING SURVIVAL UNDER THE PH MODEL

Lecture 6 PREDICTING SURVIVAL UNDER THE PH MODEL Lecture 6 PREDICTING SURVIVAL UNDER THE PH MODEL The Cox PH model: λ(t Z) = λ 0 (t) exp(β Z). How do we estimate the survival probability, S z (t) = S(t Z) = P (T > t Z), for an individual with covariates

More information

STAT 526 Spring Final Exam. Thursday May 5, 2011

STAT 526 Spring Final Exam. Thursday May 5, 2011 STAT 526 Spring 2011 Final Exam Thursday May 5, 2011 Time: 2 hours Name (please print): Show all your work and calculations. Partial credit will be given for work that is partially correct. Points will

More information

STAT331. Cox s Proportional Hazards Model

STAT331. Cox s Proportional Hazards Model STAT331 Cox s Proportional Hazards Model In this unit we introduce Cox s proportional hazards (Cox s PH) model, give a heuristic development of the partial likelihood function, and discuss adaptations

More information

Lecture 12. Multivariate Survival Data Statistics Survival Analysis. Presented March 8, 2016

Lecture 12. Multivariate Survival Data Statistics Survival Analysis. Presented March 8, 2016 Statistics 255 - Survival Analysis Presented March 8, 2016 Dan Gillen Department of Statistics University of California, Irvine 12.1 Examples Clustered or correlated survival times Disease onset in family

More information

Lecture 4 - Survival Models

Lecture 4 - Survival Models Lecture 4 - Survival Models Survival Models Definition and Hazards Kaplan Meier Proportional Hazards Model Estimation of Survival in R GLM Extensions: Survival Models Survival Models are a common and incredibly

More information

Residuals and model diagnostics

Residuals and model diagnostics Residuals and model diagnostics Patrick Breheny November 10 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/42 Introduction Residuals Many assumptions go into regression models, and the Cox proportional

More information

Fitting Cox Regression Models

Fitting Cox Regression Models Department of Psychology and Human Development Vanderbilt University GCM, 2010 1 Introduction 2 3 4 Introduction The Partial Likelihood Method Implications and Consequences of the Cox Approach 5 Introduction

More information

Multistate models and recurrent event models

Multistate models and recurrent event models and recurrent event models Patrick Breheny December 6 Patrick Breheny University of Iowa Survival Data Analysis (BIOS:7210) 1 / 22 Introduction In this final lecture, we will briefly look at two other

More information

Multistate models and recurrent event models

Multistate models and recurrent event models Multistate models Multistate models and recurrent event models Patrick Breheny December 10 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/22 Introduction Multistate models In this final lecture,

More information

Cox s proportional hazards model and Cox s partial likelihood

Cox s proportional hazards model and Cox s partial likelihood Cox s proportional hazards model and Cox s partial likelihood Rasmus Waagepetersen October 12, 2018 1 / 27 Non-parametric vs. parametric Suppose we want to estimate unknown function, e.g. survival function.

More information

Relative-risk regression and model diagnostics. 16 November, 2015

Relative-risk regression and model diagnostics. 16 November, 2015 Relative-risk regression and model diagnostics 16 November, 2015 Relative risk regression More general multiplicative intensity model: Intensity for individual i at time t is i(t) =Y i (t)r(x i, ; t) 0

More information

DAGStat Event History Analysis.

DAGStat Event History Analysis. DAGStat 2016 Event History Analysis Robin.Henderson@ncl.ac.uk 1 / 75 Schedule 9.00 Introduction 10.30 Break 11.00 Regression Models, Frailty and Multivariate Survival 12.30 Lunch 13.30 Time-Variation and

More information

9 Estimating the Underlying Survival Distribution for a

9 Estimating the Underlying Survival Distribution for a 9 Estimating the Underlying Survival Distribution for a Proportional Hazards Model So far the focus has been on the regression parameters in the proportional hazards model. These parameters describe the

More information

Survival Analysis. Lu Tian and Richard Olshen Stanford University

Survival Analysis. Lu Tian and Richard Olshen Stanford University 1 Survival Analysis Lu Tian and Richard Olshen Stanford University 2 Survival Time/ Failure Time/Event Time We will introduce various statistical methods for analyzing survival outcomes What is the survival

More information

Statistics 262: Intermediate Biostatistics Non-parametric Survival Analysis

Statistics 262: Intermediate Biostatistics Non-parametric Survival Analysis Statistics 262: Intermediate Biostatistics Non-parametric Survival Analysis Jonathan Taylor & Kristin Cobb Statistics 262: Intermediate Biostatistics p.1/?? Overview of today s class Kaplan-Meier Curve

More information

e 4β e 4β + e β ˆβ =0.765

e 4β e 4β + e β ˆβ =0.765 SIMPLE EXAMPLE COX-REGRESSION i Y i x i δ i 1 5 12 0 2 10 10 1 3 40 3 0 4 80 5 0 5 120 3 1 6 400 4 1 7 600 1 0 Model: z(t x) =z 0 (t) exp{βx} Partial likelihood: L(β) = e 10β e 10β + e 3β + e 5β + e 3β

More information

ADVANCED STATISTICAL ANALYSIS OF EPIDEMIOLOGICAL STUDIES. Cox s regression analysis Time dependent explanatory variables

ADVANCED STATISTICAL ANALYSIS OF EPIDEMIOLOGICAL STUDIES. Cox s regression analysis Time dependent explanatory variables ADVANCED STATISTICAL ANALYSIS OF EPIDEMIOLOGICAL STUDIES Cox s regression analysis Time dependent explanatory variables Henrik Ravn Bandim Health Project, Statens Serum Institut 4 November 2011 1 / 53

More information

Part III. Hypothesis Testing. III.1. Log-rank Test for Right-censored Failure Time Data

Part III. Hypothesis Testing. III.1. Log-rank Test for Right-censored Failure Time Data 1 Part III. Hypothesis Testing III.1. Log-rank Test for Right-censored Failure Time Data Consider a survival study consisting of n independent subjects from p different populations with survival functions

More information

Lecture 7 Time-dependent Covariates in Cox Regression

Lecture 7 Time-dependent Covariates in Cox Regression Lecture 7 Time-dependent Covariates in Cox Regression So far, we ve been considering the following Cox PH model: λ(t Z) = λ 0 (t) exp(β Z) = λ 0 (t) exp( β j Z j ) where β j is the parameter for the the

More information

Survival Analysis I (CHL5209H)

Survival Analysis I (CHL5209H) Survival Analysis Dalla Lana School of Public Health University of Toronto olli.saarela@utoronto.ca January 7, 2015 31-1 Literature Clayton D & Hills M (1993): Statistical Models in Epidemiology. Not really

More information

STAT Sample Problem: General Asymptotic Results

STAT Sample Problem: General Asymptotic Results STAT331 1-Sample Problem: General Asymptotic Results In this unit we will consider the 1-sample problem and prove the consistency and asymptotic normality of the Nelson-Aalen estimator of the cumulative

More information

ST745: Survival Analysis: Nonparametric methods

ST745: Survival Analysis: Nonparametric methods ST745: Survival Analysis: Nonparametric methods Eric B. Laber Department of Statistics, North Carolina State University February 5, 2015 The KM estimator is used ubiquitously in medical studies to estimate

More information

Time-dependent coefficients

Time-dependent coefficients Time-dependent coefficients Patrick Breheny December 1 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/20 Introduction As we discussed previously, stratification allows one to handle variables that

More information

Tied survival times; estimation of survival probabilities

Tied survival times; estimation of survival probabilities Tied survival times; estimation of survival probabilities Patrick Breheny November 5 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/22 Introduction Tied survival times Introduction Breslow approximation

More information

MAS3301 / MAS8311 Biostatistics Part II: Survival

MAS3301 / MAS8311 Biostatistics Part II: Survival MAS330 / MAS83 Biostatistics Part II: Survival M. Farrow School of Mathematics and Statistics Newcastle University Semester 2, 2009-0 8 Parametric models 8. Introduction In the last few sections (the KM

More information

Cox s proportional hazards/regression model - model assessment

Cox s proportional hazards/regression model - model assessment Cox s proportional hazards/regression model - model assessment Rasmus Waagepetersen September 27, 2017 Topics: Plots based on estimated cumulative hazards Cox-Snell residuals: overall check of fit Martingale

More information

Lecture 9. Statistics Survival Analysis. Presented February 23, Dan Gillen Department of Statistics University of California, Irvine

Lecture 9. Statistics Survival Analysis. Presented February 23, Dan Gillen Department of Statistics University of California, Irvine Statistics 255 - Survival Analysis Presented February 23, 2016 Dan Gillen Department of Statistics University of California, Irvine 9.1 Survival analysis involves subjects moving through time Hazard may

More information

You know I m not goin diss you on the internet Cause my mama taught me better than that I m a survivor (What?) I m not goin give up (What?

You know I m not goin diss you on the internet Cause my mama taught me better than that I m a survivor (What?) I m not goin give up (What? You know I m not goin diss you on the internet Cause my mama taught me better than that I m a survivor (What?) I m not goin give up (What?) I m not goin stop (What?) I m goin work harder (What?) Sir David

More information

Lecture 7. Poisson and lifetime processes in risk analysis

Lecture 7. Poisson and lifetime processes in risk analysis Lecture 7. Poisson and lifetime processes in risk analysis Jesper Rydén Department of Mathematics, Uppsala University jesper.ryden@math.uu.se Statistical Risk Analysis Spring 2014 Example: Life times of

More information

Lecture 11. Interval Censored and. Discrete-Time Data. Statistics Survival Analysis. Presented March 3, 2016

Lecture 11. Interval Censored and. Discrete-Time Data. Statistics Survival Analysis. Presented March 3, 2016 Statistics 255 - Survival Analysis Presented March 3, 2016 Motivating Dan Gillen Department of Statistics University of California, Irvine 11.1 First question: Are the data truly discrete? : Number of

More information

Comparison of Hazard, Odds and Risk Ratio in the Two-Sample Survival Problem

Comparison of Hazard, Odds and Risk Ratio in the Two-Sample Survival Problem Western Michigan University ScholarWorks at WMU Dissertations Graduate College 8-2014 Comparison of Hazard, Odds and Risk Ratio in the Two-Sample Survival Problem Benedict P. Dormitorio Western Michigan

More information

Statistical Inference and Methods

Statistical Inference and Methods Department of Mathematics Imperial College London d.stephens@imperial.ac.uk http://stats.ma.ic.ac.uk/ das01/ 31st January 2006 Part VI Session 6: Filtering and Time to Event Data Session 6: Filtering and

More information

Statistics in medicine

Statistics in medicine Statistics in medicine Lecture 4: and multivariable regression Fatma Shebl, MD, MS, MPH, PhD Assistant Professor Chronic Disease Epidemiology Department Yale School of Public Health Fatma.shebl@yale.edu

More information

Lecture 10. Diagnostics. Statistics Survival Analysis. Presented March 1, 2016

Lecture 10. Diagnostics. Statistics Survival Analysis. Presented March 1, 2016 Statistics 255 - Survival Analysis Presented March 1, 2016 Dan Gillen Department of Statistics University of California, Irvine 10.1 Are model assumptions correct? Is the proportional hazards assumption

More information

1 Introduction. 2 Residuals in PH model

1 Introduction. 2 Residuals in PH model Supplementary Material for Diagnostic Plotting Methods for Proportional Hazards Models With Time-dependent Covariates or Time-varying Regression Coefficients BY QIQING YU, JUNYI DONG Department of Mathematical

More information

Key Words: survival analysis; bathtub hazard; accelerated failure time (AFT) regression; power-law distribution.

Key Words: survival analysis; bathtub hazard; accelerated failure time (AFT) regression; power-law distribution. POWER-LAW ADJUSTED SURVIVAL MODELS William J. Reed Department of Mathematics & Statistics University of Victoria PO Box 3060 STN CSC Victoria, B.C. Canada V8W 3R4 reed@math.uvic.ca Key Words: survival

More information

8. Parametric models in survival analysis General accelerated failure time models for parametric regression

8. Parametric models in survival analysis General accelerated failure time models for parametric regression 8. Parametric models in survival analysis 8.1. General accelerated failure time models for parametric regression The accelerated failure time model Let T be the time to event and x be a vector of covariates.

More information

Lecture 5 Models and methods for recurrent event data

Lecture 5 Models and methods for recurrent event data Lecture 5 Models and methods for recurrent event data Recurrent and multiple events are commonly encountered in longitudinal studies. In this chapter we consider ordered recurrent and multiple events.

More information

Solution to Series 3

Solution to Series 3 Dr. A. Hauser Survival Analysis AS 2018 Solution to Series 3 1. a) > library(mass) > library(survival) > t.url d.diabetes

More information

Chapter 7 Fall Chapter 7 Hypothesis testing Hypotheses of interest: (A) 1-sample

Chapter 7 Fall Chapter 7 Hypothesis testing Hypotheses of interest: (A) 1-sample Bios 323: Applied Survival Analysis Qingxia (Cindy) Chen Chapter 7 Fall 2012 Chapter 7 Hypothesis testing Hypotheses of interest: (A) 1-sample H 0 : S(t) = S 0 (t), where S 0 ( ) is known survival function,

More information

11 Survival Analysis and Empirical Likelihood

11 Survival Analysis and Empirical Likelihood 11 Survival Analysis and Empirical Likelihood The first paper of empirical likelihood is actually about confidence intervals with the Kaplan-Meier estimator (Thomas and Grunkmeier 1979), i.e. deals with

More information

Definitions and examples Simple estimation and testing Regression models Goodness of fit for the Cox model. Recap of Part 1. Per Kragh Andersen

Definitions and examples Simple estimation and testing Regression models Goodness of fit for the Cox model. Recap of Part 1. Per Kragh Andersen Recap of Part 1 Per Kragh Andersen Section of Biostatistics, University of Copenhagen DSBS Course Survival Analysis in Clinical Trials January 2018 1 / 65 Overview Definitions and examples Simple estimation

More information

Logistic regression model for survival time analysis using time-varying coefficients

Logistic regression model for survival time analysis using time-varying coefficients Logistic regression model for survival time analysis using time-varying coefficients Accepted in American Journal of Mathematical and Management Sciences, 2016 Kenichi SATOH ksatoh@hiroshima-u.ac.jp Research

More information

Efficient Semiparametric Estimators via Modified Profile Likelihood in Frailty & Accelerated-Failure Models

Efficient Semiparametric Estimators via Modified Profile Likelihood in Frailty & Accelerated-Failure Models NIH Talk, September 03 Efficient Semiparametric Estimators via Modified Profile Likelihood in Frailty & Accelerated-Failure Models Eric Slud, Math Dept, Univ of Maryland Ongoing joint project with Ilia

More information

Approximation of Survival Function by Taylor Series for General Partly Interval Censored Data

Approximation of Survival Function by Taylor Series for General Partly Interval Censored Data Malaysian Journal of Mathematical Sciences 11(3): 33 315 (217) MALAYSIAN JOURNAL OF MATHEMATICAL SCIENCES Journal homepage: http://einspem.upm.edu.my/journal Approximation of Survival Function by Taylor

More information

4. Comparison of Two (K) Samples

4. Comparison of Two (K) Samples 4. Comparison of Two (K) Samples K=2 Problem: compare the survival distributions between two groups. E: comparing treatments on patients with a particular disease. Z: Treatment indicator, i.e. Z = 1 for

More information

FULL LIKELIHOOD INFERENCES IN THE COX MODEL

FULL LIKELIHOOD INFERENCES IN THE COX MODEL October 20, 2007 FULL LIKELIHOOD INFERENCES IN THE COX MODEL BY JIAN-JIAN REN 1 AND MAI ZHOU 2 University of Central Florida and University of Kentucky Abstract We use the empirical likelihood approach

More information

Survival Analysis APTS 2016/17. Ingrid Van Keilegom ORSTAT KU Leuven. Glasgow, August 21-25, 2017

Survival Analysis APTS 2016/17. Ingrid Van Keilegom ORSTAT KU Leuven. Glasgow, August 21-25, 2017 Survival Analysis APTS 2016/17 Ingrid Van Keilegom ORSTAT KU Leuven Glasgow, August 21-25, 2017 Basic What is Survival analysis? Survival analysis (or duration analysis) is an area of statistics that and

More information

Estimation for Modified Data

Estimation for Modified Data Definition. Estimation for Modified Data 1. Empirical distribution for complete individual data (section 11.) An observation X is truncated from below ( left truncated) at d if when it is at or below d

More information

Lecture 2: Martingale theory for univariate survival analysis

Lecture 2: Martingale theory for univariate survival analysis Lecture 2: Martingale theory for univariate survival analysis In this lecture T is assumed to be a continuous failure time. A core question in this lecture is how to develop asymptotic properties when

More information

4 Testing Hypotheses. 4.1 Tests in the regression setting. 4.2 Non-parametric testing of survival between groups

4 Testing Hypotheses. 4.1 Tests in the regression setting. 4.2 Non-parametric testing of survival between groups 4 Testing Hypotheses The next lectures will look at tests, some in an actuarial setting, and in the last subsection we will also consider tests applied to graduation 4 Tests in the regression setting )

More information

Multistate Modeling and Applications

Multistate Modeling and Applications Multistate Modeling and Applications Yang Yang Department of Statistics University of Michigan, Ann Arbor IBM Research Graduate Student Workshop: Statistics for a Smarter Planet Yang Yang (UM, Ann Arbor)

More information

Semiparametric Regression

Semiparametric Regression Semiparametric Regression Patrick Breheny October 22 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/23 Introduction Over the past few weeks, we ve introduced a variety of regression models under

More information

Dynamic Models Part 1

Dynamic Models Part 1 Dynamic Models Part 1 Christopher Taber University of Wisconsin December 5, 2016 Survival analysis This is especially useful for variables of interest measured in lengths of time: Length of life after

More information

Economics 508 Lecture 22 Duration Models

Economics 508 Lecture 22 Duration Models University of Illinois Fall 2012 Department of Economics Roger Koenker Economics 508 Lecture 22 Duration Models There is considerable interest, especially among labor-economists in models of duration.

More information

Proportional hazards regression

Proportional hazards regression Proportional hazards regression Patrick Breheny October 8 Patrick Breheny Survival Data Analysis (BIOS 7210) 1/28 Introduction The model Solving for the MLE Inference Today we will begin discussing regression

More information

The coxvc_1-1-1 package

The coxvc_1-1-1 package Appendix A The coxvc_1-1-1 package A.1 Introduction The coxvc_1-1-1 package is a set of functions for survival analysis that run under R2.1.1 [81]. This package contains a set of routines to fit Cox models

More information

Analysis of Time-to-Event Data: Chapter 4 - Parametric regression models

Analysis of Time-to-Event Data: Chapter 4 - Parametric regression models Analysis of Time-to-Event Data: Chapter 4 - Parametric regression models Steffen Unkel Department of Medical Statistics University Medical Center Göttingen, Germany Winter term 2018/19 1/25 Right censored

More information

Analysis of Time-to-Event Data: Chapter 2 - Nonparametric estimation of functions of survival time

Analysis of Time-to-Event Data: Chapter 2 - Nonparametric estimation of functions of survival time Analysis of Time-to-Event Data: Chapter 2 - Nonparametric estimation of functions of survival time Steffen Unkel Department of Medical Statistics University Medical Center Göttingen, Germany Winter term

More information

Goodness-of-Fit Tests With Right-Censored Data by Edsel A. Pe~na Department of Statistics University of South Carolina Colloquium Talk August 31, 2 Research supported by an NIH Grant 1 1. Practical Problem

More information

Two-stage Adaptive Randomization for Delayed Response in Clinical Trials

Two-stage Adaptive Randomization for Delayed Response in Clinical Trials Two-stage Adaptive Randomization for Delayed Response in Clinical Trials Guosheng Yin Department of Statistics and Actuarial Science The University of Hong Kong Joint work with J. Xu PSI and RSS Journal

More information

Goodness-Of-Fit for Cox s Regression Model. Extensions of Cox s Regression Model. Survival Analysis Fall 2004, Copenhagen

Goodness-Of-Fit for Cox s Regression Model. Extensions of Cox s Regression Model. Survival Analysis Fall 2004, Copenhagen Outline Cox s proportional hazards model. Goodness-of-fit tools More flexible models R-package timereg Forthcoming book, Martinussen and Scheike. 2/38 University of Copenhagen http://www.biostat.ku.dk

More information

PhD course in Advanced survival analysis. One-sample tests. Properties. Idea: (ABGK, sect. V.1.1) Counting process N(t)

PhD course in Advanced survival analysis. One-sample tests. Properties. Idea: (ABGK, sect. V.1.1) Counting process N(t) PhD course in Advanced survival analysis. (ABGK, sect. V.1.1) One-sample tests. Counting process N(t) Non-parametric hypothesis tests. Parametric models. Intensity process λ(t) = α(t)y (t) satisfying Aalen

More information

Lecture 3. Truncation, length-bias and prevalence sampling

Lecture 3. Truncation, length-bias and prevalence sampling Lecture 3. Truncation, length-bias and prevalence sampling 3.1 Prevalent sampling Statistical techniques for truncated data have been integrated into survival analysis in last two decades. Truncation in

More information

Survival Times (in months) Survival Times (in months) Relative Frequency. Relative Frequency

Survival Times (in months) Survival Times (in months) Relative Frequency. Relative Frequency Smooth Goodness-of-Fit Tests in Hazard-Based Models by Edsel A. Pe~na Department of Statistics University of South Carolina at Columbia E-Mail: pena@stat.sc.edu Univ. of Virginia Colloquium Talk Department

More information

Follow this and additional works at: Part of the Applied Mathematics Commons

Follow this and additional works at:   Part of the Applied Mathematics Commons Louisiana State University LSU Digital Commons LSU Master's Theses Graduate School 2004 Cox Regression Model Lindsay Sarah Smith Louisiana State University and Agricultural and Mechanical College, lsmit51@lsu.edu

More information

Likelihood Construction, Inference for Parametric Survival Distributions

Likelihood Construction, Inference for Parametric Survival Distributions Week 1 Likelihood Construction, Inference for Parametric Survival Distributions In this section we obtain the likelihood function for noninformatively rightcensored survival data and indicate how to make

More information

Quantile Regression for Residual Life and Empirical Likelihood

Quantile Regression for Residual Life and Empirical Likelihood Quantile Regression for Residual Life and Empirical Likelihood Mai Zhou email: mai@ms.uky.edu Department of Statistics, University of Kentucky, Lexington, KY 40506-0027, USA Jong-Hyeon Jeong email: jeong@nsabp.pitt.edu

More information

Multivariable Fractional Polynomials

Multivariable Fractional Polynomials Multivariable Fractional Polynomials Axel Benner May 17, 2007 Contents 1 Introduction 1 2 Inventory of functions 1 3 Usage in R 2 3.1 Model selection........................................ 3 4 Example

More information

Müller: Goodness-of-fit criteria for survival data

Müller: Goodness-of-fit criteria for survival data Müller: Goodness-of-fit criteria for survival data Sonderforschungsbereich 386, Paper 382 (2004) Online unter: http://epub.ub.uni-muenchen.de/ Projektpartner Goodness of fit criteria for survival data

More information

Survival Times (in months) Survival Times (in months) Relative Frequency. Relative Frequency

Survival Times (in months) Survival Times (in months) Relative Frequency. Relative Frequency Smooth Goodness-of-Fit Tests in Hazard-Based Models by Edsel A. Pe~na Department of Statistics University of South Carolina at Columbia E-Mail: pena@stat.sc.edu Univ. of Georgia Colloquium Talk Department

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

Faculty of Health Sciences. Cox regression. Torben Martinussen. Department of Biostatistics University of Copenhagen. 20. september 2012 Slide 1/51

Faculty of Health Sciences. Cox regression. Torben Martinussen. Department of Biostatistics University of Copenhagen. 20. september 2012 Slide 1/51 Faculty of Health Sciences Cox regression Torben Martinussen Department of Biostatistics University of Copenhagen 2. september 212 Slide 1/51 Survival analysis Standard setup for right-censored survival

More information

Joint Modeling of Longitudinal Item Response Data and Survival

Joint Modeling of Longitudinal Item Response Data and Survival Joint Modeling of Longitudinal Item Response Data and Survival Jean-Paul Fox University of Twente Department of Research Methodology, Measurement and Data Analysis Faculty of Behavioural Sciences Enschede,

More information