Previous Page | Next Page

The MCMC Procedure

Example 52.8 Cox Models

This example has two purposes. One is to illustrate how to use PROC MCMC to fit a Cox proportional hazard model. Specifically, two models are considered: time independent and time dependent models. However, note that it is much easier to fit a Bayesian Cox model by specifying the BAYES statement in PROC PHREG (see Chapter 64, The PHREG Procedure ). If you are interested only in fitting a Cox regression survival model, you should use PROC PHREG.

The second objective of this example is to demonstrate how to model data that are not independent. That is the case where the likelihood for observation depends on other observations in the data set. In other words, if you work with a likelihood function that cannot be broken down simply as , you can use this example for illustrative purposes. By default, PROC MCMC assumes that the programming statements and model specification is intended for a single row of observations in the data set. The Cox model is chosen because the complexity in the data structure requires more elaborate coding.

The Cox proportional hazard model is widely used in the analysis of survival time, failure time, or other duration data to explain the effect of exogenous explanatory variables. The data set used in this example is taken from Krall, Uthoff, and Harley (1975), who analyzed data from a study on myeloma in which researchers treated 65 patients with alkylating agents. Of those patients, 48 died during the study and 17 survived. The following statements generate the data set that is used in this example:

   data Myeloma;
      input Time Vstatus LogBUN HGB Platelet Age LogWBC Frac
            LogPBM Protein SCalc;
      label Time='survival time'
            VStatus='0=alive 1=dead';
      datalines;
    1.25  1  2.2175   9.4  1  67  3.6628  1  1.9542  12  10
    1.25  1  1.9395  12.0  1  38  3.9868  1  1.9542  20  18
    2.00  1  1.5185   9.8  1  81  3.8751  1  2.0000   2  15
   
   ... more lines ...   

   77.00  0  1.0792  14.0  1  60  3.6812  0  0.9542   0  12
   ;
   proc sort data = Myeloma;
      by descending time;
   run;
    
   data _null_;
      set Myeloma nobs=_n;
      call symputx('N', _n);
      stop;
   run;

The variable Time represents the survival time in months from diagnosis. The variable VStatus consists of two values, 0 and 1, indicating whether the patient was alive or dead, respectively, at the end of the study. If the value of VStatus is 0, the corresponding value of Time is censored. The variables thought to be related to survival are LogBUN ( at diagnosis), HGB (hemoglobin at diagnosis), Platelet (platelets at diagnosis: 0=abnormal, 1=normal), Age (age at diagnosis in years), LogWBC (log(WBC) at diagnosis), Frac (fractures at diagnosis: 0=none, 1=present), LogPBM (log percentage of plasma cells in bone marrow), Protein (proteinuria at diagnosis), and SCalc (serum calcium at diagnosis). Interest lies in identifying important prognostic factors from these explanatory variables. In addition, there are 65 (&n) observations in the data set Myeloma. The likelihood used in these examples is the Brewslow likelihood:

     

where

  • is the vector parameters

  • is the total number of observations in the data set

  • is the th time, which can be either event time or censored time

  • is the vector explanatory variables for the th individual at time

  • is the multiplicity of failures at . If there are no ties in time, is 1 for all .

  • is the risk set for the th time , which includes all observations that have survival time greater than or equal to

  • indicates whether the patient is censored. The value 0 corresponds to censoring. Note that the censored time enters the likelihood function only through the formation of the risk set .

Priors on the coefficients are independent normal priors with very large variance (1e6). Throughout this example, the symbol bZ represents the regression term in the likelihood, and the symbol S represents the term .

Time Independent Model

The regression model considered in this example uses the following formula:

     
     

The hard part of coding this in PROC MCMC is the construction of the risk set . contains all observations that have survival time greater than or equal to . First suppose that there are no ties in time. Sorting the data set by the variable time into descending order gives you that is in the right order. Observation ’s risk set consists of all data points such that in the data set. You can cumulatively increment S in the SAS statements.

With potential ties in time, at observation , you need to know whether any subsequent observations, and so on, have the same survival time as . Suppose that the th, the th, and the th observations all have the same survival time; all three of them need to be included in the risk set calculation. This means that to calculate the likelihood for some observations, you need to access both the previous and subsequent observations in the data set. There are two ways to do this. One is to use the LAG function; the other is to use the option JOINTMODEL.

The LAG function returns values from a queue (see SAS Language Reference: Dictionary). So for the th observation, you can use LAG1 to access variables from the previous row in the data set. You want to compare the lag1 value of time with the current time value. Depending on whether the two time values are equal, you can add correction terms in the calculation for the risk set S.

The following statements sort the data set by time into descending order, with the largest survival time on top:

   title 'Cox Model with Time Independent Covariates';
   proc freq data=myeloma;
      ods select none;
      tables time / out=freqs;
   run;
    
   proc sort data = freqs;
      by descending time;
   run;
    
   data myelomaM;
      set myeloma;
      ind = _N_;
   run;

The following statements run PROC MCMC and produce Output 52.8.1:

   proc mcmc data=myelomaM outpost=outi nmc=50000 ntu=3000 seed=1;
      ods select PostSummaries PostIntervals;
      array beta[9];
      parms beta: 0;
      prior beta: ~ normal(0, var=1e6);
    
      bZ = beta1 * LogBUN + beta2 * HGB + beta3 * Platelet
         + beta4 * Age + beta5 * LogWBC + beta6 * Frac +
         beta7 * LogPBM + beta8 * Protein + beta9 * SCalc;
    
      if ind = 1 then do;        /* first observation         */
         S = exp(bZ);
         l = vstatus * bZ;
         v = vstatus;
      end;
      else if (1 < ind < &N) then do;
         if (lag1(time) ne time) then do;
            l = vstatus * bZ;
            l = l - v * log(S);  /* correct the loglike value   */
            v = vstatus;         /* reset v count value         */
            S = S + exp(bZ);
         end;
         else do;                /* still a tie                 */
            l = vstatus * bZ;
            S = S + exp(bZ);
            v = v + vstatus;     /* add # of nonsensored values */
         end;
      end;
      else do;                   /* last observation            */
         if (lag1(time) ne time) then do;
            l = - v * log(S);    /* correct the loglike value   */
            S = S + exp(bZ);
            l = l + vstatus * (bZ - log(S));
         end;
         else do;
            S = S + exp(bZ);
            l = vstatus * bZ - (v + vstatus) * log(S);
         end;
      end;
      model general(l);
   run;

The symbol bZ is the regression term, which is independent of the time variable. The symbol ind indexes observation numbers in the data set. The symbol S keeps track of the risk set term for every observation. The symbol l calculates the log likelihood for each observation. Note that the value of l for observation ind is not necessarily the correct log likelihood value for that observation, especially in cases where the observation ind is in the tied times. Correction terms are added to subsequent values of l when the time variable becomes different in order to make up the difference. The total sum of l calculated over the entire data set is correct. The symbol v keeps track of the sum of vstatus, as censored data do not enter the likelihood and need to be taken out.

You use the function LAG1 to detect if two adjacent time values are different. If they are, you know that the current observation is in a different risk set than the last one. You then need to add a correction term to the log likelihood value of l. The IF-ELSE statements break the observations into three parts: the first observation, the last observation and everything in the middle.

Output 52.8.1 Summary Statistics on Cox Model with Time Independent Explanatory Variables and Ties in the Survival Time, Using PROC MCMC
Cox Model with Time Independent Covariates

The MCMC Procedure

Posterior Summaries
Parameter N Mean Standard
Deviation
Percentiles
25% 50% 75%
beta1 50000 1.7600 0.6441 1.3275 1.7651 2.1947
beta2 50000 -0.1308 0.0720 -0.1799 -0.1304 -0.0817
beta3 50000 -0.2017 0.5148 -0.5505 -0.1965 0.1351
beta4 50000 -0.0126 0.0194 -0.0257 -0.0128 0.000641
beta5 50000 0.3373 0.7256 -0.1318 0.3505 0.8236
beta6 50000 0.3992 0.4337 0.0973 0.3864 0.6804
beta7 50000 0.3749 0.4861 0.0464 0.3636 0.6989
beta8 50000 0.0106 0.0271 -0.00723 0.0118 0.0293
beta9 50000 0.1272 0.1064 0.0579 0.1300 0.1997

Posterior Intervals
Parameter Alpha Equal-Tail Interval HPD Interval
beta1 0.050 0.4649 3.0214 0.5117 3.0465
beta2 0.050 -0.2704 0.0114 -0.2746 0.00524
beta3 0.050 -1.2180 0.8449 -1.2394 0.7984
beta4 0.050 -0.0501 0.0257 -0.0512 0.0245
beta5 0.050 -1.1233 1.7232 -1.1124 1.7291
beta6 0.050 -0.4136 1.2970 -0.4385 1.2575
beta7 0.050 -0.5551 1.3593 -0.5423 1.3689
beta8 0.050 -0.0451 0.0618 -0.0451 0.0616
beta9 0.050 -0.0933 0.3272 -0.0763 0.3406

An alternative to using the LAG function is to use the PROC option JOINTMODEL. With this option, the log-likelihood function you specify applies not to a single observation but to the entire data set. See Modeling Joint Likelihood for details on how to properly use this option. The basic idea is that you store all necessary data set variables in arrays and use only the arrays to construct the log likelihood of the entire data set. This approach works here because for every observation , you can use index to access different values of arrays to construct the risk set S. To use the JOINTMODEL option, you need to do some additional data manipulation. You want to create a stop variable for each observation, which indicates the observation number that should be included in S for that observation. For example, if observations 4, 5, 6 all have the same survival time, the stop value for all of them is 6.

The following statements generate a new data set myelomaM that contains the stop variable:

   data myelomaM;
      merge myelomaM freqs(drop=percent);
      by descending time;
      retain stop;
      if first.time then do;
         stop = _n_ + count - 1;
      end;
   run;

The following SAS program fits the same Cox model by using the JOINTMODEL option:

   data a;
      run;
           
   proc mcmc data=a outpost=outa nmc=50000 ntu=3000 seed=1 jointmodel;
      ods select none;
         array beta[9];        
         array data[1] / nosymbols;
         array timeA[1] / nosymbols;
         array vstatusA[1] / nosymbols;
         array stopA[1] / nosymbols;
         array bZ[&n];          
         array S[&n];
         
         begincnst;
         rc = read_array("myelomam", data, "logbun", "hgb", "platelet",
                         "age", "logwbc", "frac", "logpbm", "protein", "scalc");
         rc = read_array("myelomam", timeA, "time");
         rc = read_array("myelomam", vstatusA, "vstatus");
         rc = read_array("myelomam", stopA, "stop");
         endcnst;
    
         parms (beta:) 0;
         prior beta: ~ normal(0, var=1e6);
    
         jl = 0; 
         /* calculate each bZ and cumulatively adding S as if there are no ties.*/
         call mult(data, beta, bZ);
         S[1] = exp(bZ[1]);
         do i = 2 to &n;
            S[i] = S[i-1] + exp(bZ[i]);
         end;
    
         do i = 1 to &n;
            /* correct the S[i] term, when needed. */
            if(stopA[i] > i) then do;
               do j = (i+1) to stopA[i];
                  S[i] = S[i] + exp(bZ[j]);
               end;
            end;
            jl = jl + vstatusA[i] * (bZ[i] - log(S[i]));
         end;
         model general(jl);
   run;
   ods select all;

No output tables were produced because this PROC MCMC run produces identical posterior samples as does the previous example.

Because the JOINTMODEL option is specified here, you do not need to specify myelomaM as the input data set. An empty data set a is used to speed up the procedure run.

Multiple ARRAY statements allocate array symbols that are used to store the parameters (beta), the response and the covariates (data, timeA, vstatusA, and stopA), and the work space (bZ and S). The data, timeA, vstatusA, and stopA arrays are declared with the /NOSYMBOLS option. This option enables PROC MCMC to dynamically resize these arrays to match the dimensions of the input data set. See the section READ_ARRAY Function. The bZ and S arrays store the regression term and the risk set term for every observation.

The BEGINCNST and ENDCNST statements enclose programming statements that read the data set variables into these arrays. The rest of the programming statements construct the log likelihood for the entire data set.

The CALL MULT function calculates the regression term in the model and stores the result in the array bZ. In the first DO loop, you sum the risk set term S as if there are no ties in time. This underevaluates some of the S elements. For observations that have a tied time, you make the necessary correction to the corresponding S values. The correction takes place in the second DO loop. Any observation that has a tied time also has a stopA[i] that is different from i. You add the right terms to S and sum up the joint log likelihood jl. The MODEL statement specifies that the log likelihood takes on the value of jl.

To see that you get identical results from these two approaches, use PROC COMPARE to compare the posterior samples from two runs:

   proc compare data=outi compare=outa;
      ods select comparesummary;
      var beta1-beta9;
   run;

The output is not shown here.

Generally, the JOINTMODEL option can be slightly faster than using the default setup. The savings come from avoiding the overhead cost of accessing the data set repeatedly at every iteration. However, the speed gain is not guaranteed because it largely depends on the efficiency of your programs.

PROC PHREG fits the same model, and you get very similar results to PROC MCMC. The following statements run PROC PHREG and produce Output 52.8.2:

   proc phreg data=Myeloma;
      ods select PostSummaries PostIntervals;
      ods output posteriorsample = phout;
      model Time*VStatus(0)=LogBUN HGB Platelet Age LogWBC
                            Frac LogPBM Protein Scalc;
      bayes seed=1 nmc=10000;
   run;

Output 52.8.2 Summary Statistics for Cox Model with Time Independent Explanatory Variables and Ties in the Survival Time, Using PROC PHREG
Cox Model with Time Independent Covariates

The PHREG Procedure
 
Bayesian Analysis

Posterior Summaries
Parameter N Mean Standard
Deviation
Percentiles
25% 50% 75%
LogBUN 10000 1.7610 0.6593 1.3173 1.7686 2.2109
HGB 10000 -0.1279 0.0727 -0.1767 -0.1287 -0.0789
Platelet 10000 -0.2179 0.5169 -0.5659 -0.2360 0.1272
Age 10000 -0.0130 0.0199 -0.0264 -0.0131 0.000492
LogWBC 10000 0.3150 0.7451 -0.1718 0.3321 0.8253
Frac 10000 0.3766 0.4152 0.0881 0.3615 0.6471
LogPBM 10000 0.3792 0.4909 0.0405 0.3766 0.7023
Protein 10000 0.0102 0.0267 -0.00745 0.0106 0.0283
SCalc 10000 0.1248 0.1062 0.0545 0.1273 0.1985

Posterior Intervals
Parameter Alpha Equal-Tail Interval HPD Interval
LogBUN 0.050 0.4418 3.0477 0.4107 2.9958
HGB 0.050 -0.2718 0.0150 -0.2801 0.00599
Platelet 0.050 -1.1952 0.8296 -1.1871 0.8341
Age 0.050 -0.0514 0.0259 -0.0519 0.0251
LogWBC 0.050 -1.2058 1.7228 -1.1783 1.7483
Frac 0.050 -0.3995 1.2316 -0.4273 1.2021
LogPBM 0.050 -0.5652 1.3671 -0.5939 1.3241
Protein 0.050 -0.0437 0.0611 -0.0405 0.0637
SCalc 0.050 -0.0935 0.3264 -0.0846 0.3322

Output 52.8.3 shows kernel density plots that compare the posterior marginal distributions of all the beta parameters from the PROC MCMC run and the PROC PHREG run. The following statements generate the comparison:

   proc kde data=outi;
      ods exclude all;
      univar beta1 beta2 beta3 beta4 beta5 beta6 beta7 beta8 beta9
         / out=m1 (drop=count);
   run;
   ods exclude none;
    
   %reshape(m1, mcmc, suffix1=, suffix2=md);
    
   data phout;
      set phout(drop = LogPost Iteration);
      beta1 = LogBUN;  beta2 = HGB;      beta3 = Platelet;
      beta4 = Age;     beta5 = LogWBC;   beta6 = Frac;
      beta7 = LogPBM;  beta8 = Protein;  beta9 = SCalc;
      drop LogBUN HGB Platelet Age LogWBC Frac LogPBM Protein SCalc;
   run;
    
   proc kde data=phout;
      ods exclude all;
      univar beta1 beta2 beta3 beta4 beta5 beta6 beta7 beta8 beta9
         / out=m2 (drop=count);
   run;
   ods exclude none;
    
   %reshape(m2, phreg, suffix1=p, suffix2=pd);
    
   data all;
      merge mcmc phreg;
   run;
    
   proc template;
      define statgraph threebythree;
         %macro plot;
            begingraph;
               layout lattice / rows=3 columns=3;
                  %do i = 1 %to 9;
                     layout overlay /yaxisopts=(label=" ");
                        seriesplot y=beta&i.md x=beta&i
                           / connectorder=xaxis
                             lineattrs=(pattern=mediumdash color=blue)
                           legendlabel = "MCMC" name="MCMC";
                        seriesplot y=beta&i.pd x=beta&i.p
                           / connectorder=xaxis lineattrs=(color=red)
                           legendlabel = "PHREG" name="PHREG";
                     endlayout;
                  %end;
                  Sidebar / align = bottom;
                     discretelegend "MCMC" "PHREG";
                  endsidebar;
               endlayout;
            endgraph;
         %mend; %plot;
      end;
   run;
    
   proc sgrender data=all template=threebythree;
      title "Kernel Density Comparison";
   run;

The macro %RESHAPE is defined in the example Logistic Regression Random-Effects Model. The posterior densities are almost identical to one another.

Output 52.8.3 Comparing Estimates from PROC MCMC and PROC PHREG
Comparing Estimates from PROC MCMC and PROC PHREG

Time Dependent Model

To model as a function of the survival time, you can relate time to covariates by using this formula:

     

For illustrational purposes, only three explanatory variables, LOGBUN, HBG, and PLATELET, are used in this example.

Since depends on , every term in the summation of is a product of the current time and all observations that are in the risk set. You can use the JOINTMODEL option, as in the last example, or you can modify the input data set such that every row contains not only the current observation but also all observations that are in the corresponding risk set. When you construct the log likelihood for each observation, you have all the relevant data at your disposal.

The following statements illustrate how you can create a new data set with different risk sets at different rows:

   title 'Cox Model with Time Dependent Covariates';
   ods select none;
   proc freq data=myeloma;
      tables time / out=freqs;
   run;
   ods select all;
    
   proc sort data = freqs;
      by descending time;
   run;
    
   data myelomaM;
      set myeloma;
      ind = _N_;
   run;
    
   data myelomaM;
      merge myelomaM freqs(drop=percent); by descending time;
      retain stop;
      if first.time then do;
         stop = _n_ + count - 1;
      end;
   run;
    
   %macro array(list);
      %global mcmcarray;
      %let mcmcarray = ;
      %do i = 1 %to 32000;
         %let v = %scan(&list, &i, %str( ));
         %if %nrbquote(&v) ne %then %do;
            array _&v[&n];
            %let mcmcarray = &mcmcarray array _&v[&n] _&v.1 - _&v.&n%str(;);
               do i = 1 to stop;
                  set myelomaM(keep=&v) point=i;
                  _&v[i] = &v;
               end;
         %end;
         %else %let i = 32001;
      %end;
   %mend;
    
   data z;
      set myelomaM;
      %array(logbun hgb platelet);
      drop vstatus logbun hgb platelet count stop;
   run;
    
   data myelomaM;
      merge myelomaM z; by descending time;
   run;

The data set myelomaM contains 65 observations and 209 variables. For each observation, you see added variables stop, _logbun1 through _logbun65, _hgb1 through _hgb65, and _platelet1 through _platelet65. The variable stop indicates the number of observations that are in the risk set of the current observation. The rest are transposed values of model covariates of the entire data set. The data set contains a number of missing values. This is due to the fact that only the relevant observations are kept, such as _logbun1 to _logbunstop. The rest of the cells are filled in with missing values. For example, the first observation has a unique survival time of 92 and stop is 1, making it a risk set of itself. You see nonmissing values only in _logbun1, _hgb1, and _platelet1.

The following statements fit the Cox model by using PROC MCMC:

   proc mcmc data=myelomaM outpost=outi nmc=50000 ntu=3000 seed=17
             missing=ac;
      ods select PostSummaries PostIntervals;
      array beta[6];
      &mcmcarray
      parms (beta:) 0;
      prior beta: ~ normal(0, prec=1e-6);
    
      b = (beta1 + beta2 * time) * logbun +
          (beta3 + beta4 * time) * hgb +
          (beta5 + beta6 * time) * platelet;
      S = 0;
      do i = 1 to stop;
         S = S + exp( (beta1 + beta2 * time) * _logbun[i] +
                      (beta3 + beta4 * time) * _hgb[i] +
                      (beta5 + beta6 * time) * _platelet[i]);
      end;
      loglike = vstatus * (b - log(S));
    
      model general(loglike);
   run;

Note that the option MISSING= is set to AC. This is due to missing cells in the input data set. You must use this option so that PROC MCMC retains observations that contain missing values.

The macro variable &mcmcarray is defined in the earlier part in this example. You can use a %put statement to print its value:

   %put &mcmcarray;

This statement prints the following:

   array _logbun[65] _logbun1 - _logbun65; array _hgb[65] _hgb1 - _hgb65; array
   _platelet[65] _platelet1 - _platelet65;

The macro uses the ARRAY statement to allocate three arrays, each of which links their corresponding data set variables. This makes it easier to reference these data set variables in the program. The PARMS statement puts all the parameters in the same block. The PRIOR statement gives them normal priors with large variance. The symbol b is the regression term, and S is cumulatively added from 1 to stop for each observation in the DO loop. The symbol loglike completes the construction of log likelihood for each observation and the MODEL statement completes the model specification.

Posterior summary and interval statistics are shown in Output 52.8.4.

Output 52.8.4 Summary Statistics on Cox Model with Time Dependent Explanatory Variables and Ties in the Survival Time, Using PROC MCMC
Cox Model with Time Dependent Covariates

The MCMC Procedure

Posterior Summaries
Parameter N Mean Standard
Deviation
Percentiles
25% 50% 75%
beta1 50000 3.2397 0.8226 2.6835 3.2413 3.7830
beta2 50000 -0.1411 0.0471 -0.1722 -0.1406 -0.1092
beta3 50000 -0.0369 0.1017 -0.1064 -0.0373 0.0315
beta4 50000 -0.00409 0.00360 -0.00656 -0.00408 -0.00167
beta5 50000 0.3548 0.7359 -0.1634 0.3530 0.8445
beta6 50000 -0.0417 0.0359 -0.0661 -0.0423 -0.0181

Posterior Intervals
Parameter Alpha Equal-Tail Interval HPD Interval
beta1 0.050 1.6399 4.8667 1.6664 4.8752
beta2 0.050 -0.2351 -0.0509 -0.2294 -0.0458
beta3 0.050 -0.2337 0.1642 -0.2272 0.1685
beta4 0.050 -0.0111 0.00282 -0.0112 0.00264
beta5 0.050 -1.0317 1.8202 -1.0394 1.8100
beta6 0.050 -0.1107 0.0295 -0.1122 0.0269

You can also use the option JOINTMODEL to get the same inference and avoid transposing the data for every observation:

   proc mcmc data=myelomaM outpost=outa nmc=50000 ntu=3000 seed=17 jointmodel;
      ods select none;
      array beta[6];      array timeA[&n];      array vstatusA[&n];
      array logbunA[&n];  array hgbA[&n];       array plateletA[&n];
      array stopA[&n];    array bZ[&n];         array S[&n];
    
      begincnst;
         timeA[ind]=time;          vstatusA[ind]=vstatus;
         logbunA[ind]=logbun;      hgbA[ind]=hgb;
         plateletA[ind]=platelet;  stopA[ind]=stop;
      endcnst;
    
      parms (beta:) 0;
      prior beta: ~ normal(0, prec=1e-6);
    
      jl = 0;
      do i = 1 to &n;
         v1 = beta1 + beta2 * timeA[i];
         v2 = beta3 + beta4 * timeA[i];
         v3 = beta5 + beta6 * timeA[i];
         bZ[i] = v1 * logbunA[i] + v2 * hgbA[i] + v3 * plateletA[i];
    
         /* sum over risk set without considering ties in time. */
         S[i] = exp(bZ[i]);
         if (i > 1) then do;
            do j = 1 to (i-1);
               b1 = v1 * logbunA[j] + v2 * hgbA[j] + v3 * plateletA[j];
               S[i] = S[i] + exp(b1);
            end;
         end;
      end;
    
      /* make correction to the risk set due to ties in time. */
      do i = 1 to &n;
         if(stopA[i] > i) then do;
            v1 = beta1 + beta2 * timeA[i];
            v2 = beta3 + beta4 * timeA[i];
            v3 = beta5 + beta6 * timeA[i];
            do j = (i+1) to stopA[i];
               b1 = v1 * logbunA[j] + v2 * hgbA[j] + v3 * plateletA[j];
               S[i] = S[i] + exp(b1);
            end;
         end;
         jl = jl + vstatusA[i] * (bZ[i] - log(S[i]));
      end;
      model general(jl);
   run;

The multiple ARRAY statements allocate array symbols that are used to store the parameters (beta), the response (timeA), the covariates (vstatusA, logbunA, hgbA, plateletA, and stopA), and work space (bZ and S). The bZ and S arrays store the regression term and the risk set term for every observation. Programming statements in the BEGINCNST and ENDCNST statements input the response and covariates from the data set to the arrays.

Using the same technique shown in the example Time Independent Model, the next DO loop calculates the regression term and corresponding S for every observation, pretending that there are no ties in time. This means that the risk set for observation involves only observation to . The correction terms are added to the corresponding S[i] in the second DO loop, conditional on whether the stop variable is greater than the observation count itself. The symbol jl cumulatively adds the log likelihood for the entire data set, and the MODEL statement specifies the joint log-likelihood function.

The following statements run PROC COMPARE and show that the output data set outa contains identical posterior samples as outi:

   proc compare data=outi compare=outa;
      ods select comparesummary;
      var beta1-beta6;
   run;

The results are not shown here.

The following statements use PROC PHREG to fit the same time dependent Cox model:

   proc phreg data=Myeloma;
      ods select PostSummaries PostIntervals;
      ods output posteriorsample = phout;
      model Time*VStatus(0)=LogBUN z2 hgb z3 platelet z4;
      z2 = Time*logbun;
      z3 = Time*hgb;
      z4 = Time*platelet;
      bayes seed=1 nmc=10000;
   run;

Coding is simpler than PROC MCMC. See Output 52.8.5 for posterior summary and interval statistics:

Output 52.8.5 Summary Statistics on Cox Model with Time Dependent Explanatory Variables and Ties in the Survival Time, Using PROC PHREG
Cox Model with Time Dependent Covariates

The PHREG Procedure
 
Bayesian Analysis

Posterior Summaries
Parameter N Mean Standard
Deviation
Percentiles
25% 50% 75%
LogBUN 10000 3.2423 0.8311 2.6838 3.2445 3.7929
z2 10000 -0.1401 0.0482 -0.1723 -0.1391 -0.1069
HGB 10000 -0.0382 0.1009 -0.1067 -0.0385 0.0297
z3 10000 -0.00407 0.00363 -0.00652 -0.00404 -0.00162
Platelet 10000 0.3778 0.7524 -0.1500 0.3389 0.8701
z4 10000 -0.0419 0.0364 -0.0660 -0.0425 -0.0178

Posterior Intervals
Parameter Alpha Equal-Tail Interval HPD Interval
LogBUN 0.050 1.6059 4.8785 1.5925 4.8582
z2 0.050 -0.2361 -0.0494 -0.2354 -0.0492
HGB 0.050 -0.2343 0.1598 -0.2331 0.1603
z3 0.050 -0.0113 0.00297 -0.0109 0.00322
Platelet 0.050 -0.9966 1.9464 -1.1342 1.7968
z4 0.050 -0.1124 0.0296 -0.1142 0.0274

Output 52.8.6 shows a kernel density comparison plot that compares posterior marginal distributions of all the beta parameters from the PROC MCMC run and the PROC PHREG run. The following statements generate Output 52.8.6:

   proc kde data=outi;
      ods exclude all;
      univar beta1 beta2 beta3 beta4 beta5 beta6 / out=m1 (drop=count);
   run; 
   ods exclude none;
   
   %reshape(m1, mcmc, suffix1=, suffix2=md);
    
   data phout;
      set phout(drop = LogPost Iteration);
      beta1 = LogBUN;  beta2 = z2;       beta3 = HGB;
      beta4 = z3;      beta5 = Platelet; beta6 = z4;
      drop LogBUN HGB Platelet z2-z4;
   run;
    
   proc kde data=phout;
      ods exclude all;
      univar beta1 beta2 beta3 beta4 beta5 beta6 / out=m2 (drop=count);
   run;
   ods exclude none;
    
   %reshape(m2, phreg, suffix1=p, suffix2=pd);
    
   data all;
      merge mcmc phreg;
   run;
    
   proc template;
      define statgraph twobythree;
         %macro plot;
            begingraph;
               layout lattice / rows=2 columns=3;
                   %do i = 1 %to 6;
                     layout overlay /yaxisopts=(label=" ");
                        seriesplot y=beta&i.md x=beta&i
                           / connectorder=xaxis
                             lineattrs=(pattern=mediumdash color=blue)
                           legendlabel = "MCMC" name="MCMC";
                        seriesplot y=beta&i.pd x=beta&i.p
                           / connectorder=xaxis lineattrs=(color=red)
                           legendlabel = "PHREG" name="PHREG";
                     endlayout;
                   %end;
                   Sidebar / align = bottom;
                      discretelegend "MCMC" "PHREG";
                   endsidebar;
               endlayout;
            endgraph;
         %mend; %plot;
      end;
   run;
    
   proc sgrender data=all template=twobythree;
      title "Kernel Density Comparison";
   run;

The macro %RESHAPE is defined in the example Logistic Regression Random-Effects Model.

Output 52.8.6 Comparing Estimates from PROC MCMC and PROC PHREG
Comparing Estimates from PROC MCMC and PROC PHREG

Previous Page | Next Page | Top of Page