Skip to main content

Efficient estimation of grouped survival models

Abstract

Background

Time- and dose-to-event phenotypes used in basic science and translational studies are commonly measured imprecisely or incompletely due to limitations of the experimental design or data collection schema. For example, drug-induced toxicities are not reported by the actual time or dose triggering the event, but rather are inferred from the cycle or dose to which the event is attributed. This exemplifies a prevalent type of imprecise measurement called grouped failure time, where times or doses are restricted to discrete increments. Failure to appropriately account for the grouped nature of the data, when present, may lead to biased analyses.

Results

We present groupedSurv, an R package which implements a statistically rigorous and computationally efficient approach for conducting genome-wide analyses based on grouped failure time phenotypes. Our approach accommodates adjustments for baseline covariates, and analysis at the variant or gene level. We illustrate the statistical properties of the approach and computational performance of the package by simulation. We present the results of a reanalysis of a published genome-wide study to identify common germline variants associated with the risk of taxane-induced peripheral neuropathy in breast cancer patients.

Conclusions

groupedSurv enables fast and rigorous genome-wide analysis on the basis of grouped failure time phenotypes at the variant, gene or pathway level. The package is freely available under a public license through the Comprehensive R Archive Network.

Background

In basic science and translational studies, time-to-event outcomes are commonly measured imprecisely or incompletely due to limitations in the design or the data collection schema. For example, in mouse studies, due to practical and cost considerations, tumor progression events are not monitored in real time. Each event is recorded as occurring between two contiguous assessments. In clinical studies, drug-induced adverse events are commonly not reported by the date of occurrence but rather by drug cycle. These are examples of grouped failure time data, also referred to as grouped survival data, grouped censored data, or simply grouped data.

It should be noted that grouped failure time phenotypes are not restricted to studies with time-to-event outcomes. Cell-line cytotoxicty studies (e.g., growth-inhibitory effects of tamoxifen on human breast cancer cell lines [1]) are commonly designed on the basis of a pre-specified set of doses. Events, such as the half-maximal inhibitory concentration (IC50), are not directly observable due to the discrete nature of the dose design. The event of interest is observed to occur between two consecutive doses. In the subsequent report, we do not distinguish between time-to-event data and dose-to-event data, and refer to them as failure time data or survival time data.

One approach for dealing with grouped data is to use methods designed to adjust for tied continuous survival times in the presence of right censoring. Commonly used methods are those proposed by Breslow and Peto [2] or Efron [3]. As we will demonstrate in this paper, these methods may be biased when applied to grouped survival data. Another approach is to use an exact likelihood [4]. However, to do so is computationally intensive and thus not feasible for genome-wide inference.

In this paper, we present groupedSurv, an open source R [5] package implementing a statistically rigorous and computationally efficient approach proposed in Prentice and Gloeckler [6] for genome-wide analysis with group censored phenotypes. The package conducts analyses at a variant, gene or pathway level. Through applying groupedSurv to simulated survival data, we establish that our approach controls type I error and yields unbiased effect size estimates. We also show, by simulation, that when methods designed for tied survival outcomes are applied to grouped survival data, the results may be biased. On the basis of results from computational cost benchmarking studies on both real and simulated survival data, we demonstrate that our package completes analyses of large genome-wide association studies (GWAS), e.g., 1,000,000 variants and n=1000 samples, within three minutes on a four-core computer. To illustrate the application of our package, we conduct an analysis of a previously published GWAS to identify common variants associated with taxane-induced peripheral neuropathy in breast cancer patients [7].

Implementation

Statistical considerations

Statistical model

Under the standard Cox proportional hazards model [8], the conditional hazard function at time t>0, given variables xi and zi, is canonically presented as

$$ \lambda(t|\mathbf{x}_{i},\mathbf{z}_{i})=\lambda_{0}(t)\exp\left(\mathbf{x}_{i}^{T} \mathbf{\beta} + \mathbf{z}_{i}^{T} \theta\right), $$
(1)

where λ0(t) is an unspecified baseline hazard function, xi is a vector of variables of interest, and zi is a vector of baseline covariates. Here, β is the parameter vector of interest while θ is a nuisance parameter vector. Under the grouped failure time model, the event of interest will fall into one of r pre-specified time intervals, or be right-censored at the beginning of one of these intervals, denoted [tj−1,tj), for j{1,2,…,r}, where t0=0 and tr=. The groupedSurv package employs the regression model for grouped survival data proposed by Prentice and Gloeckler [6], which discretizes the conditional hazard function (1) according to these intervals. Additional technical details for the model are provided in the “Statistical model” section of Additional file 1.

Efficient score statistic

For a single variable of interest, xi, groupedSurv tests the hypothesis H0:β=0 against H1:β≠0, under the grouped failure time model. The test is conducted using an efficient score statistic [9] on the basis of the observed data, {y1=(k1,δ1,x1,z1),…,yn=(kn,δn,xn,zn)}. Here, for sample i{1,…,n}, ki{1,2,…,r} denotes the interval of the observed grouped outcome and δi{0,1} denotes the event indicator. In this notation, ki=j,δi=1 indicates that the event occured in interval [tj−1,tj) while ki=j,δi=0 indicates that the sample was right-censored at time tj−1. Using this notation, the corresponding likelihood function is

$$ L_{i}(\mathbf{y}_{i},\beta,\eta) = \left(1 - \alpha_{k_i}^{\exp(x_{i} \beta + \mathbf{z}_{i}^{T} \theta)} \right)^{\delta_i} \prod_{j=1}^{k_{i}-1} \alpha_{j}^{\exp\left(x_{i} \beta + \mathbf{z}_{i}^{T} \theta\right)}, $$
(2)

where \(\alpha _{j} = \exp \left (-\int _{t_{j-1}}^{t_{j}} \lambda (u)\,du\right)\) and η=(α,θ).

Our inferential approach differs from that described in Prentice and Gloeckler in that we use a partitioned score statistic. More specifically, rather than testing the null hypothesis that all of the effect parameters are zero (H0:β=0 & θ=0), we are testing only the effect of xi (H0:β=0), while treating the parameters of the baseline covariates, θ (as well as the αj) as nuisance parameters. Using the efficient score function for β in the above model, we define our efficient score statistic as

$$ \mathcal W = \frac{\left(\sum\limits_{i=1}^{n} S_{{\beta}}({0,\hat{{\eta}}})\right)^{2}} {n\left(\bar{\mathcal I}_{{\beta\beta}}({0,\hat{{\eta}}})- \bar{\mathcal I}_{{\beta\eta}}({0,\hat{{\eta}}})\bar{\mathcal I}_{{\eta\eta}}({0,\hat{{\eta}}})^{-1} \bar{\mathcal I}_{{\beta\eta}}({0,\hat{{\eta}}})^{T}\right)}, $$
(3)

where \(\hat {\eta }\) is the maximum likelihood estimate (MLE) of the nuisance parameter under the null hypothesis, \( S_{{\beta }}({0,\hat {{\eta }}})\) is the score function with respect to β, \(\bar {\mathcal I}_{{\beta \eta }}({0,\hat {{\eta }}})\) is the second derivative of the score statistic with respect to β and η (similarly for \(\bar {\mathcal I}_{{\beta \beta }}({0,\hat {{\eta }}})\) and \(\bar {\mathcal I}_{{\eta \eta }}({0,\hat {{\eta }}})\)), and n is the sample size. The asymptotic null distribution for the statistic is chi-square, with degrees of freedom equal to the dimension of β. The derivation of this equation and other technical details, including our approach for approximating the standard error of the score statistic, are provided in Additional file 1.

Gene- and pathway-level statistics

Within the context of GWAS, what is often of interest is to conduct the analysis at the level of a gene or pathway rather than an individual variant. To allow for flexibility in conducting these types of set-based analyses, groupedSurv(), the primary function in the groupedSurv package, optionally returns the contribution of each sample to the score statistic for each variant tested. This enables users to employ the set-based statistic of their choice. An additional function, geneStat(), accepts a user-specified function as an argument and computes the gene- or pathway-level statistics directly. If no function is specified, geneStat() implements a sequence kernel association test (SKAT) [10, 11] statistic by default. Technical details are provided in the “Gene- and pathway-level statistics” section of Additional file 1.

Multiple testing

In addition to the unadjusted marginal asymptotic P-values for the variables tested, groupedSurv returns family-wise error rate (FWER) adjusted P-values and local false-discovery rates (FDR). The FWER-adjusted P-values are calculated based on the Bonferroni correction [12], while the local FDRs are based on Storey’s Q-values [13, 14].

Software package

Design

The computational algorithms of groupedSurv are coded in C++ [15], and the Rcpp [16] package is used to interface with the R environment. The Rcpp package provides a series of R wrapper classes to import and load C++ code, and allows passing of R objects between R and C++. The pthreads model is used for implementing multi-threading. In addition to the help files for its functions, a vignette is provided as a user tutorial.

Input data format

The package is designed to accept multiple input data formats, including standard R data frames and matrix objects, and gwaa.data objects from the GenABEL package [17]. Data can also be imported from binary PLINK [18] files using the BEDMatrix package [19]. Genotype dosage data, obtained from imputation software (e.g., MACH [20, 21] or IMPUTE [22]) in the form of VCF [23] files, can be imported using the VariantAnnotation package [24]. The package vignette provides examples for importing each of the data formats. Note that, in the case of missing genotypes or genotype dosage data the package implements a complete-case analysis of each variant.

Usage

The primary function of the package, groupedSurv(), is capable of executing multiple analyses in parallel. It returns a data frame containing the efficient score statistics, along with the (unadjusted) asymptotic P-values, FWER-adjusted P-values, and the FDR for each of the variables of interest.

The thetaEst() function provides MLEs for the nuisance parameters, i.e., the baseline survival rates for each interval, \(\hat {{\alpha }}_{j}\), and the parameters for any covariates, \(\hat {{\theta }}\). The estimates are computed under the null hypothesis, i.e., that the variable of interest has no effect on the time to event. This allows these estimates to be reused to calculate the efficient score statistic for any number of variables being tested.

Evaluation

Survival data simulation

We evaluate the accuracy and computational costs of the implemented methods using simulations. Grouped survival data are simulated by first generating continuous survival times, and then translating these into grouped survival times. First, the variables of interest, X, and two covariates, Z=(Z1,Z2), are simulated. Conditional on the realized values X=x and Z=(z1,z2), the continuous survival time, T, is drawn from an exponential distribution with hazard rate exp(βx+θ1z1+θ2z2). The censoring time, C, is drawn from a uniform distribution over (0,cmax).

To transform continuous times into grouped times, we first specify a final observation time point τ. The interval [0,) is then divided into r contiguous intervals, composed of r−1 finite intervals of equal size spanning [0,τ), and a final rth interval, [τ,). The resulting right-end points of the finite intervals represent the study observation time points. We define T and C as the right-end points of the intervals containing T and C, respectively. Grouped survival time is then defined as \(\tilde {T}=\min (T^{\ast },C^{\ast })\), and the event indicator is given by \(\mathbbm {1}\{T^{\ast }<C^{\ast }~\&~\tilde {T} \le \tau \}\). Technical details for the simulation approach are provided in the “Simulation” section of Additional file 1.

Statistical operating characteristics

We assess the statistical operating characteristics of our approach on the basis of empirical type I error control, statistical power, and bias of the effect size estimates. We also compare these characteristics to those of the Cox proportional hazards model [8], using either the Efron or exact likelihood methods to adjust for tied survival times in the presence of right censoring. We use the implementations of these approaches provided by the survival [25] R extension package.

Benchmarking

We conduct additional simulation studies to assess the computational performance of groupedSurv. To this end, we consider a range of sample sizes and variable counts. We also assess the performance gains from increasing the number of CPU cores used for parallel processing. Ten thousand replicate simulations are conducted for each scenario. The benchmarking analyses are performed on a AMD OpteronTM 6180 SE Server CPU running the Debian Stretch (9.3) AMD64 GNU/Linux. A detailed description of the parameters of each simulation are provided in the “Simulation” section of Additional file 1.

Reproducible pipeline

The knitr [26] R extension package is used to reproducibly conduct the data simulation, summarize the operating characteristics, and estimate the processing benchmarks. The scripts to reproduce the simulation and operating characteristics are provided as Additional file 2.

Data analysis

CALGB 40101 clinical and GWAS data

CALGB 40101 is a randomized phase III study comparing the efficacy of two standard adjuvant therapy regimens in women with breast cancer. It employs a two-by-two factorial design, randomizing patients to paclitaxel versus doxorubicin and cyclophosphamide, and four versus six cycles of therapy. Blood samples from patients who consent to participate in a pharmacogenomic companion study (CALGB 60202) and provide usable DNA are genotyped on the Illumina 610 quad platform. A genome-wide analysis to identify single nucleotide polymorphisms (SNPs) associated with paclitaxel-induced peripheral neuropathy is reported by Baldwin et al. [7]. The authors employ a cumulative dose to first grade 2 or higher paclitaxel-induced peripheral neuropathy event as the phenotype and conduct the analysis using the Cox score statistic for right-censored outcomes. The Efron approximation is used to deal with any ties in the cumulative dose outcome.

The clinical and genomic data are available for download from the database of Genotypes and Phenotypes (dbGaP) through accession phs000807.v1.p1. Additional details about the clinical study are provided in Shulman et al. [27]. Additional details about the GWAS data and neuropathy phenotyping are provided in Baldwin et al. [7].

Analysis of the CALGB 40101 data using groupedSurv

The study population for our analysis consists of 859 genetically estimated European patients identified in the CALGB 40101 GWAS publication. Four patients with no outcome data are uninformatively censored at time 0, effectively excluding them from the analyses. An addition 11 patients were missing baseline covariates or paclitaxel dosing information, and were also excluded.

After limiting the population to genetically estimated European patients with complete data, SNPs with call rates < 95%, Hardy-Weinberg P-values < 10−8, or relative minor allele frequency (MAF) < 0.05 are removed. Analyses are limited to autosomal SNPs only. The filtering is conducted using the GenABEL [17] package. The final genome-wide analysis is conducted across 500,897 SNPs.

Study model

SNPs are tested, under the additive genetic model, for association with cumulative dose to paclitaxel-induced peripheral neuropathy. Cumulative dose is measured as the number of cycles of paclitaxel received (1,2,3,4,5 or 6) prior to neuropathy event or treatment termination. For the analyses, body surface area (BSA) at clinical baseline and age at registration (log base 10 transformed) are used as covariates. GWAS is conducted both with groupedSurv and the coxph() function from the survival [25] package (using the Efron method for ties), and the top hits, ranked by unadjusted P-values from groupedSurv, are compared. The scripts to reproduce the analyses are provided as Additional file 3.

Manhattan and quantile-quantile (QQ) plots are used to visualize the empirical distribution of the resulting unadjusted asymptotic P-values. To illustrate the effect size, we use the non-parametric MLEs of the survival function [28] for interval-censored outcomes provided by the icfit() function from the interval [29] package. For regional visualizations, LocusZoom [30] plots are generated for the selected SNPs or genes.

Results

Statistical operating characteristics

We establish the statistical operating characteristics for our approach by empirical assessment of the type I error and the bias of the effect size for the simulated variant and the nuisance parameters. The type I error simulation results are shown in Fig. 1 for MAFs of 0.05,0.2 and 0.5, and event rates of 0.3, 0.5 and 0.7. Each example is based on a sample size of n=1000 and B=10,000 simulation replicates. These results provide confirmation that our approach provides type I error control.

Fig. 1
figure 1

Box Plot for Type 1 Error Box plot of type 1 error of groupedSurv for different event rates and minor allele frequencies

The simulation results for the empirical bias assessments are shown in Fig. 2 for MAFs of 0.05,0.2 and 0.5. An event rate of 0.6 and a sample size of n=1000 is used for each example, under both the null (effect size β=0) and alternative (effect size β=1) hypotheses. Along with the results from our approach, we provide the corresponding results using the Efron and exact methods of adjusting for ties in a standard right-censored analysis. Each example consists of B=10,000 replicates. Our approach produces evidently unbiased estimates, regardless of MAF. The other two approaches seemingly underestimate the effect size for MAFs of 0.05 and 0.2, while producing unbiased estimates only in the most statistically powerful case when the MAF is 0.5 [31].

Fig. 2
figure 2

Effect Size Estimation Bias for groupedSurv and Coxph Box plot comparing bias of effect size estimation of groupedSurv and Coxph

Having established control of type I error, the simulation results for the power estimations for the grouped failure time method are shown in Fig. 3 for MAFs of 0.05, 0.1, 0.2 and 0.5. An event rate of 0.6 and a sample size of n=1000 is used for each example, with the effect size varying over the range of β(−0.9,0.9). Power is estimated at the two-sided α=0.05 level using B=10,000 replicates.

Fig. 3
figure 3

Power for groupedSurv Power estimates for groupedSurv for different minor allele frequencies

These assessments of the statistical operating characteristics, bias, type I error, and power are also repeated for a smaller sample size (n=500). The results are included in Additional file 1.

Computational performance

To assess the computational performance of groupedSurv in terms of parallel efficiency, we consider a sample size of n=1,000, with 100,000 simulated SNPs to be tested individually as the variables of interest. The timing results based on 1, 4, 8, 12 and 16 CPU cores are shown in panel (a) of Fig. 4. The squares represent the observed CPU time using multiple cores while the circles represent the ideal performance, calculated as CPU time using one core divided by the number of CPU cores in each scenario.

Fig. 4
figure 4

Timing benchmark plots for groupedSurv for a different numbers of CPU cores, and b different sample sizes and numbers of SNPs

To evaluate the performance of groupedSurv in terms of sample size and number of variables tested, we consider sample sizes of n=100, 500 and 1000, and SNP counts of 200,000, 500,000 and 1,000,000. The models also include two baseline covariates. The computational costs for the different sample sizes and numbers of SNPs are shown in panel (b) of Fig. 4, based on four CPU cores.

CALGB 40101 GWAS results

The analysis is based on outcome data from 844 CALGB 40101 patients with 500,897 SNPs passing quality controls. An annotated list of the top 300 SNPs, ranked by unadjusted P-value, is provided as Additional file 4. The QQ and Manhattan plots for all SNPs are shown in Fig. 5. The QQ plot does not exhibit evidence of inflation.

Fig. 5
figure 5

QQ and Manhattan Plot for GWAS(a) Quantile-quantile plot of expected − log10(P-values) and observed − log10(P-values) for all SNOs analyzed, (b)Manhattan plot of − log10(P-values) for all SNPs analyzed

None of the 500,897 variants meet the genome-wide threshold of significance of 1 × 10−8. We prioritize the variants according to their corresponding unadjusted P-values for further examination with respect to potential biological relevance. The top 50 hits are shown in Table 1. Figure 6 shows the non-parametric MLEs of neuropathy-free survival by genotype for the top three hits. Survival and regional visualization plots are provided for six additional SNPs in Additional file 1.

Fig. 6
figure 6

Non-parametric Maximum Likelihood Survival Survival plots for the top three SNPs

Table 1 Top hits from CALGB 40101

Discussion

On the basis of results from the application of the groupedSurv package to simulated survival data, we demonstrate the theoretical properties of our approach. More specifically, we confirm that the testing rule provides proper type I error control, and that the model estimates are asympotically unbiased.

The groupedSurv package enables fast genome-wide inference based on grouped censored phenotypes. As Fig. 4 illustrates, on a single core, the analysis of 1,000,000 variants and n=1000 patients requires less than 8.5 minutes. The completion times are reduced to about 2.1, 1.0, 0.7 or 0.5 minutes when increasing the core count to 4, 8, 12 or 16, respectively.

As we have outlined, an alternative approach to using a likelihood model for grouped data is to repurpose methods for adjustments for ties in continuous right censored data. As we and others [31] have shown, these methods may be biased if applied to grouped censored data. The effect of sample size on this bias is illustrated in Figure S1 in Additional file 1.

Although the analysis using this approach did not identify any variants that reached the genome-wide threshold for significance, the annotated results (Table 1) revealed additional candidate genes undiscovered in the initial GWAS. Among the genes listed in Table 1, many show functions in biological pathways critical to neurite regeneration after chemotherapy damage and show modest to high expression in human dorsal root ganglion, the target peripheral nerve damaged by chemotherapy agents [32]. In particular, the genomic region containing rs9435869 is an intriguing hit since both neighboring genes have potential relevance to chemotherapy-induced peripheral neuropathy (CIPN). RHOU is a Rho GTPase that is known to regulate cytoskeletal organization and induce filopodium formation, a critical step in neuronal development [3335]. Furthermore, RAB4A, encoding a member of the RAB GTPase family, is a regulator of vesicular recycling of cell surface receptors through interaction with its effector NDRG1 [36]. Mutations in NDRG1 (N-myc downstream-regulated gene 1) have been shown to be causative in the rare congenital subtype of Charcot-Marie Tooth Disease Type 4D, an inherited peripheral sensorimotor nerve disorder [3739].

Another SNP included in the top 50 hits, rs6481837, annotated to NRP1 (neuropilin 1) which functions to control growth cone projection in developing neurons [40], supports the hypothesis that axon guidance is important in the development of CIPN. This gene pathway was previously implicated with the role of EPHA5 from the initial GWAS [27]. Genes involved in synaptic formation associated to neurodevelopmental disorders of the central nervous system, such as NRXN1 (neurexin 1) and CADM1 (cell adhesion molecule 1), may also have biological relevance in the context of the peripheral nervous system during the manifestation of this drug-induced neurotoxicity [41, 42]. Although these genes/variants are promising for understanding the molecular mechanisms of CIPN, further in vitro investigations are needed.

Here we note several limitations in our approach. First, while the simulation results confirm that the MLEs are asymptotically unbiased, the effect size estimates are model-based and thus may be biased if the model is misspecified. Second, because the phenotype for the CALGB 40101 GWAS analysis is constructed via a manual review of clinical research forms [7], the cycle attribution may be erroneous due to incomplete or missing information. Our approach properly accounts for the group censoring mechanism, however, it may not be able to account for such phenotyping errors. Lastly, in the analysis of the CALGB 40101 data, we assume that the censoring mechanism is uninformative. Although the censoring induced by assignment to four versus six cycles can safely be assumed to be uninformative as it was decided by study randomization, other forms of censoring may be informative, such as early dropouts due to drug sensitivity. If informative censoring is present, the model parameters need to be interpreted within the context of cause-specific hazards.

We conclude this section by considering potential future extensions. In its current form, our approach does not allow for time-dependent covariates. For example, BSA at baseline is a covariate in our analysis of the CALGB 40101 GWAS. BSA, however, varies at each cycle. Prentice and Gloeckner [6] note that it is possible to extend the regression model to incorporate time-dependent covariates. Another extension, that is currently partially implemented, is the ability to analyze data from familial genetic studies, in which the outcomes may be correlated. The package incorporates a kinship frailty model [43], however, the current implementation is sensitive to departures from model assumptions. Therefore, at present we consider it as an experimental feature. A future extension of this implementation is to make it more robust.

Conclusions

Grouped censored phenotypes are prevalent in basic, translational and clinical science research due to the design of, or limitations in, the data collection schema. Failure to properly account for a grouped failure time mechanism may lead to biased analysis results. We present groupedSurv, an open source R package for conducting genome-wide analyses based on grouped survival phenotypes in a statistically principled and rigorous, and computationally efficient manner. In the context of GWAS, the package enables analysis at the variant as well as gene or pathway level. The package is extensively documented and freely available under a public license to the research community.

Availability and requirements

Project name: groupedSurv

Project home page: https://CRAN.R-project.org/package=groupedSurv

Operating system(s): Linux, Windows and OS X

Programming language: R

Other requirements:C++ 11 or higher, and supporting R packages required for installation

License: GPL (≥2)

Any restrictions to use by non-academics: None

Abbreviations

BSA:

Body surface area

CIPN:

Chemotherapy-induced peripheral neuropathy

FDR:

False discovery rate

FWER:

Family-wise error rate

GWAS:

Genome-wide association study

IC50:

Half-maximal inhibitory concentration

MAF:

Minor allele frequency

MLE:

Maximum likelihood estimate

QQ plot:

Quantile-quantile plot

SKAT:

Sequence kernel association test

SNP:

Single nucleotide polymorphism

References

  1. Reddel RR, Murphy LC, Hall RE, Sutherland RL. Differential sensitivity of human breast cancer cell lines to the growth-inhibitory effects of Tamoxifen. Cancer Res. 1985; 45(4):1525–31.

    CAS  PubMed  Google Scholar 

  2. Breslow N. Covariance analysis of censored survival data. Biometrics. 1974; 30(1):89–99.

    Article  CAS  Google Scholar 

  3. Efron B. The efficiency of Cox’s likelihood function for censored data. J Am Stat Assoc. 1977; 72(359):557–65.

    Article  Google Scholar 

  4. Kalbfleisch JD, Prentice RL. The Statistical Analysis of Failure Time Data. New York: John Wiley & Sons, Inc.; 1982.

    Google Scholar 

  5. R Core Team. R: a Language and Environment for Statistical Computing. Vienna: R Foundation for Statistical Computing; 2018. https://www.R-project.org/. R Foundation for Statistical Computing.

    Google Scholar 

  6. Prentice RL, Gloeckler LA. Regression analysis of grouped survival data with application to breast cancer data. Biometrics. 1978; 34(1):57–67.

    Article  CAS  Google Scholar 

  7. Baldwin RM, Owzar K, Zembutsu H, Chhibber A, Kubo M, Jiang C, Watson D, Eclov R, Mefford J, McLeod HL, Friedman PN, Hudis CA, Winer EP, Jorgenson EM, Witte JS, Shulman LN, Nakamura Y, Ratain MJ, Kroetz DL. A genome-wide association study identifies novel loci for paclitaxel-induced sensory peripheral neuropathy in CALGB 40101. Clin Cancer Res. 2012; 18(18):5099–109.

    Article  CAS  Google Scholar 

  8. Cox DR. Regression models and life-tables. J R Stat Soc Ser B Methodol. 1972; 34(2):187–220.

    Google Scholar 

  9. Rao CR. Tests of significance in multivariate analysis. Biometrika. 1948; 35:58–79.

    Article  CAS  Google Scholar 

  10. Wu MC, Lee S, Cai T, Li Y, Boehnke M, Lin X. Rare-variant association testing for sequencing data with the sequence kernel association test. Am J Hum Genet. 2011; 89(1):82–93.

    Article  CAS  Google Scholar 

  11. Ionita-Laza I, Lee S, Makarov V, Buxbaum JD, Lin X. Sequence kernel association tests for the combined effect of rare and common variants. Am J Hum Genet. 2013; 92(6):841–53.

    Article  CAS  Google Scholar 

  12. Bonferroni CE. Il calcolo delle assicurazioni su gruppi di teste. Studi in Onore del Professore Salvatore Ortu Carbon. 1935;:13–60.

  13. Storey JD. The positive false discovery rate: a Bayesian interpretation and the q-value. Ann Stat. 2003; 31(6):2013–35.

    Article  Google Scholar 

  14. Storey JD, Taylor JE, Siegmund D. Strong control, conservative point estimation and simultaneous conservative consistency of false discovery rates: a unified approach. J R Stat Soc Ser B Stat Methodol. 2004; 66:187–205.

    Article  Google Scholar 

  15. Stroustrup B. The C++ Programming Language, 3rd edn. Boston: Addison-Wesley Longman Publishing Co., Inc.; 2000.

    Google Scholar 

  16. Eddelbuettel D, François R. Rcpp: seamless R and C++ integration. J Stat Softw. 2011; 40(8):1–18.

    Article  Google Scholar 

  17. GenABEL project developers. GenABEL: Genome-wide SNP Association Analysis. 2013. https://CRAN.R-project.org/package=GenABEL. R package version 1.8-0.

  18. Purcell S. PLINK. 2009. http://pngu.mgh.harvard.edu/purcell/plink/. version 1.07.

  19. Grueneberg A. BEDMatrix: Extract Genotypes from a PLINK.bed file. 2017. https://CRAN.R-project.org/package=BEDMatrix. R package version 1.4.0.

  20. Li Y, Willer CJ, Sanna S, Abecasis GR. Genotype imputation. Annu Rev Genomics Hum Genet. 2009; 10:387–406.

    Article  CAS  Google Scholar 

  21. Li Y, Willer CJ, Ding J, Scheet P, Abecasis GR. MaCH: using sequence and genotype data to estimate haplotypes and unobserved genotypes. Genet Epidemiol. 2010; 34:816–34.

    Article  Google Scholar 

  22. Marchini J, Howie B, Myers S, McVean G, Donnelly P. A new multipoint method for genome-wide association studies by imputation of genotypes. Nat Genet. 2007; 39:906–13.

    Article  CAS  Google Scholar 

  23. Danecek P, Auton A, Abecasis G, Albers CA, Banks E, DePristo MA, Handsaker RE, Lunter G, Marth GT, Sherry ST, McVean G, Durbin R, 1000 Genomes Project Analysis Group. The variant call format and VCFtools. Bioinformatics. 2011; 27(15):2156–8.

    Article  CAS  Google Scholar 

  24. Obenchain V, Lawrence M, Carey V, Gogarten S, Shannon P, Morgan M. VariantAnnotation: a Bioconductor package for exploration and annotation of genetic variants. Bioinformatics. 2014; 30(14):2076–8.

    Article  CAS  Google Scholar 

  25. Therneau TM. A Package for Survival Analysis in S. 2015. https://CRAN.R-project.org/package=survival. version 2.38.

  26. Xie Y. Dynamic Documents with R and knitr, 2nd edn. Boca Raton: Chapman and Hall/CRC; 2015. https://yihui.name/knitr/. ISBN 978-1498716963.

    Google Scholar 

  27. Shulman LN, Berry DA, Cirrincione CT. Comparison of doxorubicin and cyclophosphamide versus single-sgent paclitaxel as adjuvant therapy for breast cancer in women with 0 to 3 positive axillary nodes: CALGB 40101 (Alliance). J Clin Oncol. 2014; 32(22):2311–7.

    Article  CAS  Google Scholar 

  28. Gentleman R, Geyer C. Maximum likelihood for interval censored data: consistency and computation. Biometrika. 1994; 81:618–23.

    Article  Google Scholar 

  29. Fay MP, Shaw PA. Exact and asymptotic weighted logrank tests for interval censored data: the interval R package. J Stat Softw. 2010; 36(2):1–34.

    Article  Google Scholar 

  30. Pruim RJ, Welch RP, Sanna S, Teslovich TM, Chines PS, Gliedt TP, Boehnke M, Abecasis GR, Willer CJ. LocusZoom: regional visualization of genome-wide association scan results. Bioinformatics. 2010; 26(18):2336–7.

    Article  CAS  Google Scholar 

  31. Kalbfleisch JD, Prentice RL. The Statistical Analysis of Failure Time Data, 2nd edn. New York: Wiley; 2011. Chap. 4.

    Google Scholar 

  32. Flegel C, Schöbel N, Altmüller J, Becker C, Tannapfel A, Hatt H, Gisselmann G. RNA-Seq analysis of human trigeminal and dorsal root ganglia with a focus on chemoreceptors. PLoS ONE. 2015; 10(6):1–30.

    Article  Google Scholar 

  33. Aino R, Pontus A. The atypical Rho GTPase Wrch1 collaborates with the nonreceptor tyrosine kinases Pyk2 and Src in regulating cytoskeletal dynamics. Mol Cell Biol. 2007; 28(5):1802–14.

    Google Scholar 

  34. Alan JK, Robinson SK, Magsig KL, Demarco RS, Lundquist EA. The atypical Rho GTPase CHW-1 works with SAX-3/Robo to mediate axon guidance in caenorhabditis elegans. G3 (Bethesda). 2018; 8(6):1885–95.

    Article  Google Scholar 

  35. Stankiewicz TR, Linseman DA. Rho family GTPases: key players in neuronal development, neuronal survival, and neurodegeneration. Front Cell Neurosci. 2014; 8:314.

    Article  Google Scholar 

  36. Kachhap SK, Faith D, Qian DZ, Shabbeer S, Galloway NL, Pili R, Denmeade SR, DeMarzo AM, Carducci MA. The N-Myc down regulated gene1 (NDRG1) is a RAB4A effector involved in vesicular recycling of E-Cadherin. PLoS ONE. 2007; 2(9):1–11.

    Article  Google Scholar 

  37. Kalaydjieva L, Gresham D, Gooding R, Heather L, Baas F, de Jonge R, Blechschmidt K, Angelicheva D, Chandler D, Worsley P, Rosenthal A, King RHM, Thomas PK. N-myc downstream-regulated gene 1 is mutated in hereditary motor and sensory neuropathy-Lom. Am J Hum Genet. 2000; 67(1):47–58.

    Article  CAS  Google Scholar 

  38. Hunter M, Bernard R, Freitas E, Boyer A, Morar B, Martins IJ, Tournev I, Jordanova A, Guergelcheva V, Ishpekova B, Kremensky I, Nicholson G, Schlotter B, Lochmuller H, Voit T, Colomer J, Thomas PK, Levy N, Kalaydjieva L. Mutation screening of the N-myc downstream-regulated gene 1 (NDRG1) in patients with Charcot-Marie Tooth Disease. Hum Mutat. 2003; 22(2):129–35.

    Article  CAS  Google Scholar 

  39. Okamoto Y, Goksungur MT, Pehlivan D, Beck CR, Gonzaga-Jauregui C, Muzny DM, Atik MM, Carvalho CMB, Matur Z, Bayraktar S, Boone PM, Akyuz K, Gibbs RA, Battaloglu E, Parman Y, Lupski JR. Exonic duplication CNV of NDRG1 associated with autosomal-recessive HMSN-Lom/CMT4D. Genet Med. 2014; 16(5):386–94.

    Article  CAS  Google Scholar 

  40. Schwarz Q, Vieira JM, Howard B, Eickholt BJ, Ruhrberg C. Neuropilin 1 and 2 control cranial gangliogenesis and axon guidance through neural crest cells. Development. 2008; 135(9):1605–13.

    Article  CAS  Google Scholar 

  41. Harrison V, Connell L, Hayesmoore J, McParland J, Pike MG, Blair E. Compound heterozygous deletion of NRXN1 causing severe developmental delay with early onset epilepsy in two sisters. Am J Med Genet A. 2011; 155a(11):2826–31.

    Article  Google Scholar 

  42. Biederer T, Sara Y, Mozhayeva M, Atasoy D, Liu XR, Kavalali ET, Sudhof TC. SynCAM, a synaptic adhesion molecule that drives synapse assembly. Science. 2002; 297(5586):1525–31.

    Article  CAS  Google Scholar 

  43. Ripatti S, Palmgren J. Estimation of multivariate frailty models using penalized partial likelihood. Biometrics. 2004; 56(4):1016–22.

    Article  Google Scholar 

  44. Bioconductor Core Team. TxDb.Hsapiens.UCSC.hg38.knownGene: Annotation Package for TxDb Object(s). 2016. http://bioconductor.org/packages/TxDb.Hsapiens.UCSC.hg38.knownGene/. R package version 3.4.0.

  45. Hsu F, Kent WJ, Clawson H, Kuhn RM, Diekhans M, Haussler D. The UCSC known genes. Bioinformatics. 2006; 22(9):1036–46.

    Article  CAS  Google Scholar 

  46. Pages H. SNPlocs.Hsapiens.dbSNP150.GRCh38: SNP Locations for Homo Sapiens (dbSNP Build 150). 2017. http://bioconductor.org/packages/SNPlocs.Hsapiens.dbSNP150.GRCh38/. R package version 0.99.20.

Download references

Acknowledgements

The authors thank reviewers for comments and suggestions that substantially improved the paper. The content is solely the responsibility of the authors and does not necessarily represent the official views of the National Institutes of Health. The authors gratefully acknowledge the Alliance for Oncology Clinical Trial for sharing the data from the CALGB 40101 GWAS.

Funding

This research was supported in part by awards P01CA142538 (AA, KO, JL and ZL) from the National Cancer Institute. The funder has no role in the design of the study, collection, analysis, and interpretation of the data or writing the manuscript.

Availability of data and materials

The clinical and genomic data from CALGB 40101 are available for download from the database of Genotypes and Phenotypes (dbGaP) through accession phs000807.v1.p1. The script to produce the grouped censored phenotype presented in this paper is provided as supplementary material.

Author information

Authors and Affiliations

Authors

Contributions

ZL and KO conceived of and designed the project; KCC and DLK acquired the clinical and genomic data; ABS, JM, TT and YJ developed the initial software; ZL, KO, ABS, TT, JL and AA contributed to the methodology development; JL formalized, refined and packaged the software and performed the analyses; KCC and DLK interpreted the biological findings; JL, ABS, KO and ZL wrote the manuscript, with significant contributions from JM.; All authors have agreed to be responsible for the accuracy and integrity of the work and have given final approval of the version to be published.

Corresponding author

Correspondence to Zhiguo Li.

Ethics declarations

Ethics approval and consent to participate

The analyses presented in this report were conducted on the basis of de-identified demographic, clinical and genome-wide genetic data from patients randomized to CALGB 40101 (NCT00041119). The analysis population was restricted to CALGB 40101 patients who had provided consent to participation in pharmacogenomic research under the auspices of a pharmacogenetic companion study (CALGB 60202). Consent for participation in pharmacogenetic studies was obtained on the basis of written approval from each patient and recorded on a protocol-specific informed consent form. The Alliance for Clinical Trials in Oncology is the responsible party for CALGB 40101 and has given authors permission to use the data for this methods research project. Their contribution has been acknowledged in the paper. It is also noted that these data are available through the database of Genotypes and Phenotypes (dbGaP; Study Accession: phs000807.v1.p1).

The clinical parent study CALGB 40101 (NCT00041119) along with all of its correlative sub-studies, including CALGB 60202, were reviewed by the Central Institutional Review Board (CIRB) for the National Cancer Institute (www.ncicirb.org).

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Additional files

Additional file 1

Additional descriptions of statistical model, simulation parameters, and statistical operating characteristics and data analysis results, including additional illustrative figures. (PDF 556 kb)

Additional file 2

knitr-generated slides showing R code used to reproducibly conduct the data simulations, summarize the operating characteristics, and estimate the processing benchmarks. (PDF 112 kb)

Additional file 3

knitr-generated slides showing R code used to reproducibly conduct the analysis of the CALGB 40101 data. (PDF 145 kb)

Additional file 4

Table containing the annotated top 300 SNPs, ranked by unadjusted P-value, from the CALGB 40101 GWAS results. (CSV 29 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Li, Z., Lin, J., Sibley, A.B. et al. Efficient estimation of grouped survival models. BMC Bioinformatics 20, 269 (2019). https://doi.org/10.1186/s12859-019-2899-x

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-019-2899-x

Keywords