kmcut 1.2.0
This document provides a brief tutorial for the R package ‘kmcut’. The main purpose of the package is to identify potential prognostic biomarkers and an optimal numeric cutoff for each biomarker that can be used to stratify a group of test subjects (samples) into two sub-groups with significantly different survival (better vs. worse). Originally, the package was intended to be used with variables that describe gene expression, such as microarray or RNA-seq expression levels of individual genes or gene signatures, such as single-sample Gene Set Enrichment Analysis (ssGSEA) signatures. However, it can be used with any quantitative variable that has a sufficiently large proportion of unique values. The main requirement of the package is that for a group of test subjects (samples) two types of data are available: (a) right-censored survival time data and (b) at least one gene expression-like feature with a large proportion of unique numeric values describing each test subject (sample).
The package can be installed from Bioconductor by utilizing the code below:
After installation, load the package:
The package requires input data to be in two tab-delimited text files:
A file with right-censored survival data and
A file with gene expression-like features. The sample identifiers in both files must be exactly the same. The package contains built-in example files with survival data and RNA-seq gene expression data that describe neuroblastoma tumor samples (Zhang et al, 2015).
| sample_id | stime | scens | 
| SEQC_NB001 | 1362 | 1 | 
| SEQC_NB002 | 2836 | 1 | 
| SEQC_NB003 | 1191 | 1 | 
| SEQC_NB004 | 220 | 1 | 
| SEQC_NB005 | 2217 | 0 | 
Table 1. An illustration of the survival data file format for five samples.
| tracking_id | SEQC_NB001 | SEQC_NB002 | SEQC_NB003 | SEQC_NB004 | SEQC_NB005 | 
| MYCN | 4.16347458 | 3.464994927 | 8.494631614 | 8.438018327 | 5.509974474 | 
| MYH2 | 0.006539622 | 0.009077256 | 0 | 4.111214977 | 0.008735951 | 
Table 2. An illustration of the file format for expression data with two genes and five samples.
Expression and survival data are stored in a SummarizedExperiment object. The function ‘create_se_object’ reads a file with expression data and a file with survival data, and returns a SummarizedExperiment object.
# Read names of the built-in gene expression data file and survival data file
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create a SummarizedExperiment object 'se'
se = create_se_object(efile = fdat, sfile = sdat)This function uses each distinct value of every feature from the dataset as a stratification cutoff to select a cutoff that results in the maximum separation of the Kaplan-Meier survival curves, and then estimates the statistical significance of this optimal cutoff by means of the permutation test. A detailed description of the steps implemented in this function is provided below and is also available in our original publication (Wei et al, 2018).
First, an ordered list C of all distinct values of a given feature observed in the group of test subjects (samples) is created, all values in the list being sorted from smallest to largest. Then, each value from the list is used as a stratification cutoff: samples with the feature below or equal to the cutoff are labeled as ‘low’ and above the cutoff as ‘high’. To avoid edge effects, if for a particular cutoff the size of low or high sub-group is smaller than ‘min_fraction’ of the total number of samples, this cutoff is discarded from the list. The log-rank test is applied to compare survival distributions between the low and high groups for each stratification cutoff, and the value of the test statistic is recorded. After all stratification cutoffs from the list are tested, the vector of the observed values of the test statistic is created, O=(o1, o2 ,…, on), where oi is the observed value of the test statistic for the cutoff ci in the list C=(c1, c2 ,…, cn). The cutoff that results in the largest value of the test statistic, OMAX, is selected as the optimal cutoff, COPT. If two or more cutoffs result in the same observed value of the test statistic, the cutoff closest to the median is selected.
Additionally, the shape of the plot of the observed values of the test statistic is compared to the expected “ideal” plot. The empirical assumption behind this comparison is that the “ideal” optimization should produce a plot of the observed values of the test statistic with exactly one peak, meaning that the values monotonically increase before the peak and monotonically decrease after the peak. Initially, three possible expected plots are defined: E1, E2, and E3. Each plot consists of cutoff points from C, has a single peak, with the height of this peak being equal to OMAX. In the plot E1 the peak is located at the 25th percentile of all distinct values of the feature, in the plot E2 at the 50th percentile, and in the plot E3 at the 75th percentile. The final expected plot, E, is selected from (E1, E2, E3) to minimize the distance from the location of its peak to COPT. The similarity of is quantified by the Spearman rank correlation between the vectors of the observed and expected values, r(O, E).
The statistical significance of the stratification cutoff COPT obtained from the optimization procedure for a given feature is estimated by means of a random permutation test run for ‘n_iter’ iterations. On each iteration i, the sample labels in the survival data and in the feature data are randomly shuffled, the same optimization procedure is applied to the randomized data, and the largest value of the observed test statistic ORAND(i) and the Spearman rank correlation between the observed and expected plot rRAND(i) are recorded. After all ‘n_iter’ iterations are completed, the p-value is calculated as follows:
The equation used to calculate the p-value.
where d[ORAND(i) OMAX AND rRAND(i) r(O, E)] = 1 if on random iteration i
the largest value of the observed test statistic is equal to or greater than
OMAX and the Spearman rank correlation between the observed and the expected
plot is equal to or greater than r(O, E). Otherwise,
d[ORAND(i) OMAX AND rRAND(i) r(O, E)] = 0.
The random permutation test described above is time-consuming. It is recommended that the users first run the ‘km_opt_scut’ function to identify a relatively small sub-set of candidate genes, and then apply ‘km_opt_pcut’ to this sub-set.
The ‘km_opt_pcut’ function can be run in parallel on multiple processors by
setting the nproc argument to the desired number of processors. The graph
below shows how the run time of the ‘km_opt_pcut’ function decreases when the
number of processors is increased. The results were obtained by using a data set
of 200 genes and 215 samples, with 10000 iterations per gene.
Benchmarking utilized the NIH High Performance Computing cluster
Biowulf.
The run time vs. the number of processors.
An example of how to run ‘km_opt_pcut’ on 1 processor with the data files included in the package:
# Read names of the built-in gene expression data file and survival data file
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object
se = create_se_object(efile = fdat, sfile = sdat)
# Run the permutation test for 10 iterations for each gene, use 1 processor
km_opt_pcut(obj = se, bfname = "test", n_iter = 10, wlabels = TRUE,
                wpdf = FALSE, verbose = FALSE, nproc = 1)## Running on 1 CPU(s)
Two graphs are created for each gene, MYCN and MYH2.
One graph shows the observed optimization plot (blue circles) and the expected
optimization plot (green triangles). The optimal stratification cutoff is
highlighted by the red circle. The Spearman rank correlation between the
observed and the expected plots is printed after gene name. For instance, in
the case of MYCN the correlation is high, R = 0.909, indicating good
optimization. In the case of MYH2, the correlation is low and negative,
R = -0.043, indicating poor optimization.
The other graph shows the Kaplan-Meier survival curves for groups with low and
high gene expression groups stratified using the optimal cutoff. The value of
this optimal cutoff and the p-value are printed after gene name. For instance,
in the case of MYCN gene, the optimal cutoff is 5.84464 and the p-value is 0
(note that in the figure the p-value is shown as exactly 0 because only 10
iterations of the permutation test were used in this example).
The MYCN oncogene expression is known to be a strong predictor of survival outcome for neuroblastoma patients - low expression levels correspond to better survival, high expression levels correspond to poor survival (Norris et al, 1997). The significant results of the optimization for MYCN confirm this information.
The MYH2 gene encodes the myosin heavy chain 2, which is a protein found in the muscle tissue and the level of its expression has nothing to do with neuroblastoma survival (Smerdu et al, 1994). The statistically not significant results of the optimization for MYH2 confirm this information.
Additionally, this run will create the following two output files in the current working directory (the names of output files will be created automatically by adding the run information to the base name ‘bfname’).
a) Tab-delimited text file with the results
“test_KMoptp_minf_0.10_iter_10.txt”
| tracking_id | CUTOFF | CHI_SQ | LOW_N | HIGH_N | R | P | FDR_P | 
| MYCN | 5.84464174 | 70.91 | 49 | 44 | 0.909 | 0 | 0 | 
| MYH2 | 0.00219771 | 2.52 | 42 | 51 | -0.043 | 0.1 | 0.1 | 
Table 3. An illustration of the file format for tab-delimited text file with the results for two genes. 1st column – gene id, 2nd – optimal stratification cutoff, 3rd – test statistic calculated for the optimal cutoff, 4th – number of samples in low-expression sub-group, 5th - number of samples in high-expression sub-group, 6th – permutation test p-value, 7th – FDR-adjusted p-value.
b) CSV file with low/high sample labels
“test_KMoptp_minf_0.10_iter_10_labels.csv”
| sample_id | MYCN | MYH2 | 
|---|---|---|
| SEQC_NB003 | 2 | 1 | 
| SEQC_NB005 | 2 | 2 | 
| SEQC_NB006 | 1 | 2 | 
| SEQC_NB016 | 1 | 2 | 
| SEQC_NB051 | 1 | 1 | 
Table 4. An illustration of the file format for the CVS file with low/high labels for two genes and five samples. 1st column – sample ids, all subsequent columns contain low/high labels for each gene, where 1 and 2 correspond to low- and high-expression sub-groups, respectively (‘low’ means below the cutoff and ‘high’ means above the cutoff).
This function uses each distinct value of a given feature observed in the dataset as a stratification cutoff to select a cutoff that results in the maximum separation of the Kaplan-Meier survival curves, but does not use the permutation test to estimate the statistical significance of this optimal cutoff. ‘km_opt_scut’ produces graphs and output files virtually identical to the output of ‘km_opt_pcut’ (except for the permutation test p-value) and is meant to be used as a fast exploratory alternative to ‘km_opt_pcut’. An example of how to use ‘km_opt_scut’ with the data files included in the package:
# Read names of the built-in gene expression data file and survival data file
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object
se <- create_se_object(efile = fdat, sfile = sdat)
 
# Search for optimal cutoffs
km_opt_scut(obj = se, bfname = "test", wpdf = FALSE, verbose = FALSE)
Two graphs are created for each gene, MYCN and MYH2.
Additionally, this run will create the following two output files in the current working directory (the names of output files will be created automatically by adding the run information to the base name ‘bfname’).
a) Tab-delimited text file with the results "test_KMopt_minf_0.10.txt
b) CSV file with low/high sample labels “test_KMopt_minf_0.10_labels.csv”
The format of these files is identical to the output files described for function ‘km_opt_pcut’. The only difference is that the tab-delimited file with the results in column ‘P’ and the PDF file with Kaplan-Meier curves contain the p-value obtained from the log-rank test performed with the optimal cutoff. This p-value is provided for information purposes only and should not be treated as an actual p-value because it does not reflect the calculation of multiple test statistics involved in the optimization procedure applied to select the optimal cutoff.
For each feature, this function uses the cutoff supplied as a quantile (from 0 to 100) to stratify samples into 2 groups (below and above this quantile), plots Kaplan-Meier survival curves for these two groups and calculates the log-rank test p-value. Since for each feature only one cutoff corresponding to the specified quantile is used, it is equivalent to performing one log-rank test per feature (that is, no optimization is performed). An example of how to use ‘km_qcut’ with the data files included in the package:
# Read names of the built-in gene expression data file and survival data file
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package="kmcut")
# Create SummarizedExperiment object
se <- create_se_object(efile = fdat, sfile = sdat)
 
# Use the 50th quantile (the median) to stratify the samples
km_qcut(obj = se, bfname = "test", quant = 50, wpdf = FALSE)
A graph with Kaplan-Meier curves will be created for each gene, MYCN and MYH2.
Additionally, this run will create the following two output files in the current working directory (the names of output files will be created automatically by adding the run information to the base name ‘bfname’).
a) Tab-delimited text file with the results “test_KM_quant_50.txt”
b) CSV file with low/high sample labels “test_KM_quant_50_labels.csv”
The format of these two files is identical to the output files described for function ‘km_opt_pcut’.
For each feature, this function applies the user-supplied fixed value as a cutoff to stratify samples into 2 groups (below/above this cutoff), plots Kaplan-Meier survival curves for these two groups, and calculates the log-rank test p-value. Since for each feature the same fixed cutoff is used, it is equivalent to performing one log-rank test per feature (no optimization is performed). An example of how to use ‘km_ucut’ with the data files included in the package:
# Read names of the built-in gene expression data file and survival data file
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object
se <- create_se_object(efile = fdat, sfile = sdat)
 
# Use the cutoff = 5 to stratify the samples and remove features that have 
# less than 90% unique values (this removes the MYH2 gene from the analysis)
km_ucut(obj = se, bfname = "test", cutoff = 5, min_uval = 90, wpdf = FALSE)
A graph with Kaplan-Meier curves is created for gene (there is only MYCN here).
Additionally, this run will create the following two output files in the current working directory (the names of output files will be created automatically by adding the run information to the base name ‘bfname’).
a) Tab-delimited text file with the results “test_KM_ucut_5.txt”
b) CSV file with low/high sample labels “test_KM_ucut_5_labels.csv”
The format of these two files is identical to the output files described for function ‘km_opt_pcut’.
This function creates Kaplan-Meier survival curves for each feature in a validation data file by using a file with previously determined stratification cutoffs (one cutoff per feature) and calculates the log-rank test p-value. Since for each feature only one previously determined cutoff is used, it is equivalent to performing one log-rank test per feature (no optimization is performed). The file with previously determined stratification cutoffs is a tab-delimited file with the table that contains one or more feature and a stratification cutoff for each feature (the table is generated by functions ‘km_opt_scut’, ‘km_opt_pcut’, ‘km_qcut’ or ‘km_ucut’). It must have first two columns named as ‘tracking_id’ and ‘CUTOFF’. The ‘tracking_id’ column contains gene (feature) names, the ‘CUTOFF’ column contains stratification cutoff for each gene (feature). An example of how to use ‘km_val_cut’ to validate stratification cutoffs determined by ‘km_qcut’:
# Read names of training (fdat1) and validation (fdat2) gene expression data
# files and survival data file (sdat).
fdat1 <- system.file("extdata", "expression_data_1.txt", package = "kmcut")
fdat2 <- system.file("extdata", "expression_data_2.txt", package = "kmcut")
sdat <- system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object with training data
se1 <- create_se_object(efile = fdat1, sfile = sdat)
# Step 1: Run 'km_qcut' on the training data in 'se1'
km_qcut(obj = se1, bfname = "training_data", quant = 50, min_uval = 40)Step 1 will create three output files in the current working directory:
The format of these three files is identical to the output files described for function ‘km_opt_pcut’. The only difference is that the PDF file does not contain observed vs. expected optimization plots.
# Create SummarizedExperiment object with test data
se2 <- create_se_object(efile = fdat2, sfile = sdat)
 
# Step 2: Validate the thresholds from "training_data_KM_quant_50.txt" on
# the test data in 'se2'.
km_val_cut(infile = "training_data_KM_quant_50.txt", obj = se2, 
             bfname = "test", wpdf = TRUE, min_uval = 40)Step 2 will create three output files in the current working directory:
The format of these three files is identical to the output files described for function ‘km_opt_pcut’. The only difference is that the PDF file does not contain observed vs. expected optimization plots.
This function fits a univariate Cox proportional hazard regression model and performs the likelihood ratio test for each feature in the dataset. An example of how to use ‘ucox_batch’ with the data files included in the package:
# Read names of the built-in gene expression data file (fdat) and
# survival data file (sdat)
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object
se <- create_se_object(efile = fdat, sfile = sdat)
# Perform the regression on the data in 'se'
ucox_batch(obj = se, bfname = "test")## Processing 1 of 2## Processing 2 of 2This will create in the current working directory a tab-delimited text file with results “test_ucoxbatch.txt”
| tracking_id | CC | HR | P | FDR_P | 
| MYCN | 0.78532 | 1.82512 | 1.6284328112261e-14 | 3.25686562245233e-14 | 
| MYH2 | 0.46433 | 1.43 | 0.318152334987645 | 0.318152334987645 | 
Table 5. An illustration of the file format for the tab-delimited text file with Cox regression summary. 1st column – gene id, 2nd – concordance coefficient, 3rd – hazard ratio, 4th – likelihood ratio test p-value, 5th – FDR-adjusted p-value.
This function fits a univariate Cox proportional hazard regression model for each feature in the training dataset and then uses the models to calculate risk scores for the same features in the test dataset. An example of how to use ‘ucox_pred’ with the data files included in the package:
# Read names of the built-in training (fdat1) and test (fdat2) 
# gene expression data files and survival data file (sdat)
fdat1 = system.file("extdata", "expression_data_1.txt", package = "kmcut")
fdat2 = system.file("extdata", "expression_data_2.txt", package = "kmcut")
sdat = system.file("extdata", "survival_data.txt", package = "kmcut")
# Create SummarizedExperiment object with training data
se1 <- create_se_object(efile = fdat1, sfile = sdat)
# Create SummarizedExperiment object with test data
se2 <- create_se_object(efile = fdat2, sfile = sdat)
# Fit Cox model on the training data in 'se1' and use it to calculate the risk
# scores for the test data in 'se2'.
ucox_pred(obj1 = se1, obj2 = se2, bfname = "demo", min_uval = 40)## Processing 1 of 2## Processing 2 of 2This will create three output files in the current working directory:
a) Tab-delimited text file with Cox regression summary for the training data
“demo_cox_train_sum.txt”
| tracking_id | CC | HR | P | FDR_P | 
| MYCN | 0.66449 | 1.29795 | 5.8280601452252e-06 | 1.16561202904505e-05 | 
| MYH2 | 0.45961 | 1.89406 | 0.127377383432028 | 0.127377383432028 | 
Table 6. An illustration of the file format for the tab-delimited text file with Cox regression summary. 1st column – gene id, 2nd – concordance coefficient, 3rd – hazard ratio, 4th – likelihood ratio test p-value, 5th – FDR-adjusted p-value.
b) Tab-delimited text file with the risk scores for the training data
“demo_train_score.txt”
In this file, rows are genes (features) and columns are samples.
c) Tab-delimited text file with the risk scores for the test data
“demo_test_score.txt”
In this file, rows are genes (features) and columns are samples.
The package also contains the following functions that can be used to manipulate data tables.
This function extracts a sub-set of rows (such as a group of genes) from a data table. All columns will be preserved. Names of the rows to be extracted must be in a text file, one name per line (the exact names, case-sensitive, no extra symbols are allowed). An example of how to use the function with the data files included in the package:
# Read the name of the built-in gene expression data file with 2 genes (2 rows)
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
# Read the name of the built-in list file that contains one gene id (MYCN)
idlist = system.file("extdata", "rowids.txt", package = "kmcut")
# Run the function
extract_rows(fnamein = fdat, fids = idlist,
            fnameout = "example_genes_subset.txt")This will create a tab-delimited text file “example_genes_subset.txt” with one row “MYCN” in the current working directory.
This function extracts a sub-set of columns (such as a group of samples) from a data table. All rows will be preserved. Names of the columns to be extracted must be in a text file, one name per line (the exact names, case-sensitive, no extra symbols are allowed). An example of how to use the function with the data files included in the package:
# Read the name of the built-in gene expression data file with 2 genes (2 rows)
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
# Read the name of the built-in list file that contains a sub-set of 
# column (sample) ids
idlist = system.file("extdata", "columnids.txt", package = "kmcut")
# Run the function
extract_columns(fnamein = fdat, fids = idlist,
                    fnameout = "example_samples_subset.txt")This will create a tab-delimited text file “example_samples_subset.txt” in the current working directory. This file will contain columns (samples) from the list.
This function transposes a data table (that is, converts rows to columns and columns to rows). Row names will become column names, and column names will become row names. An example of how to use the function with the data file included in the package:
# Read the name of the built-in gene expression data file.
# In this file, genes are rows and samples are columns.
fdat = system.file("extdata", "example_genes.txt", package = "kmcut")
# Run the function
transpose_table(fnamein = fdat, fnameout = "example_genes_transposed.txt")This will create a tab-delimited text file “example_genes_295_transposed.txt” with the transposed table in the current working directory. In this file, genes (features) are columns and samples are rows.
## R version 4.5.0 RC (2025-04-04 r88126)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_GB              LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## time zone: America/New_York
## tzcode source: system (glibc)
## 
## attached base packages:
## [1] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] kmcut_1.2.0      BiocStyle_2.36.0
## 
## loaded via a namespace (and not attached):
##  [1] sass_0.4.10                 generics_0.1.3             
##  [3] SparseArray_1.8.0           lattice_0.22-7             
##  [5] magrittr_2.0.3              pracma_2.4.4               
##  [7] digest_0.6.37               evaluate_1.0.3             
##  [9] grid_4.5.0                  bookdown_0.43              
## [11] iterators_1.0.14            fastmap_1.2.0              
## [13] foreach_1.5.2               doParallel_1.0.17          
## [15] jsonlite_2.0.0              Matrix_1.7-3               
## [17] GenomeInfoDb_1.44.0         survival_3.8-3             
## [19] tinytex_0.57                BiocManager_1.30.25        
## [21] httr_1.4.7                  UCSC.utils_1.4.0           
## [23] codetools_0.2-20            jquerylib_0.1.4            
## [25] abind_1.4-8                 cli_3.6.4                  
## [27] rlang_1.1.6                 crayon_1.5.3               
## [29] XVector_0.48.0              Biobase_2.68.0             
## [31] splines_4.5.0               cachem_1.1.0               
## [33] DelayedArray_0.34.0         yaml_2.3.10                
## [35] S4Arrays_1.8.0              tools_4.5.0                
## [37] parallel_4.5.0              GenomeInfoDbData_1.2.14    
## [39] SummarizedExperiment_1.38.0 BiocGenerics_0.54.0        
## [41] R6_2.6.1                    matrixStats_1.5.0          
## [43] stats4_4.5.0                lifecycle_1.0.4            
## [45] magick_2.8.6                S4Vectors_0.46.0           
## [47] IRanges_2.42.0              bslib_0.9.0                
## [49] Rcpp_1.0.14                 xfun_0.52                  
## [51] GenomicRanges_1.60.0        MatrixGenerics_1.20.0      
## [53] knitr_1.50                  htmltools_0.5.8.1          
## [55] rmarkdown_2.29              compiler_4.5.0Zhang, W., Yu, Y., Hertwig, F., et al. (2015) [Comparison of RNA-seq and
microarray-based models for clinical endpoint prediction.]
Genome Biol. 16, 133.
(https://genomebiology.biomedcentral.com/articles/10.1186/s13059-015-0694-1)
Wei, J.S., Kuznetsov, I.B., Zhang, S., et al. (2018) [Clinically Relevant
Cytotoxic Immune Cell Signatures and Clonal Expansion of T-Cell Receptors in
High-Risk MYCN-Not-Amplified Human Neuroblastoma.]
Clin. Cancer Res. 24(22), 5673-5684.
(https://clincancerres.aacrjournals.org/content/24/22/5673.long)
Norris, M.D., Bordow, S.B., Haber, P.S., et al. (1997) [Evidence that the
MYCN oncogene regulates MRP gene expression in neuroblastoma.]
Eur. J. Cancer 33(12), 1911-1916.
(https://pubmed.ncbi.nlm.nih.gov/9516823/)
Smerdu, V., Karsch-Mizrachi, I., Campione, M., et al. (1994) [Type IIx
myosin heavy chain transcripts are expressed in type IIb fibers of human
skeletal muscle.]
Am. J. Physiol. 267(6 Pt 1), C1723-1728.
(https://pubmed.ncbi.nlm.nih.gov/7545970/)