I. Preliminaries

Loading libraries

library("tidyverse")
library("tibble")
library("msigdbr")
library("ggplot2")
library("TCGAbiolinks")
library("RNAseqQC")
library("DESeq2")
library("ensembldb")
library("purrr")
library("magrittr")
library("vsn")
library("matrixStats")
library("dplyr")
library("grex")
library("survminer")
library("survival")

II. Downloading the TCGA gene expression data

Create a function for downloading TCGA gene expression data.

For more detailed documentation, refer to 2. Differential Gene Expression Analysis - TCGA.Rmd.

GDC_DIR = "../data/public/GDCdata"

query_and_filter_samples <- function(project) {
  query_tumor <- GDCquery(
    project = project,
    data.category = "Transcriptome Profiling",
    data.type = "Gene Expression Quantification",
    experimental.strategy = "RNA-Seq",
    workflow.type = "STAR - Counts",
    access = "open",
    sample.type = "Primary Tumor"
  )
  tumor <- getResults(query_tumor)

  query_normal <- GDCquery(
    project = project,
    data.category = "Transcriptome Profiling",
    data.type = "Gene Expression Quantification",
    experimental.strategy = "RNA-Seq",
    workflow.type = "STAR - Counts",
    access = "open",
    sample.type = "Solid Tissue Normal"
  )
  normal <- getResults(query_normal)

  submitter_ids <- inner_join(tumor, normal, by = "cases.submitter_id") %>%
    dplyr::select(cases.submitter_id)
  tumor <- tumor %>%
    dplyr::filter(cases.submitter_id %in% submitter_ids$cases.submitter_id)
  normal <- normal %>%
    dplyr::filter(cases.submitter_id %in% submitter_ids$cases.submitter_id)

  samples <- rbind(tumor, normal)
  unique(samples$sample_type)

  query_project <- GDCquery(
    project = project,
    data.category = "Transcriptome Profiling",
    data.type = "Gene Expression Quantification",
    experimental.strategy = "RNA-Seq",
    workflow.type = "STAR - Counts",
    access = "open",
    sample.type = c("Solid Tissue Normal", "Primary Tumor"),
    barcode = as.list(samples$sample.submitter_id)
  )

  # If this is your first time running this notebook (i.e., you have not yet downloaded the results of the query in the previous block),
  # uncomment the code block below

  # GDCdownload(
  #   query_coad,
  #   directory = GDC_DIR
  # )

  return(list(samples = samples, query_project = query_project))
}

Download the TCGA gene expression data for colorectal cancer (TCGA-COAD).

projects <- c("TCGA-COAD")

with_results_projects <- c()

samples <- list()
project_data <- list()

for (project in projects) {
  result <- tryCatch(
    {
      result <- query_and_filter_samples(project)
      samples[[project]] <- result$samples
      project_data[[project]] <- result$query_project

      with_results_projects <- c(with_results_projects, project)
    },
    error = function(e) {

    }
  )
}

Running the code block above should generate and populate a directory named GDCdata.

III. Data preprocessing

Construct the RNA-seq count matrix for each cancer type.

tcga_data <- list()
tcga_matrix <- list()

projects <- with_results_projects
for (project in projects) {
  tcga_data[[project]] <- GDCprepare(
    project_data[[project]], 
    directory = GDC_DIR,
    summarizedExperiment = TRUE
  )
}
for (project in projects) {
  count_matrix <- assay(tcga_data[[project]], "unstranded")

  # Remove duplicate entries
  count_matrix_df <- data.frame(count_matrix)
  count_matrix_df <- count_matrix_df[!duplicated(count_matrix_df), ]
  count_matrix <- data.matrix(count_matrix_df)
  rownames(count_matrix) <- cleanid(rownames(count_matrix))
  count_matrix <- count_matrix[!(duplicated(rownames(count_matrix)) | duplicated(rownames(count_matrix), fromLast = TRUE)), ]

  tcga_matrix[[project]] <- count_matrix
}

Format the samples table so that it can be fed as input to DESeq2.

for (project in projects) {
  rownames(samples[[project]]) <- samples[[project]]$cases
  samples[[project]] <- samples[[project]] %>%
    dplyr::select(case = "cases.submitter_id", type = "sample_type")
  samples[[project]]$type <- str_replace(samples[[project]]$type, "Solid Tissue Normal", "normal")
  samples[[project]]$type <- str_replace(samples[[project]]$type, "Primary Tumor", "tumor")
}

DESeq2 requires the row names of samples should be identical to the column names of count_matrix.

for (project in projects) {
  colnames(tcga_matrix[[project]]) <- gsub(x = colnames(tcga_matrix[[project]]), pattern = "\\.", replacement = "-")
  tcga_matrix[[project]] <- tcga_matrix[[project]][, rownames(samples[[project]])]

  # Sanity check
  print(all(colnames(tcga_matrix[[project]]) == rownames(samples[[project]])))
}

IV. Differential gene expression analysis

For more detailed documentation on obtaining the gene set, refer to 7. Differential Gene Expression Analysis - TCGA - Pan-cancer - Unique Genes.Rmd.

RCDdb <- "../data/public/rcd-gene-list/unique-genes/necroptosis-ferroptosis-pyroptosis/"

Write utility functions for filtering the gene sets, performing differential gene expression analysis, plotting the results, and performing variance-stabilizing transformation.

filter_gene_set_and_perform_dgea <- function(genes) {
  tcga_rcd <- list()

  for (project in projects) {
    rownames(genes) <- genes$gene_id
    tcga_rcd[[project]] <- tcga_matrix[[project]][rownames(tcga_matrix[[project]]) %in% genes$gene_id, ]
    tcga_rcd[[project]] <- tcga_rcd[[project]][, rownames(samples[[project]])]
  }

  dds_rcd <- list()
  res_rcd <- list()

  for (project in projects) {
    print(project)
    print("=============")
    dds <- DESeqDataSetFromMatrix(
      countData = tcga_rcd[[project]],
      colData = samples[[project]],
      design = ~type
    )
    dds <- filter_genes(dds, min_count = 10)
    dds$type <- relevel(dds$type, ref = "normal")
    dds_rcd[[project]] <- DESeq(dds)
    res_rcd[[project]] <- results(dds_rcd[[project]])
  }

  deseq.bbl.data <- list()

  for (project in projects) {
    deseq.results <- res_rcd[[project]]
    deseq.bbl.data[[project]] <- data.frame(
      row.names = rownames(deseq.results),
      baseMean = deseq.results$baseMean,
      log2FoldChange = deseq.results$log2FoldChange,
      lfcSE = deseq.results$lfcSE,
      stat = deseq.results$stat,
      pvalue = deseq.results$pvalue,
      padj = deseq.results$padj,
      cancer_type = project,
      gene_symbol = genes[rownames(deseq.results), "gene"]
    )
  }

  deseq.bbl.data.combined <- bind_rows(deseq.bbl.data)
  deseq.bbl.data.combined <- dplyr::filter(deseq.bbl.data.combined, abs(log2FoldChange) >= 1.5 & padj < 0.05)

  return(deseq.bbl.data.combined)
}
plot_dgea <- function(deseq.bbl.data.combined) {
  sizes <- c("<10^-15" = 4, "10^-10" = 3, "10^-5" = 2, "0.05" = 1)

  deseq.bbl.data.combined <- deseq.bbl.data.combined %>%
    mutate(fdr_category = cut(padj,
      breaks = c(-Inf, 1e-15, 1e-10, 1e-5, 0.05),
      labels = c("<10^-15", "10^-10", "10^-5", "0.05"),
      right = FALSE
    ))

  top_genes <- deseq.bbl.data.combined %>%
    group_by(cancer_type) %>%
    mutate(rank = rank(-abs(log2FoldChange))) %>%
    dplyr::filter(rank <= 10) %>%
    ungroup()

  ggplot(top_genes, aes(y = cancer_type, x = gene_symbol, size = fdr_category, fill = log2FoldChange)) +
    geom_point(alpha = 0.5, shape = 21, color = "black") +
    scale_size_manual(values = sizes) +
    scale_fill_gradient2(low = "blue", mid = "white", high = "red", limits = c(min(deseq.bbl.data.combined$log2FoldChange), max(deseq.bbl.data.combined$log2FoldChange))) +
    theme_minimal() +
    theme(
      axis.text.x = element_text(size = 9, angle = 90, hjust = 1)
    ) +
    theme(legend.position = "bottom") +
    theme(legend.position = "bottom") +
    labs(size = "Adjusted p-value", fill = "log2 FC", y = "Cancer type", x = "Gene")
}
perform_vsd <- function(genes) {
  tcga_rcd <- list()

  for (project in projects) {
    rownames(genes) <- genes$gene_id
    tcga_rcd[[project]] <- tcga_matrix[[project]][rownames(tcga_matrix[[project]]) %in% genes$gene_id, ]
    tcga_rcd[[project]] <- tcga_rcd[[project]][, rownames(samples[[project]])]
  }

  vsd_rcd <- list()

  for (project in projects) {
    print(project)
    print("=============")
    dds <- DESeqDataSetFromMatrix(
      countData = tcga_rcd[[project]],
      colData = samples[[project]],
      design = ~type
    )
    dds <- filter_genes(dds, min_count = 10)

    # Perform variance stabilization
    dds <- estimateSizeFactors(dds)
    nsub <- sum(rowMeans(counts(dds, normalized = TRUE)) > 10)
    vsd <- vst(dds, nsub = nsub)
    vsd_rcd[[project]] <- assay(vsd)
  }

  return(vsd_rcd)
}

Ferroptosis

Fetch the gene set of interest.

genes <- read.csv(paste0(RCDdb, "Ferroptosis.csv"))
print(genes)
genes$gene_id <- cleanid(genes$gene_id)
genes <- distinct(genes, gene_id, .keep_all = TRUE)
genes <- subset(genes, gene_id != "")
genes

Filter the genes to include only those in the gene set of interest, and then perform differential gene expression analysis.

deseq.bbl.data.combined <- filter_gene_set_and_perform_dgea(genes)
[1] "TCGA-COAD"
[1] "============="
Warning: some variables in design formula are characters, converting to factorsestimating size factors
estimating dispersions
gene-wise dispersion estimates
mean-dispersion relationship
final dispersion estimates
fitting model and testing
-- replacing outliers and refitting for 21 genes
-- DESeq argument 'minReplicatesForReplace' = 7 
-- original counts are preserved in counts(dds)
estimating dispersions
fitting model and testing
deseq.bbl.data.combined

Plot the results.

plot_dgea(deseq.bbl.data.combined)

Perform variance-stabilizing transformation for further downstream analysis (i.e., for survival analysis).

vsd <- perform_vsd(genes)
[1] "TCGA-COAD"
[1] "============="

V. Downloading the clinical data

Download clinical data from TCGA, and perform some preprocessing: - The deceased column should be FALSE if the patient is alive and TRUE otherwise - The overall_survival column should reflect the follow-up time if the patient is alive and the days to death otherwise

download_clinical_data <- function(project) {
  clinical_data <- GDCquery_clinic(project)
  clinical_data$deceased <- ifelse(clinical_data$vital_status == "Alive", FALSE, TRUE)
  clinical_data$overall_survival <- ifelse(clinical_data$vital_status == "Alive",
    clinical_data$days_to_last_follow_up,
    clinical_data$days_to_death
  )

  return(clinical_data)
}
tcga_clinical <- list()
for (project in projects) {
  tcga_clinical[[project]] <- download_clinical_data(project)
}

VI. Performing survival analysis

Write utility functions for performing survival analysis.

construct_gene_df <- function(gene_of_interest, project) {
  normal_df <- tcga_matrix[[project]] %>%
    as.data.frame() %>%
    rownames_to_column(var = "gene_id") %>%
    gather(key = "case_id", value = "counts", -gene_id) %>%
    left_join(., genes, by = "gene_id") %>%
    dplyr::filter(gene == gene_of_interest) %>%
    dplyr::filter(case_id %in% rownames(samples[[project]] %>% dplyr::filter(type == "normal")))
  normal_df$case_id <- paste0(sapply(strsplit(as.character(normal_df$case_id), "-"), `[`, 1), '-',
                            sapply(strsplit(as.character(normal_df$case_id), "-"), `[`, 2), '-', 
                            sapply(strsplit(as.character(normal_df$case_id), "-"), `[`, 3))
  
  tumor_df <- tcga_matrix[[project]] %>%
      as.data.frame() %>%
      rownames_to_column(var = "gene_id") %>%
      gather(key = "case_id", value = "counts", -gene_id) %>%
      left_join(., genes, by = "gene_id") %>%
      dplyr::filter(gene == gene_of_interest) %>%
      dplyr::filter(case_id %in% rownames(samples[[project]] %>% dplyr::filter(type == "tumor")))
  tumor_df$case_id <- paste0(sapply(strsplit(as.character(tumor_df$case_id), "-"), `[`, 1), '-',
                            sapply(strsplit(as.character(tumor_df$case_id), "-"), `[`, 2), '-', 
                            sapply(strsplit(as.character(tumor_df$case_id), "-"), `[`, 3))
  
  gene_df <- inner_join(normal_df, tumor_df, by = c("gene_id", "case_id", "deathtype", "gene", "description", "gene_biotype", "pmid", "comment"))
  gene_df$log_fold = log2(gene_df$counts.y / gene_df$counts.x)
  
  gene_df$strata <- ifelse(abs(gene_df$log_fold) >= 1.5, "HIGH", "LOW")
  gene_df <- merge(gene_df, tcga_clinical[[project]], by.x = "case_id", by.y = "submitter_id")
  
  return(gene_df)
}
compute_surival_fit <- function(gene_df) {
  return (survfit(Surv(overall_survival, deceased) ~ strata, data = gene_df))
}
compute_cox <- function(gene_df) {
  return (coxph(Surv(overall_survival, deceased) ~ strata, data=gene_df))
}
plot_survival <- function(fit) {
  return(ggsurvplot(fit,
    data = gene_df,
    pval = T,
    risk.table = T,
    risk.table.height = 0.3
  ))
}
compute_survival_diff <- function(gene_df) {
  return(survdiff(Surv(overall_survival, deceased) ~ strata, data = gene_df))
}

Perform survival analysis by testing for the difference in the Kaplan-Meier curves using the G-rho family of Harrington and Fleming tests: https://rdrr.io/cran/survival/man/survdiff.html

Our genes of interest are the differentially expressed genes.

significant_projects <- c()
significant_genes <- c()

ctr <- 1
for (project in projects) {
  for (gene in c(genes$gene)) {
    cat(project, gene, "\n\n")
    error <- tryCatch (
      {
        gene_df <- construct_gene_df(gene, project)
      },
      error = function(e) {
        cat("\n\n============================\n\n")
        e
      }
    )
    
    if(inherits(error, "error")) next

    if (nrow(gene_df) > 0) {
      tryCatch (
        {
          fit <- compute_surival_fit(gene_df)
          survival <- compute_survival_diff(gene_df)
          cox <- compute_cox(gene_df)
          print(ctr)
          ctr <- ctr + 1
          print(survival)
          cat("\n")
          print(cox)
          print(plot_survival(fit))
          if (pchisq(survival$chisq, length(survival$n)-1, lower.tail = FALSE) < 0.05) {
            significant_projects <- c(significant_projects, project)
            significant_genes <- c(significant_genes, gene)
          }
        },
        error = function(e) {
        }
      )
      
    }
    
    cat("\n\n============================\n\n")
  }
}
TCGA-COAD MIR212 



============================

TCGA-COAD NR5A2 

[1] 1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.51     0.217       1.9
strata=LOW  3        3     1.49     1.535       1.9

 Chisq= 1.9  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.9773    2.6573   0.7360 1.328 0.184

Likelihood ratio test=1.58  on 1 df, p=0.2084
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TFAM 

[1] 2
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CREB5 

[1] 3
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     4.43     0.463     0.894
strata=LOW  9        9     7.57     0.272     0.894

 Chisq= 0.9  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.7314    2.0779   0.7898 0.926 0.354

Likelihood ratio test=0.99  on 1 df, p=0.3208
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NOS2 

[1] 4
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     6.64    0.0191    0.0474
strata=LOW  5        5     5.36    0.0237    0.0474

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1335    0.8751   0.6132 -0.218 0.828

Likelihood ratio test=0.05  on 1 df, p=0.8274
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HULC  

[1] 5
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.39     0.157      0.21
strata=LOW  9        9     9.61     0.039      0.21

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3178    0.7277   0.6969 -0.456 0.648

Likelihood ratio test=0.2  on 1 df, p=0.6554
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PLXNB2 

[1] 6
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.44     1.697      2.26
strata=LOW  9        9    10.56     0.231      2.26

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.1758    0.3086   0.8255 -1.424 0.154

Likelihood ratio test=1.93  on 1 df, p=0.1648
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KIF20A 

[1] 7
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     7.28    0.0107    0.0321
strata=LOW  5        5     4.72    0.0166    0.0321

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1146    1.1214   0.6399 0.179 0.858

Likelihood ratio test=0.03  on 1 df, p=0.8579
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TIMP1 

[1] 8
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.38    0.0175    0.0647
strata=LOW  4        4     3.62    0.0405    0.0647

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1656    1.1802   0.6519 0.254 0.799

Likelihood ratio test=0.06  on 1 df, p=0.8006
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR615 



============================

TCGA-COAD MIR93 

[1] 9
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.17    0.1643     0.291
strata=LOW  7        7     7.83    0.0876     0.291

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3455    0.7079   0.6432 -0.537 0.591

Likelihood ratio test=0.29  on 1 df, p=0.5919
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ENO3 

[1] 10
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.785     1.883      2.25
strata=LOW  10       10   11.215     0.132      2.25

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -1.2922    0.2747   0.9204 -1.404 0.16

Likelihood ratio test=1.72  on 1 df, p=0.1895
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MMD 

[1] 11
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NQO1 

[1] 12
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     2.76      3.81      6.07
strata=LOW  6        6     9.24      1.14      6.07

 Chisq= 6.1  on 1 degrees of freedom, p= 0.01 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.8171    0.1625   0.8307 -2.187 0.0287

Likelihood ratio test=5.72  on 1 df, p=0.01675
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MARCHF5 

[1] 13
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD JUN 

[1] 14
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.46     0.968      1.44
strata=LOW  8        8     9.54     0.249      1.44

 Chisq= 1.4  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8422    0.4307   0.7212 -1.168 0.243

Likelihood ratio test=1.33  on 1 df, p=0.2486
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALDH3A2 

[1] 15
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALOX5 

[1] 16
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     7.04     0.153     0.439
strata=LOW  6        6     4.96     0.217     0.439

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4287    1.5352   0.6519 0.658 0.511

Likelihood ratio test=0.44  on 1 df, p=0.5064
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP9 

[1] 17
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     4.58     0.543      1.06
strata=LOW  9        9     7.42     0.335      1.06

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.7950    2.2144   0.7905 1.006 0.315

Likelihood ratio test=1.17  on 1 df, p=0.2785
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GLRX5 

[1] 18
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD METTL14 

[1] 19
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TOR2A 

[1] 20
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.16    0.6013     0.752
strata=LOW  10       10    10.84    0.0646     0.752

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7387    0.4777   0.8710 -0.848 0.396

Likelihood ratio test=0.65  on 1 df, p=0.4188
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP14 

[1] 21
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR130B 



============================

TCGA-COAD CERS6-AS1 

[1] 22
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     5.95     0.151     0.398
strata=LOW  7        7     6.05     0.149     0.398

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4442    1.5592   0.7087 0.627 0.531

Likelihood ratio test=0.41  on 1 df, p=0.5206
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NFS1 

[1] 23
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.18    0.3054     0.429
strata=LOW  9        9     9.82    0.0679     0.429

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4797    0.6190   0.7394 -0.649 0.516

Likelihood ratio test=0.4  on 1 df, p=0.5259
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC3A2 

[1] 24
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.38     1.911      2.34
strata=LOW  9        9    10.62     0.248      2.34

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -1.0779    0.3403   0.7381 -1.46 0.144

Likelihood ratio test=1.89  on 1 df, p=0.1692
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ZFAS1 

[1] 25
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     4.81     0.997      1.97
strata=LOW  5        5     7.19     0.667      1.97

 Chisq= 2  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9480    0.3875   0.6984 -1.357 0.175

Likelihood ratio test=2.02  on 1 df, p=0.1555
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PANX1 

[1] 26
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HSPB1 

[1] 27
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.97     0.188     0.378
strata=LOW  8        8     7.03     0.133     0.378

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)    z     p
strataLOW 0.4177    1.5184   0.6844 0.61 0.542

Likelihood ratio test=0.39  on 1 df, p=0.5303
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CREB1 

[1] 28
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EZH2 

[1] 29
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.94  0.000692   0.00153
strata=LOW  6        6     6.06  0.000678   0.00153

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.02384   0.97645  0.60945 -0.039 0.969

Likelihood ratio test=0  on 1 df, p=0.9688
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC40A1 

[1] 30
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PAQR3 

[1] 31
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR545 



============================

TCGA-COAD MIR6077 



============================

TCGA-COAD MIR424 



============================

TCGA-COAD NOX5 

[1] 32
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.34     2.065      2.69
strata=LOW  9        9    10.66     0.259      2.69

 Chisq= 2.7  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.2666    0.2818   0.8236 -1.538 0.124

Likelihood ratio test=2.23  on 1 df, p=0.1354
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DHODH 

[1] 33
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PTPN18 

[1] 34
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IARS1 

[1] 35
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     0.66     2.724      3.29
strata=LOW  10       10    11.34     0.158      3.29

 Chisq= 3.3  on 1 degrees of freedom, p= 0.07 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -1.6435    0.1933   1.0086 -1.63 0.103

Likelihood ratio test=2.41  on 1 df, p=0.1203
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IL4R 

[1] 36
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SENP1 

[1] 37
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA16 



============================

TCGA-COAD SOX2 

[1] 38
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    10.79    0.0585     0.637
strata=LOW   2        2     1.21    0.5241     0.637

 Chisq= 0.6  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.6592    1.9333   0.8406 0.784 0.433

Likelihood ratio test=0.55  on 1 df, p=0.4563
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LIFR 

[1] 39
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11   11.726    0.0449      2.12
strata=LOW   1        1    0.274    1.9207      2.12

 Chisq= 2.1  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z    p
strataLOW 1.605     4.978    1.226 1.309 0.19

Likelihood ratio test=1.35  on 1 df, p=0.2452
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR199A2 



============================

TCGA-COAD COX4I2 

[1] 40
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3      1.5     1.487      1.92
strata=LOW  9        9     10.5     0.213      1.92

 Chisq= 1.9  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0230    0.3595   0.7706 -1.328 0.184

Likelihood ratio test=1.62  on 1 df, p=0.2028
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATF2 

[1] 41
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ABCC5 

[1] 42
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.72     0.444     0.702
strata=LOW  7        7     8.28     0.199     0.702

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.5160    0.5969   0.6218 -0.83 0.407

Likelihood ratio test=0.67  on 1 df, p=0.4118
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CCDC6 

[1] 43
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.35    0.0276      0.05
strata=LOW  8        8     7.65    0.0157      0.05

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1459    1.1571   0.6533 0.223 0.823

Likelihood ratio test=0.05  on 1 df, p=0.8225
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD OTUB1 



============================

TCGA-COAD ALOXE3 

[1] 44
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.99      0.36      4.79
strata=LOW  3        3     1.01      3.91      4.79

 Chisq= 4.8  on 1 degrees of freedom, p= 0.03 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z      p
strataLOW 1.635     5.130    0.828 1.975 0.0483

Likelihood ratio test=3.55  on 1 df, p=0.05946
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SCP2 

[1] 45
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PHKG2 

[1] 46
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MTDH 

[1] 47
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACO1 

[1] 48
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR137 



============================

TCGA-COAD OIP5-AS1 

[1] 49
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR494 



============================

TCGA-COAD MLLT1 

[1] 50
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR19B1 



============================

TCGA-COAD RPTOR 

[1] 51
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GCH1 

[1] 52
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.16    0.2235     0.332
strata=LOW  8        8     8.84    0.0799     0.332

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3738    0.6881   0.6519 -0.573 0.566

Likelihood ratio test=0.32  on 1 df, p=0.5719
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP16 

[1] 53
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR9-3 



============================

TCGA-COAD CISD3 

[1] 54
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     5.18     0.269     0.525
strata=LOW  8        8     6.82     0.204     0.525

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4584    1.5815   0.6373 0.719 0.472

Likelihood ratio test=0.53  on 1 df, p=0.4649
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD USP35 

[1] 55
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.274    1.9207      2.12
strata=LOW  11       11   11.726    0.0449      2.12

 Chisq= 2.1  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -1.6050    0.2009   1.2257 -1.309 0.19

Likelihood ratio test=1.35  on 1 df, p=0.2452
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRKAA1 

[1] 56
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAPK14 

[1] 57
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GRIA3 

[1] 58
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.32     0.169      1.34
strata=LOW  3        3     1.68     1.038      1.34

 Chisq= 1.3  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z    p
strataLOW 0.8359    2.3069   0.7415 1.127 0.26

Likelihood ratio test=1.17  on 1 df, p=0.2804
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KDM5C 

[1] 59
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3      2.2    0.2932     0.391
strata=LOW  9        9      9.8    0.0657     0.391

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4411    0.6433   0.7109 -0.621 0.535

Likelihood ratio test=0.36  on 1 df, p=0.5458
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DECR1 

[1] 60
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD VCP 

[1] 61
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR129-1 



============================

TCGA-COAD PARP10 

[1] 62
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     3.76     0.821      1.57
strata=LOW  10       10     8.24     0.374      1.57

 Chisq= 1.6  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z     p
strataLOW 1.253     3.501    1.063 1.179 0.238

Likelihood ratio test=1.91  on 1 df, p=0.1666
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ULK2 

[1] 63
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CISD1 

[1] 64
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR147A 



============================

TCGA-COAD BBOX1-AS1 



============================

TCGA-COAD RB1 

[1] 65
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TTPA 

[1] 66
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9   11.041     0.377      5.53
strata=LOW  3        3    0.959     4.345      5.53

 Chisq= 5.5  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.9221    6.8355   0.9345 2.057 0.0397

Likelihood ratio test=4.19  on 1 df, p=0.04074
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDC25A 

[1] 67
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.52    0.0591     0.114
strata=LOW  8        8     7.48    0.0357     0.114

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2313    1.2602   0.6850 0.338 0.736

Likelihood ratio test=0.12  on 1 df, p=0.7315
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PCAT1 

[1] 68
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.64     0.326     0.687
strata=LOW  5        5     6.36     0.289     0.687

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.5200    0.5945   0.6341 -0.82 0.412

Likelihood ratio test=0.7  on 1 df, p=0.4039
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DAZAP1 

[1] 69
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEX2 

[1] 70
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR124-3 



============================

TCGA-COAD TRIM21 

[1] 71
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MEG3 

[1] 72
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     4.92     0.879      1.73
strata=LOW  5        5     7.08     0.611      1.73

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8428    0.4305   0.6551 -1.286 0.198

Likelihood ratio test=1.73  on 1 df, p=0.1881
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GCLC 

[1] 73
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IDH2 

[1] 74
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1      3.1     1.425      2.88
strata=LOW  11       11      8.9     0.497      2.88

 Chisq= 2.9  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

               coef exp(coef)  se(coef)     z     p
strataLOW 1.955e+01 3.092e+08 1.012e+04 0.002 0.998

Likelihood ratio test=4.97  on 1 df, p=0.02579
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FNDC5 

[1] 75
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6      6.5    0.0388     0.105
strata=LOW  6        6      5.5    0.0459     0.105

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2125    1.2367   0.6559 0.324 0.746

Likelihood ratio test=0.11  on 1 df, p=0.7445
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FANCD2 

[1] 76
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     1.83     2.571      3.53
strata=LOW  8        8    10.17     0.463      3.53

 Chisq= 3.5  on 1 degrees of freedom, p= 0.06 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.3488    0.2595   0.7711 -1.749 0.0803

Likelihood ratio test=3.04  on 1 df, p=0.08138
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LCN2 

[1] 77
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     7.61    0.0487     0.143
strata=LOW  5        5     4.39    0.0843     0.143

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2314    1.2604   0.6124 0.378 0.705

Likelihood ratio test=0.14  on 1 df, p=0.7067
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TFR2 

[1] 78
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.55    0.0353     0.135
strata=LOW  4        4     3.45    0.0875     0.135

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2379    1.2686   0.6490 0.367 0.714

Likelihood ratio test=0.13  on 1 df, p=0.7164
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP12 

[1] 79
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.16     1.573      2.32
strata=LOW  8        8     9.84     0.345      2.32

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.1242    0.3249   0.7750 -1.451 0.147

Likelihood ratio test=2.12  on 1 df, p=0.1459
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NR1D1 

[1] 80
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     0.66     2.724      3.29
strata=LOW  10       10    11.34     0.158      3.29

 Chisq= 3.3  on 1 degrees of freedom, p= 0.07 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -1.6435    0.1933   1.0086 -1.63 0.103

Likelihood ratio test=2.41  on 1 df, p=0.1203
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATG13 

[1] 81
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TMSB4X 

[1] 82
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.33     0.337      0.42
strata=LOW  10       10    10.67     0.042      0.42

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.5382    0.5838   0.8408 -0.64 0.522

Likelihood ratio test=0.38  on 1 df, p=0.5391
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDK14 

[1] 83
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RP1-228H13.5 

[1] 84
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.12     0.857      1.63
strata=LOW  6        6     7.88     0.448      1.63

 Chisq= 1.6  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8912    0.4102   0.7192 -1.239 0.215

Likelihood ratio test=1.64  on 1 df, p=0.1999
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NOX3 



============================

TCGA-COAD IFNA17 



============================

TCGA-COAD ALOX12B 

[1] 85
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7        4      2.26      4.42
strata=LOW  5        5        8      1.13      4.42

 Chisq= 4.4  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.6134    0.1992   0.8327 -1.938 0.0527

Likelihood ratio test=4.57  on 1 df, p=0.03252
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PGRMC1 

[1] 86
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.61    0.0336    0.0654
strata=LOW  7        7     7.39    0.0209    0.0654

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1657    0.8473   0.6483 -0.256 0.798

Likelihood ratio test=0.07  on 1 df, p=0.7984
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ULK1 

[1] 87
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.16    0.6013     0.752
strata=LOW  10       10    10.84    0.0646     0.752

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7387    0.4777   0.8710 -0.848 0.396

Likelihood ratio test=0.65  on 1 df, p=0.4188
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TRIM26 

[1] 88
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD QSOX1 

[1] 89
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.55    0.0656     0.124
strata=LOW  8        8     7.45    0.0400     0.124

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2309    1.2598   0.6561 0.352 0.725

Likelihood ratio test=0.13  on 1 df, p=0.7232
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATM 

[1] 90
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.96  0.000216  0.000481
strata=LOW  6        6     6.04  0.000213  0.000481

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.01342   0.98667  0.61161 -0.022 0.982

Likelihood ratio test=0  on 1 df, p=0.9825
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIB2 

[1] 91
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.92  0.003076   0.00395
strata=LOW  10       10    10.08  0.000587   0.00395

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z    p
strataLOW -0.05061   0.95065  0.80554 -0.063 0.95

Likelihood ratio test=0  on 1 df, p=0.9501
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC1A5 

[1] 92
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5      2.2     3.543      5.05
strata=LOW  7        7      9.8     0.798      5.05

 Chisq= 5  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.5318    0.2162   0.7433 -2.061 0.0393

Likelihood ratio test=4.39  on 1 df, p=0.03613
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR2115 



============================

TCGA-COAD LINC00336 

[1] 93
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     7.13     0.636       1.9
strata=LOW  7        7     4.87     0.931       1.9

 Chisq= 1.9  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.9382    2.5553   0.7034 1.334 0.182

Likelihood ratio test=1.94  on 1 df, p=0.1634
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NDRG1 

[1] 94
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.43     0.721      1.21
strata=LOW  7        7     8.57     0.288      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7401    0.4771   0.6864 -1.078 0.281

Likelihood ratio test=1.17  on 1 df, p=0.2792
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TAFAZZIN 

[1] 95
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     4.21     0.346     0.667
strata=LOW  9        9     7.79     0.187     0.667

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.6385    1.8936   0.7940 0.804 0.421

Likelihood ratio test=0.73  on 1 df, p=0.3931
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR135B 



============================

TCGA-COAD GLS2 

[1] 96
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.88     0.212     0.538
strata=LOW  5        5     6.12     0.204     0.538

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5121    0.5992   0.7050 -0.726 0.468

Likelihood ratio test=0.56  on 1 df, p=0.4548
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HELLS 

[1] 97
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.93  0.000886   0.00178
strata=LOW  7        7     7.07  0.000619   0.00178

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.02681   0.97355  0.63562 -0.042 0.966

Likelihood ratio test=0  on 1 df, p=0.9664
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KLF2 

[1] 98
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.53    0.0629     0.112
strata=LOW  8        8     7.47    0.0382     0.112

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2139    1.2385   0.6409 0.334 0.739

Likelihood ratio test=0.11  on 1 df, p=0.7364
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TFAP2A 

[1] 99
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.47    0.0265     0.101
strata=LOW  4        4     3.53    0.0636     0.101

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2067    1.2297   0.6531 0.317 0.752

Likelihood ratio test=0.1  on 1 df, p=0.7533
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FURIN 

[1] 100
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.25    0.1714     0.278
strata=LOW  8        8     8.75    0.0637     0.278

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z   p
strataLOW -0.3590    0.6984   0.6840 -0.525 0.6

Likelihood ratio test=0.27  on 1 df, p=0.6027
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDH1 

[1] 101
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     6.23     0.500      1.41
strata=LOW  4        4     5.77     0.541      1.41

 Chisq= 1.4  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9351    0.3926   0.8119 -1.152 0.249

Likelihood ratio test=1.55  on 1 df, p=0.2134
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR6852 



============================

TCGA-COAD MIR670 



============================

TCGA-COAD TYRO3 

[1] 102
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.76    0.1531      0.24
strata=LOW  9        9     8.24    0.0698      0.24

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3355    1.3986   0.6873 0.488 0.625

Likelihood ratio test=0.25  on 1 df, p=0.6176
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR4715 



============================

TCGA-COAD ABHD12 

[1] 103
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.18    0.3054     0.429
strata=LOW  9        9     9.82    0.0679     0.429

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4797    0.6190   0.7394 -0.649 0.516

Likelihood ratio test=0.4  on 1 df, p=0.5259
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATG7 

[1] 104
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MT1G 



============================

TCGA-COAD SAT1 

[1] 105
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.41     1.780      2.25
strata=LOW  9        9    10.59     0.238      2.25

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0995    0.3330   0.7692 -1.429 0.153

Likelihood ratio test=1.86  on 1 df, p=0.1723
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR182 



============================

TCGA-COAD HOTAIR 

[1] 106
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=9, 37 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8    8.764    0.0666       2.8
strata=LOW  1        1    0.236    2.4714       2.8

 Chisq= 2.8  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z     p
strataLOW 2.013     7.483    1.415 1.422 0.155

Likelihood ratio test=1.75  on 1 df, p=0.1855
n= 9, number of events= 9 
   (37 observations deleted due to missingness)


============================

TCGA-COAD PIR 

[1] 107
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.49     0.103     0.153
strata=LOW  9        9     9.51     0.027     0.153

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.2882    0.7496   0.7390 -0.39 0.697

Likelihood ratio test=0.15  on 1 df, p=0.7002
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ELAVL1 

[1] 108
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACADSB 

[1] 109
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NCOA4 

[1] 110
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA10 



============================

TCGA-COAD IFNA13 



============================

TCGA-COAD MIR9-2 



============================

TCGA-COAD RRM2 

[1] 111
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5      4.9   0.00195   0.00392
strata=LOW  7        7      7.1   0.00135   0.00392

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z    p
strataLOW -0.03987   0.96091  0.63660 -0.063 0.95

Likelihood ratio test=0  on 1 df, p=0.9501
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EPSTI1 

[1] 112
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     6.76     0.460      1.28
strata=LOW  7        7     5.24     0.593      1.28

 Chisq= 1.3  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.7757    2.1722   0.7001 1.108 0.268

Likelihood ratio test=1.33  on 1 df, p=0.249
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00551 

[1] 113
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.86     0.336      0.57
strata=LOW  7        7     8.14     0.159      0.57

 Chisq= 0.6  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4847    0.6159   0.6474 -0.749 0.454

Likelihood ratio test=0.56  on 1 df, p=0.4557
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC25A28 

[1] 114
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00973 



============================

TCGA-COAD MIR378A 

[1] 115
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=11, 35 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     7.87   0.00226   0.00889
strata=LOW  3        3     3.13   0.00568   0.00889

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.06729   0.93492  0.71388 -0.094 0.925

Likelihood ratio test=0.01  on 1 df, p=0.9246
n= 11, number of events= 11 
   (35 observations deleted due to missingness)


============================

TCGA-COAD MGST1 

[1] 116
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.25    0.1728      0.26
strata=LOW  8        8     8.75    0.0642      0.26

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3311    0.7181   0.6517 -0.508 0.611

Likelihood ratio test=0.25  on 1 df, p=0.6158
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIB1 

[1] 117
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SRC 

[1] 118
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.27   0.02179    0.0321
strata=LOW  9        9     8.73   0.00815    0.0321

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1234    1.1313   0.6889 0.179 0.858

Likelihood ratio test=0.03  on 1 df, p=0.8566
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATG5 

[1] 119
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACVR1B 

[1] 120
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.79   0.01202    0.0197
strata=LOW  8        8     8.21   0.00554    0.0197

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)     z     p
strataLOW -0.09154   0.91253  0.65196 -0.14 0.888

Likelihood ratio test=0.02  on 1 df, p=0.8887
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NT5DC2 

[1] 121
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.89    0.2027     0.387
strata=LOW  9        9     8.11    0.0972     0.387

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4909    1.6338   0.7964 0.616 0.538

Likelihood ratio test=0.42  on 1 df, p=0.5183
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PIK3CA 

[1] 122
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NUPR1 

[1] 123
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.41     1.780      2.25
strata=LOW  9        9    10.59     0.238      2.25

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0995    0.3330   0.7692 -1.429 0.153

Likelihood ratio test=1.86  on 1 df, p=0.1723
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AKT1S1 

[1] 124
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR19A 



============================

TCGA-COAD USP7 

[1] 125
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.77     0.549     0.855
strata=LOW  8        8     9.23     0.165     0.855

 Chisq= 0.9  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6504    0.5218   0.7152 -0.909 0.363

Likelihood ratio test=0.81  on 1 df, p=0.3668
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TMSB4Y 

[1] 126
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=8, 38 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.09   0.00190   0.00472
strata=LOW  4        4     3.91   0.00198   0.00472

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.05336   1.05481  0.77685 0.069 0.945

Likelihood ratio test=0  on 1 df, p=0.9453
n= 8, number of events= 8 
   (38 observations deleted due to missingness)


============================

TCGA-COAD SIAH2 

[1] 127
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR29A 



============================

TCGA-COAD CHAC1 

[1] 128
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.26    0.1299     0.254
strata=LOW  7        7     7.74    0.0714     0.254

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3241    0.7232   0.6453 -0.502 0.616

Likelihood ratio test=0.24  on 1 df, p=0.6207
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00616 



============================

TCGA-COAD PRKAA2 

[1] 129
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11   11.826    0.0577      4.29
strata=LOW   1        1    0.174    3.9134      4.29

 Chisq= 4.3  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW  2.350    10.488    1.415 1.661 0.0966

Likelihood ratio test=2.29  on 1 df, p=0.1301
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LONP1 

[1] 130
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PPARG 

[1] 131
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.96     0.182     0.475
strata=LOW  5        5     6.04     0.179     0.475

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4841    0.6163   0.7084 -0.683 0.494

Likelihood ratio test=0.49  on 1 df, p=0.4829
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAPK1 

[1] 132
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEX6 

[1] 133
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     4.36     0.424     0.745
strata=LOW  9        9     7.64     0.242     0.745

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.5930    1.8094   0.6956 0.852 0.394

Likelihood ratio test=0.78  on 1 df, p=0.3766
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PPARA 

[1] 134
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACSL4 

[1] 135
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.85     0.148      0.27
strata=LOW  8        8     7.15     0.100      0.27

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3282    1.3885   0.6338 0.518 0.605

Likelihood ratio test=0.27  on 1 df, p=0.6001
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ANO6 

[1] 136
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.66    0.0718    0.0888
strata=LOW  10       10    10.34    0.0115    0.0888

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2396    0.7869   0.8060 -0.297 0.766

Likelihood ratio test=0.08  on 1 df, p=0.7713
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD YTHDC2 

[1] 137
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.52    0.0509    0.0945
strata=LOW  7        7     7.48    0.0308    0.0945

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1958    0.8222   0.6379 -0.307 0.759

Likelihood ratio test=0.09  on 1 df, p=0.7591
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR103A1 



============================

TCGA-COAD INTS2 

[1] 138
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PTPN6 

[1] 139
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.25     2.465      3.14
strata=LOW  9        9    10.75     0.286      3.14

 Chisq= 3.1  on 1 degrees of freedom, p= 0.08 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.3546    0.2580   0.8225 -1.647 0.0996

Likelihood ratio test=2.54  on 1 df, p=0.1113
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SMAD7 

[1] 140
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     6.96     0.132     0.372
strata=LOW  6        6     5.04     0.183     0.372

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3740    1.4536   0.6162 0.607 0.544

Likelihood ratio test=0.36  on 1 df, p=0.547
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATG16L1 

[1] 141
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00976 

[1] 142
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     9.71   0.00865    0.0505
strata=LOW   2        2     2.29   0.03667    0.0505

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1822    0.8334   0.8118 -0.224 0.822

Likelihood ratio test=0.05  on 1 df, p=0.8196
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD H19 

[1] 143
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.09     1.180      1.78
strata=LOW  7        7     8.91     0.409      1.78

 Chisq= 1.8  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8409    0.4313   0.6475 -1.299 0.194

Likelihood ratio test=1.65  on 1 df, p=0.1996
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FADS1 

[1] 144
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     2.16     3.716      5.74
strata=LOW  7        7     9.84     0.818      5.74

 Chisq= 5.7  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.8615    0.1554   0.8684 -2.144 0.0321

Likelihood ratio test=5.23  on 1 df, p=0.0222
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CHP1 

[1] 145
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.03     0.187     0.386
strata=LOW  6        6     6.97     0.135     0.386

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4035    0.6680   0.6539 -0.617 0.537

Likelihood ratio test=0.39  on 1 df, p=0.5331
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRR5 

[1] 146
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.01      3.91      4.79
strata=LOW  9        9    10.99      0.36      4.79

 Chisq= 4.8  on 1 degrees of freedom, p= 0.03 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.6350    0.1949   0.8280 -1.975 0.0483

Likelihood ratio test=3.55  on 1 df, p=0.05946
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CFL1 

[1] 147
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR382 



============================

TCGA-COAD LAMP2 

[1] 148
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.49     0.103     0.153
strata=LOW  9        9     9.51     0.027     0.153

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.2882    0.7496   0.7390 -0.39 0.697

Likelihood ratio test=0.15  on 1 df, p=0.7002
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PTPN14 

[1] 149
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.56      1.34      1.74
strata=LOW  9        9    10.44      0.20      1.74

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9751    0.3771   0.7686 -1.269 0.205

Likelihood ratio test=1.49  on 1 df, p=0.2226
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AGPAT3 

[1] 150
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD STING1 

[1] 151
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ABCC1 

[1] 152
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.95     0.569     0.759
strata=LOW  9        9    10.05     0.110     0.759

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6303    0.5324   0.7350 -0.858 0.391

Likelihood ratio test=0.69  on 1 df, p=0.4063
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA5 



============================

TCGA-COAD MIR140 

[1] 153
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=5, 41 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.72     0.606      2.01
strata=LOW  1        1     2.28     0.721      2.01

 Chisq= 2  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.077e+01  9.533e-10  2.244e+04 -0.001 0.999

Likelihood ratio test=3.22  on 1 df, p=0.07279
n= 5, number of events= 5 
   (41 observations deleted due to missingness)


============================

TCGA-COAD MYB 

[1] 154
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.58     0.787      1.18
strata=LOW  8        8     9.42     0.215      1.18

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7602    0.4676   0.7151 -1.063 0.288

Likelihood ratio test=1.11  on 1 df, p=0.293
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA6 



============================

TCGA-COAD IFNA14 



============================

TCGA-COAD BDNF-AS 

[1] 155
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.35    0.0276      0.05
strata=LOW  8        8     7.65    0.0157      0.05

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1459    1.1571   0.6533 0.223 0.823

Likelihood ratio test=0.05  on 1 df, p=0.8225
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TRIB2 

[1] 156
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MALAT1 

[1] 157
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4        5     0.200     0.384
strata=LOW  8        8        7     0.143     0.384

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3948    1.4841   0.6408 0.616 0.538

Likelihood ratio test=0.39  on 1 df, p=0.532
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FH 

[1] 158
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEX10 

[1] 159
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SCD 

[1] 160
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.13     0.678      1.33
strata=LOW  5        5     6.87     0.507      1.33

 Chisq= 1.3  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7261    0.4838   0.6408 -1.133 0.257

Likelihood ratio test=1.34  on 1 df, p=0.2472
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FTL 

[1] 161
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     3.51      1.76      3.02
strata=LOW  6        6     8.49      0.73      3.02

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.1983    0.3017   0.7253 -1.652 0.0985

Likelihood ratio test=2.95  on 1 df, p=0.08612
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TSC1 

[1] 162
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.75     0.898      1.21
strata=LOW  9        9    10.25     0.153      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8222    0.4395   0.7688 -1.069 0.285

Likelihood ratio test=1.07  on 1 df, p=0.2998
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRD3 

[1] 163
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.04    0.8900      1.08
strata=LOW  10       10    10.96    0.0843      1.08

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8793    0.4151   0.8712 -1.009 0.313

Likelihood ratio test=0.91  on 1 df, p=0.3411
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC16A1 

[1] 164
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR132 



============================

TCGA-COAD MIR375 



============================

TCGA-COAD MIOX 

[1] 165
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     9.24    0.0619      0.29
strata=LOW   2        2     2.76    0.2076      0.29

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4271    0.6524   0.7980 -0.535 0.593

Likelihood ratio test=0.31  on 1 df, p=0.5771
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATXN8OS 



============================

TCGA-COAD KLHDC3 

[1] 166
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MICU1 

[1] 167
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CBS 

[1] 168
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.63    0.0246    0.0512
strata=LOW  6        6     6.37    0.0217    0.0512

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1381    0.8710   0.6106 -0.226 0.821

Likelihood ratio test=0.05  on 1 df, p=0.8208
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HUWE1 

[1] 169
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00472 

[1] 170
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    10.46    0.0199     0.164
strata=LOW   2        2     1.54    0.1346     0.164

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3259    1.3853   0.8074 0.404 0.686

Likelihood ratio test=0.15  on 1 df, p=0.6954
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FGF21 



============================

TCGA-COAD MIR34A 



============================

TCGA-COAD IDH1 

[1] 171
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.43    0.0735     0.135
strata=LOW  7        7     7.57    0.0430     0.135

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2339    0.7915   0.6389 -0.366 0.714

Likelihood ratio test=0.13  on 1 df, p=0.7146
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GSK3B 

[1] 172
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.75     0.898      1.21
strata=LOW  9        9    10.25     0.153      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8222    0.4395   0.7688 -1.069 0.285

Likelihood ratio test=1.07  on 1 df, p=0.2998
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KDM4A 

[1] 173
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.25    0.1714     0.278
strata=LOW  8        8     8.75    0.0637     0.278

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z   p
strataLOW -0.3590    0.6984   0.6840 -0.525 0.6

Likelihood ratio test=0.27  on 1 df, p=0.6027
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEX12 

[1] 174
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IDO1 

[1] 175
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8      7.1     0.114     0.315
strata=LOW  4        4      4.9     0.165     0.315

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3591    0.6983   0.6431 -0.558 0.577

Likelihood ratio test=0.32  on 1 df, p=0.5716
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BCAT2 

[1] 176
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ADAM23 

[1] 177
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.86   0.00315   0.00687
strata=LOW  6        6     6.14   0.00301   0.00687

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05068   0.95058  0.61129 -0.083 0.934

Likelihood ratio test=0.01  on 1 df, p=0.9339
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEX3 

[1] 178
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATP5MC3 

[1] 179
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AQP5 

[1] 180
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9     8.64    0.0151    0.0759
strata=LOW  3        3     3.36    0.0387    0.0759

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2228    0.8003   0.8103 -0.275 0.783

Likelihood ratio test=0.08  on 1 df, p=0.7789
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ADAMTS9-AS1 



============================

TCGA-COAD ACSL3 

[1] 181
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DDR2 

[1] 182
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    11.34     0.158      3.29
strata=LOW   2        2     0.66     2.724      3.29

 Chisq= 3.3  on 1 degrees of freedom, p= 0.07 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)    z     p
strataLOW 1.644     5.173    1.009 1.63 0.103

Likelihood ratio test=2.41  on 1 df, p=0.1203
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TERT 

[1] 183
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6      5.2    0.1218     0.235
strata=LOW  6        6      6.8    0.0933     0.235

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2945    0.7449   0.6101 -0.483 0.629

Likelihood ratio test=0.23  on 1 df, p=0.6284
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA7 



============================

TCGA-COAD ECH1 

[1] 184
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.87     0.155     0.289
strata=LOW  8        8     7.13     0.106     0.289

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3414    1.4069   0.6379 0.535 0.593

Likelihood ratio test=0.29  on 1 df, p=0.5878
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CS 

[1] 185
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AMN 

[1] 186
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.25   0.00781    0.0332
strata=LOW  4        4     3.75   0.01720    0.0332

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1270    1.1354   0.6978 0.182 0.856

Likelihood ratio test=0.03  on 1 df, p=0.8569
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DUOX2 

[1] 187
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     6.91     0.171     0.477
strata=LOW  4        4     5.09     0.232     0.477

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4704    0.6248   0.6872 -0.685 0.494

Likelihood ratio test=0.5  on 1 df, p=0.4805
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MBOAT1 

[1] 188
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RNF113A 

[1] 189
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.41    0.2517     0.307
strata=LOW  10       10    10.59    0.0334     0.307

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.4507    0.6372   0.8198 -0.55 0.583

Likelihood ratio test=0.28  on 1 df, p=0.597
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR138-1 



============================

TCGA-COAD MIR144 



============================

TCGA-COAD P4HB 

[1] 190
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR338 



============================

TCGA-COAD PTGS2 

[1] 191
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     7.98     0.492      1.67
strata=LOW  6        6     4.02     0.976      1.67

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)    z     p
strataLOW 0.824     2.280    0.654 1.26 0.208

Likelihood ratio test=1.63  on 1 df, p=0.2015
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ASAH2 

[1] 192
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     2.42    0.0739    0.0992
strata=LOW  10       10     9.58    0.0187    0.0992

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2503    1.2844   0.7967 0.314 0.753

Likelihood ratio test=0.1  on 1 df, p=0.7476
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR522 



============================

TCGA-COAD GALNT14 

[1] 193
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     6.02     0.173     0.388
strata=LOW  7        7     5.98     0.174     0.388

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3909    1.4783   0.6315 0.619 0.536

Likelihood ratio test=0.39  on 1 df, p=0.53
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KDM4C 

[1] 194
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.61    0.0336    0.0654
strata=LOW  7        7     7.39    0.0209    0.0654

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1657    0.8473   0.6483 -0.256 0.798

Likelihood ratio test=0.07  on 1 df, p=0.7984
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FXN 

[1] 195
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MEF2C 

[1] 196
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     7.13   0.00252   0.00733
strata=LOW  5        5     4.87   0.00369   0.00733

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.05427   1.05577  0.63414 0.086 0.932

Likelihood ratio test=0.01  on 1 df, p=0.932
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MDM2 

[1] 197
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.56      1.34      1.74
strata=LOW  9        9    10.44      0.20      1.74

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9751    0.3771   0.7686 -1.269 0.205

Likelihood ratio test=1.49  on 1 df, p=0.2226
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAP3K14 

[1] 198
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.16    0.6013     0.752
strata=LOW  10       10    10.84    0.0646     0.752

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7387    0.4777   0.8710 -0.848 0.396

Likelihood ratio test=0.65  on 1 df, p=0.4188
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MDM4 

[1] 199
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.35    0.1259     0.193
strata=LOW  8        8     8.65    0.0488     0.193

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2855    0.7516   0.6522 -0.438 0.662

Likelihood ratio test=0.19  on 1 df, p=0.6649
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ASMTL-AS1 

[1] 200
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.87     0.333     0.525
strata=LOW  7        7     8.13     0.158     0.525

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4408    0.6435   0.6131 -0.719 0.472

Likelihood ratio test=0.51  on 1 df, p=0.4766
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NEAT1 

[1] 201
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.11    0.2521     0.365
strata=LOW  8        8     8.89    0.0883     0.365

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)    z     p
strataLOW -0.3836    0.6814   0.6389 -0.6 0.548

Likelihood ratio test=0.35  on 1 df, p=0.5557
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD COPZ1 

[1] 202
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PLIN2 

[1] 203
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.62     0.721      1.09
strata=LOW  8        8     9.38     0.202      1.09

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7299    0.4820   0.7141 -1.022 0.307

Likelihood ratio test=1.02  on 1 df, p=0.3115
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FADS2 

[1] 204
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.44     1.002      1.37
strata=LOW  8        8     9.56     0.255      1.37

 Chisq= 1.4  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7593    0.4680   0.6616 -1.148 0.251

Likelihood ratio test=1.24  on 1 df, p=0.2662
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR7-1 



============================

TCGA-COAD TXN 

[1] 205
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR302A 



============================

TCGA-COAD EGLN2 

[1] 206
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.03  0.000310  0.000444
strata=LOW  9        9     8.97  0.000105  0.000444

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.01452   1.01462  0.68912 0.021 0.983

Likelihood ratio test=0  on 1 df, p=0.9832
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NCOA3 

[1] 207
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.28     0.905      1.59
strata=LOW  7        7     8.72     0.340      1.59

 Chisq= 1.6  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9139    0.4010   0.7472 -1.223 0.221

Likelihood ratio test=1.56  on 1 df, p=0.2112
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SREBF1 

[1] 208
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC01134 

[1] 209
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7      4.1      2.06      3.95
strata=LOW  5        5      7.9      1.07      3.95

 Chisq= 4  on 1 degrees of freedom, p= 0.05 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.5001    0.2231   0.8177 -1.835 0.0666

Likelihood ratio test=4.1  on 1 df, p=0.0428
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MYCN 

[1] 210
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1      2.1     0.579     0.791
strata=LOW  11       11      9.9     0.123     0.791

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.9341    2.5449   1.0824 0.863 0.388

Likelihood ratio test=0.93  on 1 df, p=0.3348
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IFNA4 



============================

TCGA-COAD DPEP1 

[1] 211
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11    10.73   0.00679    0.0683
strata=LOW   1        1     1.27   0.05735    0.0683

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2790    0.7565   1.0707 -0.261 0.794

Likelihood ratio test=0.07  on 1 df, p=0.7873
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD VDAC2 

[1] 212
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PCBP2-OT1 

[1] 213
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=9, 37 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.25     0.108     0.326
strata=LOW  3        3     3.75     0.151     0.326

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4689    0.6257   0.8285 -0.566 0.571

Likelihood ratio test=0.34  on 1 df, p=0.5582
n= 9, number of events= 9 
   (37 observations deleted due to missingness)


============================

TCGA-COAD KEAP1 

[1] 214
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RPL8 

[1] 215
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     1.27   0.05735    0.0683
strata=LOW  11       11    10.73   0.00679    0.0683

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z     p
strataLOW 0.279     1.322    1.071 0.261 0.794

Likelihood ratio test=0.07  on 1 df, p=0.7873
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALOX12 

[1] 216
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACSF2 

[1] 217
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     6.25    0.0901     0.214
strata=LOW  5        5     5.75    0.0980     0.214

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2930    0.7461   0.6349 -0.461 0.644

Likelihood ratio test=0.22  on 1 df, p=0.6407
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KDM5A 

[1] 218
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NRAS 

[1] 219
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.16    0.2235     0.332
strata=LOW  8        8     8.84    0.0799     0.332

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.3738    0.6881   0.6519 -0.573 0.566

Likelihood ratio test=0.32  on 1 df, p=0.5719
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR30E 



============================

TCGA-COAD OGFRP1 

[1] 220
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.66    0.0934     0.183
strata=LOW  8        8     7.34    0.0593     0.183

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z    p
strataLOW 0.2926    1.3399   0.6857 0.427 0.67

Likelihood ratio test=0.19  on 1 df, p=0.6634
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TF 

[1] 221
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7      7.9     0.102      0.34
strata=LOW  5        5      4.1     0.196      0.34

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)    z     p
strataLOW 0.3714    1.4497   0.6400 0.58 0.562

Likelihood ratio test=0.33  on 1 df, p=0.5627
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ETV4 



============================

TCGA-COAD PLA2G6 

[1] 222
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.04     0.302     0.446
strata=LOW  8        8     8.96     0.103     0.446

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4344    0.6476   0.6554 -0.663 0.507

Likelihood ratio test=0.42  on 1 df, p=0.5145
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD POR 

[1] 223
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.25     2.465      3.14
strata=LOW  9        9    10.75     0.286      3.14

 Chisq= 3.1  on 1 degrees of freedom, p= 0.08 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.3546    0.2580   0.8225 -1.647 0.0996

Likelihood ratio test=2.54  on 1 df, p=0.1113
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRPF1 

[1] 224
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TMBIM4 

[1] 225
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KRAS 

[1] 226
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AHCY 

[1] 227
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     5.41    0.0313    0.0654
strata=LOW  7        7     6.59    0.0257    0.0654

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1617    1.1755   0.6327 0.256 0.798

Likelihood ratio test=0.07  on 1 df, p=0.797
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR34C 



============================

TCGA-COAD ATG3 

[1] 228
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR30B 



============================

TCGA-COAD LYRM1 

[1] 229
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.96     0.186     0.376
strata=LOW  8        8     7.04     0.131     0.376

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4172    1.5177   0.6854 0.609 0.543

Likelihood ratio test=0.39  on 1 df, p=0.5315
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SIRT6 

[1] 230
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.77   0.01966    0.0277
strata=LOW  9        9     9.23   0.00589    0.0277

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1159    0.8906   0.6967 -0.166 0.868

Likelihood ratio test=0.03  on 1 df, p=0.8689
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KMT2D 

[1] 231
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.44     1.697      2.26
strata=LOW  9        9    10.56     0.231      2.26

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.1758    0.3086   0.8255 -1.424 0.154

Likelihood ratio test=1.93  on 1 df, p=0.1648
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LPIN1 

[1] 232
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MBOAT2 

[1] 233
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD KDM3B 

[1] 234
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.75     0.898      1.21
strata=LOW  9        9    10.25     0.153      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8222    0.4395   0.7688 -1.069 0.285

Likelihood ratio test=1.07  on 1 df, p=0.2998
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ARHGEF26-AS1 

[1] 235
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    11.44     0.181      4.35
strata=LOW   2        2     0.56     3.708      4.35

 Chisq= 4.4  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z      p
strataLOW 1.848     6.344    1.011 1.827 0.0676

Likelihood ratio test=2.97  on 1 df, p=0.08482
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR9-1 



============================

TCGA-COAD AIFM2 

[1] 236
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRDX1 

[1] 237
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     0.82    0.0396    0.0452
strata=LOW  11       11    11.18    0.0029    0.0452

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2300    0.7945   1.0848 -0.212 0.832

Likelihood ratio test=0.04  on 1 df, p=0.8365
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FOXO4 

[1] 238
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BMAL1 

[1] 239
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.95     0.186     0.413
strata=LOW  5        5     6.05     0.183     0.413

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4041    0.6676   0.6325 -0.639 0.523

Likelihood ratio test=0.42  on 1 df, p=0.5167
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR127 



============================

TCGA-COAD TGFBR1 

[1] 240
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     0.82    0.0396    0.0452
strata=LOW  11       11    11.18    0.0029    0.0452

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2300    0.7945   1.0848 -0.212 0.832

Likelihood ratio test=0.04  on 1 df, p=0.8365
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NR1D2 

[1] 241
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FZD7 

[1] 242
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.77   0.00891    0.0191
strata=LOW  6        6     6.23   0.00826    0.0191

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z    p
strataLOW -0.08464   0.91884  0.61184 -0.138 0.89

Likelihood ratio test=0.02  on 1 df, p=0.8899
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD G6PD 

[1] 243
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1      3.1     1.425      2.88
strata=LOW  11       11      8.9     0.497      2.88

 Chisq= 2.9  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

               coef exp(coef)  se(coef)     z     p
strataLOW 1.955e+01 3.092e+08 1.012e+04 0.002 0.998

Likelihood ratio test=4.97  on 1 df, p=0.02579
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HRAS 



============================

TCGA-COAD SLC38A1 

[1] 244
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC39A14 

[1] 245
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR21 



============================

TCGA-COAD MIR1-1 



============================

TCGA-COAD PROM2 

[1] 246
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     9.81   0.00355    0.0217
strata=LOW   2        2     2.19   0.01591    0.0217

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1203    0.8867   0.8163 -0.147 0.883

Likelihood ratio test=0.02  on 1 df, p=0.8816
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NFE2L2 

[1] 247
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GABARAPL1 

[1] 248
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR335 



============================

TCGA-COAD PTEN 

[1] 249
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP4 

[1] 250
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.09     1.186      1.99
strata=LOW  7        7     8.91     0.411      1.99

 Chisq= 2  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0108    0.3639   0.7442 -1.358 0.174

Likelihood ratio test=1.93  on 1 df, p=0.165
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MS4A15 

[1] 251
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.66     0.259      2.69
strata=LOW  3        3     1.34     2.065      2.69

 Chisq= 2.7  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 1.2666    3.5488   0.8236 1.538 0.124

Likelihood ratio test=2.23  on 1 df, p=0.1354
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TIMM9 

[1] 252
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     2.42    0.0739    0.0992
strata=LOW  10       10     9.58    0.0187    0.0992

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2503    1.2844   0.7967 0.314 0.753

Likelihood ratio test=0.1  on 1 df, p=0.7476
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP3 

[1] 253
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD WIPI1 

[1] 254
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     6.77    0.0883     0.223
strata=LOW  6        6     5.23    0.1144     0.223

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)    z     p
strataLOW 0.2878    1.3334   0.6120 0.47 0.638

Likelihood ratio test=0.22  on 1 df, p=0.6373
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SNX5 

[1] 255
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.49     0.103     0.153
strata=LOW  9        9     9.51     0.027     0.153

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.2882    0.7496   0.7390 -0.39 0.697

Likelihood ratio test=0.15  on 1 df, p=0.7002
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00239 

[1] 256
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     5.97     0.159     0.416
strata=LOW  7        7     6.03     0.158     0.416

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4531    1.5731   0.7073 0.641 0.522

Likelihood ratio test=0.43  on 1 df, p=0.5111
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PIEZO1 

[1] 257
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.31     2.168      2.85
strata=LOW  9        9    10.69     0.266      2.85

 Chisq= 2.8  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -1.3168    0.2680   0.8334 -1.58 0.114

Likelihood ratio test=2.35  on 1 df, p=0.1249
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AKR1C2 

[1] 258
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10   11.073     0.104      1.48
strata=LOW   2        2    0.927     1.240      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 1.0164    2.7632   0.8716 1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR4443 



============================

TCGA-COAD SLC16A1-AS1 

[1] 259
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3    0.834      5.63      7.28
strata=LOW  9        9   11.166      0.42      7.28

 Chisq= 7.3  on 1 degrees of freedom, p= 0.007 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z      p
strataLOW -2.52855   0.07977  1.17716 -2.148 0.0317

Likelihood ratio test=5.57  on 1 df, p=0.01826
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FAR1 

[1] 260
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CISD2 

[1] 261
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAPK3 

[1] 262
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CYGB 

[1] 263
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.26    0.1282     0.217
strata=LOW  7        7     7.74    0.0706     0.217

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2872    0.7504   0.6180 -0.465 0.642

Likelihood ratio test=0.21  on 1 df, p=0.6439
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MLST8 



============================

TCGA-COAD PANX2 

[1] 264
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     6.94     0.126     0.331
strata=LOW  6        6     5.06     0.173     0.331

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3535    1.4240   0.6169 0.573 0.567

Likelihood ratio test=0.33  on 1 df, p=0.5655
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEBP1 

[1] 265
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP8 

[1] 266
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.83     0.749     0.954
strata=LOW  9        9    10.17     0.135     0.954

 Chisq= 1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6846    0.5043   0.7143 -0.958 0.338

Likelihood ratio test=0.84  on 1 df, p=0.3587
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GJA1 

[1] 267
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.27     2.364      2.95
strata=LOW  9        9    10.73     0.279      2.95

 Chisq= 3  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.2585    0.2841   0.7778 -1.618 0.106

Likelihood ratio test=2.35  on 1 df, p=0.125
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BAP1 

[1] 268
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAP3K11 

[1] 269
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TTBK2 

[1] 270
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     5.18     0.269     0.525
strata=LOW  8        8     6.82     0.204     0.525

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4584    1.5815   0.6373 0.719 0.472

Likelihood ratio test=0.53  on 1 df, p=0.4649
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR214 



============================

TCGA-COAD PARP15 

[1] 271
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.44     0.545     0.956
strata=LOW  6        6     7.56     0.320     0.956

 Chisq= 1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5998    0.5489   0.6215 -0.965 0.334

Likelihood ratio test=0.94  on 1 df, p=0.3331
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HDDC3 

[1] 272
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR10A 



============================

TCGA-COAD CGAS 

[1] 273
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.28    0.1197       0.2
strata=LOW  7        7     7.72    0.0665       0.2

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2721    0.7618   0.6110 -0.445 0.656

Likelihood ratio test=0.2  on 1 df, p=0.6578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SIRT2 

[1] 274
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.16    0.6013     0.752
strata=LOW  10       10    10.84    0.0646     0.752

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7387    0.4777   0.8710 -0.848 0.396

Likelihood ratio test=0.65  on 1 df, p=0.4188
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PPARD 

[1] 275
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EGR1 

[1] 276
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     7.36     0.253     0.764
strata=LOW  6        6     4.64     0.401     0.764

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.5628    1.7555   0.6520 0.863 0.388

Likelihood ratio test=0.76  on 1 df, p=0.3823
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AQP3 

[1] 277
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     9.48     0.647      3.54
strata=LOW  5        5     2.52     2.431      3.54

 Chisq= 3.5  on 1 degrees of freedom, p= 0.06 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.2331    3.4319   0.6912 1.784 0.0744

Likelihood ratio test=3.15  on 1 df, p=0.07599
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HSF1 



============================

TCGA-COAD MIR18A 



============================

TCGA-COAD OSBPL9 

[1] 278
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SESN2 

[1] 279
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BECN1 

[1] 280
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FTMT 



============================

TCGA-COAD HCAR1 

[1] 281
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     6.09     0.600      1.39
strata=LOW  4        4     5.91     0.618      1.39

 Chisq= 1.4  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -0.7910    0.4534   0.6873 -1.151 0.25

Likelihood ratio test=1.46  on 1 df, p=0.2273
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HILPDA 

[1] 282
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.89    0.0895     0.376
strata=LOW  4        4     3.11    0.2562     0.376

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)    z     p
strataLOW 0.3962    1.4862   0.6501 0.61 0.542

Likelihood ratio test=0.36  on 1 df, p=0.5484
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GSTM1 

[1] 283
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     8.12     0.555      1.96
strata=LOW  6        6     3.88     1.163      1.96

 Chisq= 2  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.8898    2.4346   0.6555 1.357 0.175

Likelihood ratio test=1.89  on 1 df, p=0.1689
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR222 

[1] 284
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=3, 43 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 2        2     1.17     0.595      1.47
strata=LOW  1        1     1.83     0.379      1.47

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.097e+01  7.775e-10  2.928e+04 -0.001 0.999

Likelihood ratio test=2.2  on 1 df, p=0.1383
n= 3, number of events= 3 
   (43 observations deleted due to missingness)


============================

TCGA-COAD RARRES2 

[1] 285
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     8.31     0.644      2.52
strata=LOW  6        6     3.69     1.453      2.52

 Chisq= 2.5  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 1.0873    2.9663   0.7164 1.518 0.129

Likelihood ratio test=2.48  on 1 df, p=0.1153
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRD4 

[1] 286
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SOCS1 

[1] 287
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3      2.2    0.2932     0.391
strata=LOW  9        9      9.8    0.0657     0.391

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4411    0.6433   0.7109 -0.621 0.535

Likelihood ratio test=0.36  on 1 df, p=0.5458
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR17 



============================

TCGA-COAD GDF15 

[1] 288
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11      8.9     0.497      2.88
strata=LOW   1        1      3.1     1.425      2.88

 Chisq= 2.9  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

                coef  exp(coef)   se(coef)      z     p
strataLOW -1.955e+01  3.234e-09  1.012e+04 -0.002 0.998

Likelihood ratio test=4.97  on 1 df, p=0.02579
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ARF6 

[1] 289
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDO1 

[1] 290
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     8.47    0.0258    0.0974
strata=LOW  4        4     3.53    0.0618    0.0974

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2031    1.2252   0.6518 0.312 0.755

Likelihood ratio test=0.1  on 1 df, p=0.7571
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CAMKK2 

[1] 291
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC01606 

[1] 292
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=7, 39 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     6.69    0.0713      1.82
strata=LOW  1        1     0.31    1.5403      1.82

 Chisq= 1.8  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z    p
strataLOW 1.701     5.477    1.416 1.201 0.23

Likelihood ratio test=1.3  on 1 df, p=0.2547
n= 7, number of events= 7 
   (39 observations deleted due to missingness)


============================

TCGA-COAD BACH1 

[1] 293
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DPP4 

[1] 294
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     8.84     0.384      1.68
strata=LOW  5        5     3.16     1.075      1.68

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.8499    2.3394   0.6756 1.258 0.208

Likelihood ratio test=1.59  on 1 df, p=0.2079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PPP1R13L 

[1] 295
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.85   0.00615    0.0119
strata=LOW  8        8     8.15   0.00290    0.0119

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.07592   0.92689  0.69690 -0.109 0.913

Likelihood ratio test=0.01  on 1 df, p=0.9137
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR150 



============================

TCGA-COAD FLT3 

[1] 296
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.86   0.00315   0.00687
strata=LOW  6        6     6.14   0.00301   0.00687

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05068   0.95058  0.61129 -0.083 0.934

Likelihood ratio test=0.01  on 1 df, p=0.9339
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAP1LC3A 

[1] 297
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.29    0.0192    0.0321
strata=LOW  8        8     7.71    0.0107    0.0321

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1135    1.1202   0.6337 0.179 0.858

Likelihood ratio test=0.03  on 1 df, p=0.8572
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD A2M-AS1 

[1] 298
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.95     0.186     0.413
strata=LOW  5        5     6.05     0.183     0.413

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4041    0.6676   0.6325 -0.639 0.523

Likelihood ratio test=0.42  on 1 df, p=0.5167
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PDSS2 

[1] 299
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.35    0.0276      0.05
strata=LOW  8        8     7.65    0.0157      0.05

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1459    1.1571   0.6533 0.223 0.823

Likelihood ratio test=0.05  on 1 df, p=0.8225
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DNAJB6 



============================

TCGA-COAD SUV39H1 

[1] 300
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     1.02  0.000387   0.00045
strata=LOW  11       11    10.98  0.000036   0.00045

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.02281   1.02308  1.07582 0.021 0.983

Likelihood ratio test=0  on 1 df, p=0.983
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LPCAT3 

[1] 301
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.76     0.408     0.678
strata=LOW  7        7     8.24     0.186     0.678

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5260    0.5910   0.6455 -0.815 0.415

Likelihood ratio test=0.66  on 1 df, p=0.4172
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR761 



============================

TCGA-COAD CDCA3 

[1] 302
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.63    0.0248    0.0533
strata=LOW  6        6     6.37    0.0219    0.0533

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1414    0.8681   0.6130 -0.231 0.818

Likelihood ratio test=0.05  on 1 df, p=0.8179
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EPAS1 

[1] 303
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.31     0.542       1.2
strata=LOW  5        5     6.69     0.429       1.2

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7516    0.4716   0.7019 -1.071 0.284

Likelihood ratio test=1.24  on 1 df, p=0.2658
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC11A2 

[1] 304
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.84   0.01396    0.0184
strata=LOW  10       10    10.16   0.00253    0.0184

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1117    0.8943   0.8234 -0.136 0.892

Likelihood ratio test=0.02  on 1 df, p=0.8931
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CREB3 

[1] 305
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATF3 

[1] 306
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.95     0.186     0.413
strata=LOW  5        5     6.05     0.183     0.413

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4041    0.6676   0.6325 -0.639 0.523

Likelihood ratio test=0.42  on 1 df, p=0.5167
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TGFB1 

[1] 307
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.65     1.111      1.46
strata=LOW  9        9    10.35     0.177      1.46

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9000    0.4066   0.7684 -1.171 0.241

Likelihood ratio test=1.28  on 1 df, p=0.2581
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SMG9 

[1] 308
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.92  0.003076   0.00395
strata=LOW  10       10    10.08  0.000587   0.00395

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z    p
strataLOW -0.05061   0.95065  0.80554 -0.063 0.95

Likelihood ratio test=0  on 1 df, p=0.9501
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NOX4 

[1] 309
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     9.58    0.0187    0.0992
strata=LOW   2        2     2.42    0.0739    0.0992

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2503    0.7786   0.7967 -0.314 0.753

Likelihood ratio test=0.1  on 1 df, p=0.7476
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR27A 



============================

TCGA-COAD FOXP1 

[1] 310
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SNCA 

[1] 311
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     7.91     0.106     0.349
strata=LOW  5        5     4.09     0.205     0.349

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3737    1.4531   0.6358 0.588 0.557

Likelihood ratio test=0.34  on 1 df, p=0.5578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ENPP2 

[1] 312
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.86   0.00315   0.00687
strata=LOW  6        6     6.14   0.00301   0.00687

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05068   0.95058  0.61129 -0.083 0.934

Likelihood ratio test=0.01  on 1 df, p=0.9339
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRD2 

[1] 313
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ISCU 

[1] 314
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PHF21A 

[1] 315
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP6 

[1] 316
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     2.76    0.2076      0.29
strata=LOW  10       10     9.24    0.0619      0.29

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4271    1.5328   0.7980 0.535 0.593

Likelihood ratio test=0.31  on 1 df, p=0.5771
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ZEB1 

[1] 317
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.07     0.114     0.771
strata=LOW  3        3     1.93     0.594     0.771

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.6195    1.8581   0.7165 0.865 0.387

Likelihood ratio test=0.69  on 1 df, p=0.4052
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LIG3 

[1] 318
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.04    0.8900      1.08
strata=LOW  10       10    10.96    0.0843      1.08

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8793    0.4151   0.8712 -1.009 0.313

Likelihood ratio test=0.91  on 1 df, p=0.3411
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PEDS1 

[1] 319
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RPPH1 



============================

TCGA-COAD GFRA1 

[1] 320
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11   11.726    0.0449      2.12
strata=LOW   1        1    0.274    1.9207      2.12

 Chisq= 2.1  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z    p
strataLOW 1.605     4.978    1.226 1.309 0.19

Likelihood ratio test=1.35  on 1 df, p=0.2452
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AQP8 



============================

TCGA-COAD SIRT1 

[1] 321
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR15A 



============================

TCGA-COAD AKR1C3 

[1] 322
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     5.36    0.0237    0.0474
strata=LOW  7        7     6.64    0.0191    0.0474

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1335    1.1428   0.6132 0.218 0.828

Likelihood ratio test=0.05  on 1 df, p=0.8274
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DLD 

[1] 323
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD USP11 

[1] 324
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.92  0.003076   0.00395
strata=LOW  10       10    10.08  0.000587   0.00395

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z    p
strataLOW -0.05061   0.95065  0.80554 -0.063 0.95

Likelihood ratio test=0  on 1 df, p=0.9501
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SREBF2 

[1] 325
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR190A 



============================

TCGA-COAD IFNA8 



============================

TCGA-COAD KDM6B 

[1] 326
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.44     1.697      2.26
strata=LOW  9        9    10.56     0.231      2.26

 Chisq= 2.3  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.1758    0.3086   0.8255 -1.424 0.154

Likelihood ratio test=1.93  on 1 df, p=0.1648
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACOT1 

[1] 327
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.67     0.482     0.787
strata=LOW  7        7     8.33     0.212     0.787

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5649    0.5684   0.6445 -0.876 0.381

Likelihood ratio test=0.76  on 1 df, p=0.3834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RELA 

[1] 328
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC39A7 

[1] 329
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD POM121L12 



============================

TCGA-COAD MIR101-1 



============================

TCGA-COAD GABPB1-AS1 

[1] 330
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.927     1.240      1.48
strata=LOW  10       10   11.073     0.104      1.48

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.0164    0.3619   0.8716 -1.166 0.244

Likelihood ratio test=1.18  on 1 df, p=0.2764
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EGFR 

[1] 331
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRD7 

[1] 332
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR1287 



============================

TCGA-COAD MIR23A 



============================

TCGA-COAD LCE2C 



============================

TCGA-COAD ADAMTS13 

[1] 333
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.54    0.0595    0.0911
strata=LOW  8        8     8.46    0.0249    0.0911

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1927    0.8247   0.6394 -0.301 0.763

Likelihood ratio test=0.09  on 1 df, p=0.7651
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SIRT3 

[1] 334
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.09  0.001837   0.00303
strata=LOW  8        8     7.91  0.000949   0.00303

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03513   1.03575  0.63806 0.055 0.956

Likelihood ratio test=0  on 1 df, p=0.956
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CIRBP 

[1] 335
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRDT 

[1] 336
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=8, 38 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7    7.875    0.0972         7
strata=LOW  1        1    0.125    6.1250         7

 Chisq= 7  on 1 degrees of freedom, p= 0.008 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

               coef exp(coef)  se(coef)     z     p
strataLOW 2.200e+01 3.598e+09 2.267e+04 0.001 0.999

Likelihood ratio test=4.16  on 1 df, p=0.04142
n= 8, number of events= 8 
   (38 observations deleted due to missingness)


============================

TCGA-COAD KIF4A 

[1] 337
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.87   0.00369   0.00733
strata=LOW  7        7     7.13   0.00252   0.00733

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05427   0.94717  0.63414 -0.086 0.932

Likelihood ratio test=0.01  on 1 df, p=0.932
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CPEB1 



============================

TCGA-COAD LINC01833 



============================

TCGA-COAD MAPKAP1 

[1] 338
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.16    0.6013     0.752
strata=LOW  10       10    10.84    0.0646     0.752

 Chisq= 0.8  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7387    0.4777   0.8710 -0.848 0.396

Likelihood ratio test=0.65  on 1 df, p=0.4188
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ATF4 

[1] 339
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.74   0.02409    0.0354
strata=LOW  9        9     9.26   0.00714    0.0354

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1344    0.8742   0.7150 -0.188 0.851

Likelihood ratio test=0.03  on 1 df, p=0.852
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC7A11 

[1] 340
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9      9.2   0.00434     0.021
strata=LOW  3        3      2.8   0.01427     0.021

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1030    1.1084   0.7114 0.145 0.885

Likelihood ratio test=0.02  on 1 df, p=0.8856
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD EMC2 

[1] 341
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD WWTR1 

[1] 342
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     6.97     0.153     0.428
strata=LOW  4        4     5.03     0.212     0.428

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4443    0.6413   0.6844 -0.649 0.516

Likelihood ratio test=0.45  on 1 df, p=0.5038
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD HSPA5 

[1] 343
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BEX1 

[1] 344
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    10.53    0.0264     0.241
strata=LOW   2        2     1.47    0.1885     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4107    1.5079   0.8420 0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PML 

[1] 345
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR142 



============================

TCGA-COAD AEBP2 

[1] 346
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GPAT4 

[1] 347
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.75     0.898      1.21
strata=LOW  9        9    10.25     0.153      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8222    0.4395   0.7688 -1.069 0.285

Likelihood ratio test=1.07  on 1 df, p=0.2998
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CA9 

[1] 348
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10   11.097     0.108      1.54
strata=LOW   2        2    0.903     1.332      1.54

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 1.0034    2.7276   0.8422 1.191 0.233

Likelihood ratio test=1.21  on 1 df, p=0.2718
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD STK11 

[1] 349
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TBK1 

[1] 350
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDKN2A 

[1] 351
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     9.62    0.0148     0.082
strata=LOW   2        2     2.38    0.0599     0.082

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2309    0.7938   0.8078 -0.286 0.775

Likelihood ratio test=0.09  on 1 df, p=0.7702
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DCAF7 

[1] 352
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MTF1 

[1] 353
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MEG8 

[1] 354
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.51     0.217       1.9
strata=LOW  3        3     1.49     1.535       1.9

 Chisq= 1.9  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.9773    2.6573   0.7360 1.328 0.184

Likelihood ratio test=1.58  on 1 df, p=0.2084
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CLTRN 

[1] 355
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     5.53     1.155      2.54
strata=LOW  9        9     6.47     0.986      2.54

 Chisq= 2.5  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z    p
strataLOW 1.2082    3.3473   0.7983 1.513 0.13

Likelihood ratio test=2.82  on 1 df, p=0.09329
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP11 

[1] 356
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GABARAPL2 

[1] 357
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CDKN1A 

[1] 358
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     7.23   0.00757    0.0226
strata=LOW  5        5     4.77   0.01149    0.0226

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)    z    p
strataLOW 0.09535   1.10005  0.63420 0.15 0.88

Likelihood ratio test=0.02  on 1 df, p=0.881
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NEDD4L 

[1] 359
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     7.96     0.483      1.55
strata=LOW  6        6     4.04     0.951      1.55

 Chisq= 1.6  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)    z     p
strataLOW 0.7516    2.1204   0.6161 1.22 0.222

Likelihood ratio test=1.49  on 1 df, p=0.2225
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AR 

[1] 360
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8    10.51     0.601      5.91
strata=LOW  4        4     1.49     4.247      5.91

 Chisq= 5.9  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.9195    6.8176   0.8941 2.147 0.0318

Likelihood ratio test=4.94  on 1 df, p=0.02617
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR20A 



============================

TCGA-COAD HMOX1 

[1] 361
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.76     0.408     0.678
strata=LOW  7        7     8.24     0.186     0.678

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5260    0.5910   0.6455 -0.815 0.415

Likelihood ratio test=0.66  on 1 df, p=0.4172
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ZFP36 

[1] 362
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.86   0.00315   0.00687
strata=LOW  6        6     6.14   0.00301   0.00687

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05068   0.95058  0.61129 -0.083 0.934

Likelihood ratio test=0.01  on 1 df, p=0.9339
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR744 

[1] 363
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=10, 36 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     7.99     0.495      2.85
strata=LOW  4        4     2.01     1.968      2.85

 Chisq= 2.9  on 1 degrees of freedom, p= 0.09 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 1.2442    3.4703   0.7798 1.596 0.111

Likelihood ratio test=2.54  on 1 df, p=0.1107
n= 10, number of events= 10 
   (36 observations deleted due to missingness)


============================

TCGA-COAD CTSB 

[1] 364
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     4.58     0.543      1.06
strata=LOW  9        9     7.42     0.335      1.06

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.7950    2.2144   0.7905 1.006 0.315

Likelihood ratio test=1.17  on 1 df, p=0.2785
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AGPS 

[1] 365
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     4.35    0.0276      0.05
strata=LOW  8        8     7.65    0.0157      0.05

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1459    1.1571   0.6533 0.223 0.823

Likelihood ratio test=0.05  on 1 df, p=0.8225
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MT1DP 

[1] 366
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     7.52    0.0307    0.0997
strata=LOW  4        4     4.48    0.0516    0.0997

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2161    0.8057   0.6856 -0.315 0.753

Likelihood ratio test=0.1  on 1 df, p=0.749
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SNX4 

[1] 367
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NR4A1 

[1] 368
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.42     0.569     0.972
strata=LOW  6        6     7.58     0.331     0.972

 Chisq= 1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5959    0.5511   0.6127 -0.973 0.331

Likelihood ratio test=0.95  on 1 df, p=0.3299
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MFN2 

[1] 369
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.07     1.808      2.61
strata=LOW  8        8     9.93     0.376      2.61

 Chisq= 2.6  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -1.1848    0.3058   0.7739 -1.531 0.126

Likelihood ratio test=2.35  on 1 df, p=0.1254
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SELENOI 

[1] 370
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.56      1.34      1.74
strata=LOW  9        9    10.44      0.20      1.74

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.9751    0.3771   0.7686 -1.269 0.205

Likelihood ratio test=1.49  on 1 df, p=0.2226
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD AGAP2-AS1 

[1] 371
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     7.05     0.128     0.363
strata=LOW  4        4     4.95     0.183     0.363

 Chisq= 0.4  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4086    0.6646   0.6824 -0.599 0.549

Likelihood ratio test=0.38  on 1 df, p=0.5382
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TRIM46 

[1] 372
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     2.61     2.178      3.25
strata=LOW  7        7     9.39     0.607      3.25

 Chisq= 3.3  on 1 degrees of freedom, p= 0.07 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.1950    0.3027   0.6952 -1.719 0.0856

Likelihood ratio test=2.93  on 1 df, p=0.08695
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CYB5R1 

[1] 373
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARK7 

[1] 374
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     0.82    0.0396    0.0452
strata=LOW  11       11    11.18    0.0029    0.0452

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2300    0.7945   1.0848 -0.212 0.832

Likelihood ratio test=0.04  on 1 df, p=0.8365
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CARS1 

[1] 375
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NOX1 

[1] 376
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     2.88     0.432     0.642
strata=LOW  8        8     9.12     0.137     0.642

 Chisq= 0.6  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.5343    0.5861   0.6745 -0.792 0.428

Likelihood ratio test=0.61  on 1 df, p=0.4352
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD VDR 

[1] 377
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     5.11     0.695      1.46
strata=LOW  5        5     6.89     0.517      1.46

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8245    0.4385   0.6993 -1.179 0.238

Likelihood ratio test=1.51  on 1 df, p=0.2191
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PROK2 

[1] 378
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     2.39      5.45      8.74
strata=LOW  6        6     9.61      1.36      8.74

 Chisq= 8.7  on 1 degrees of freedom, p= 0.003 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z      p
strataLOW -2.58808   0.07516  1.09935 -2.354 0.0186

Likelihood ratio test=8.48  on 1 df, p=0.003595
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FABP4 

[1] 379
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11   11.615    0.0325      1.09
strata=LOW   1        1    0.385    0.9804      1.09

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z     p
strataLOW 1.142     3.134    1.156 0.988 0.323

Likelihood ratio test=0.79  on 1 df, p=0.374
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ABCB10 

[1] 380
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CP 

[1] 381
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10     8.63     0.219     0.858
strata=LOW   2        2     3.37     0.559     0.858

 Chisq= 0.9  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7269    0.4834   0.7998 -0.909 0.363

Likelihood ratio test=0.94  on 1 df, p=0.3318
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR4735 



============================

TCGA-COAD MIR130A 



============================

TCGA-COAD TUG1 

[1] 382
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.35    0.1259     0.193
strata=LOW  8        8     8.65    0.0488     0.193

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2855    0.7516   0.6522 -0.438 0.662

Likelihood ratio test=0.19  on 1 df, p=0.6649
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR9-3HG 

[1] 383
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     6.88   0.00196   0.00536
strata=LOW  5        5     5.12   0.00263   0.00536

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.04644   0.95462  0.63453 -0.073 0.942

Likelihood ratio test=0.01  on 1 df, p=0.9415
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR196C 



============================

TCGA-COAD IFNA21 

[1] 384
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=4, 42 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 2        2     2.33    0.0476     0.154
strata=LOW  2        2     1.67    0.0667     0.154

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.4812    1.6180   1.2380 0.389 0.697

Likelihood ratio test=0.16  on 1 df, p=0.6913
n= 4, number of events= 4 
   (42 observations deleted due to missingness)


============================

TCGA-COAD RP11-274B21.9 

[1] 385
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7      6.5    0.0389    0.0969
strata=LOW  5        5      5.5    0.0459    0.0969

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1966    0.8215   0.6327 -0.311 0.756

Likelihood ratio test=0.1  on 1 df, p=0.7541
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PVT1 

[1] 386
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     6.91     0.171     0.477
strata=LOW  4        4     5.09     0.232     0.477

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4704    0.6248   0.6872 -0.685 0.494

Likelihood ratio test=0.5  on 1 df, p=0.4805
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR539 



============================

TCGA-COAD IFNA2 



============================

TCGA-COAD TFRC 

[1] 387
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.47    0.0504     0.107
strata=LOW  6        6     6.53    0.0423     0.107

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1999    0.8188   0.6135 -0.326 0.744

Likelihood ratio test=0.11  on 1 df, p=0.7454
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALOX15B 

[1] 388
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9     9.34    0.0122    0.0596
strata=LOW  3        3     2.66    0.0427    0.0596

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.1699    1.1852   0.6969 0.244 0.807

Likelihood ratio test=0.06  on 1 df, p=0.8097
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MPC1 

[1] 389
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.04     0.957      1.69
strata=LOW  6        6     7.96     0.485      1.69

 Chisq= 1.7  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8441    0.4299   0.6652 -1.269 0.204

Likelihood ratio test=1.66  on 1 df, p=0.1982
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MTCH1 

[1] 390
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR324 

[1] 391
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=10, 36 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7     6.89   0.00178   0.00615
strata=LOW  3        3     3.11   0.00394   0.00615

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05604   0.94550  0.71459 -0.078 0.937

Likelihood ratio test=0.01  on 1 df, p=0.9373
n= 10, number of events= 10 
   (36 observations deleted due to missingness)


============================

TCGA-COAD SNHG14 

[1] 392
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8    10.15     0.454      3.37
strata=LOW  4        4     1.85     2.485      3.37

 Chisq= 3.4  on 1 degrees of freedom, p= 0.07 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.2616    3.5312   0.7275 1.734 0.0829

Likelihood ratio test=2.85  on 1 df, p=0.09128
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PDK4 

[1] 393
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    10.46    0.0199     0.164
strata=LOW   2        2     1.54    0.1346     0.164

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3259    1.3853   0.8074 0.404 0.686

Likelihood ratio test=0.15  on 1 df, p=0.6954
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD DUOX1 

[1] 394
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00886 

[1] 395
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9   11.257     0.453      8.56
strata=LOW  3        3    0.743     6.857      8.56

 Chisq= 8.6  on 1 degrees of freedom, p= 0.003 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW  2.647    14.107    1.170 2.263 0.0236

Likelihood ratio test=6.16  on 1 df, p=0.01303
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NF2 

[1] 396
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR149 



============================

TCGA-COAD CYP4F8 

[1] 397
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=11, 35 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6      4.4     0.580      1.07
strata=LOW  5        5      6.6     0.387      1.07

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6675    0.5130   0.6565 -1.017 0.309

Likelihood ratio test=1.06  on 1 df, p=0.3029
n= 11, number of events= 11 
   (35 observations deleted due to missingness)


============================

TCGA-COAD AKR1C1 

[1] 398
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     7.58    0.0228    0.0764
strata=LOW  4        4     4.42    0.0392    0.0764

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1902    0.8268   0.6893 -0.276 0.783

Likelihood ratio test=0.08  on 1 df, p=0.7798
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRKCA 

[1] 399
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.94     0.228     0.461
strata=LOW  6        6     7.06     0.159     0.461

 Chisq= 0.5  on 1 degrees of freedom, p= 0.5 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z   p
strataLOW -0.4407    0.6436   0.6538 -0.674 0.5

Likelihood ratio test=0.46  on 1 df, p=0.4957
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CD44 

[1] 400
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     5.29    0.0952     0.199
strata=LOW  6        6     6.71    0.0751     0.199

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2736    0.7607   0.6156 -0.444 0.657

Likelihood ratio test=0.2  on 1 df, p=0.6584
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FBXW7 

[1] 401
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.75     0.898      1.21
strata=LOW  9        9    10.25     0.153      1.21

 Chisq= 1.2  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.8222    0.4395   0.7688 -1.069 0.285

Likelihood ratio test=1.07  on 1 df, p=0.2998
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD YAP1 

[1] 402
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MTOR 

[1] 403
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.58    0.0929     0.142
strata=LOW  9        9     8.42    0.0394     0.142

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2581    1.2945   0.6868 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7021
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RICTOR 

[1] 404
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD WIPI2 

[1] 405
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1    0.653    0.1841     0.207
strata=LOW  11       11   11.347    0.0106     0.207

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4955    0.6093   1.0988 -0.451 0.652

Likelihood ratio test=0.18  on 1 df, p=0.6697
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD IREB2 

[1] 406
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GOT1 

[1] 407
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CD82 

[1] 408
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5      4.5    0.0557      0.11
strata=LOW  7        7      7.5    0.0334      0.11

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2119    0.8090   0.6412 -0.331 0.741

Likelihood ratio test=0.11  on 1 df, p=0.7434
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MAPK9 

[1] 409
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LGMN 

[1] 410
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.08  0.001892   0.00279
strata=LOW  9        9     8.92  0.000652   0.00279

 Chisq= 0  on 1 degrees of freedom, p= 1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW 0.03677   1.03746  0.69665 0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9578
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PARP2 

[1] 411
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  1        1     0.82    0.0396    0.0452
strata=LOW  11       11    11.18    0.0029    0.0452

 Chisq= 0  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2300    0.7945   1.0848 -0.212 0.832

Likelihood ratio test=0.04  on 1 df, p=0.8365
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MIR16-1 



============================

TCGA-COAD ATG4D 

[1] 412
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     2.77   0.01966    0.0277
strata=LOW  9        9     9.23   0.00589    0.0277

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1159    0.8906   0.6967 -0.166 0.868

Likelihood ratio test=0.03  on 1 df, p=0.8689
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RBMS1 

[1] 413
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.26    0.1282     0.217
strata=LOW  7        7     7.74    0.0706     0.217

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2872    0.7504   0.6180 -0.465 0.642

Likelihood ratio test=0.21  on 1 df, p=0.6439
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD GSTZ1 

[1] 414
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     3.44    0.0570    0.0893
strata=LOW  9        9     8.56    0.0229    0.0893

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.2085    1.2319   0.6989 0.298 0.765

Likelihood ratio test=0.09  on 1 df, p=0.7626
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SRSF9 



============================

TCGA-COAD HIF1A 

[1] 415
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.35    0.1259     0.193
strata=LOW  8        8     8.65    0.0488     0.193

 Chisq= 0.2  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.2855    0.7516   0.6522 -0.438 0.662

Likelihood ratio test=0.19  on 1 df, p=0.6649
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FNDC3B 

[1] 416
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     3.53     0.615      1.06
strata=LOW  7        7     8.47     0.256      1.06

 Chisq= 1.1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)     z     p
strataLOW -0.6954    0.4989   0.6885 -1.01 0.313

Likelihood ratio test=1.03  on 1 df, p=0.3105
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RHEBP1 



============================

TCGA-COAD PSEN1 

[1] 417
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ADIPOQ 

[1] 418
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11     10.4     0.035     0.282
strata=LOW   1        1      1.6     0.227     0.282

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z   p
strataLOW -0.5619    0.5701   1.0704 -0.525 0.6

Likelihood ratio test=0.32  on 1 df, p=0.5734
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD MUC1 

[1] 419
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     6.82    0.0994     0.274
strata=LOW  6        6     5.18    0.1311     0.274

 Chisq= 0.3  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.3237    1.3822   0.6206 0.522 0.602

Likelihood ratio test=0.27  on 1 df, p=0.6042
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD CAV1 

[1] 420
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8     9.56     0.255      1.42
strata=LOW  4        4     2.44     0.998      1.42

 Chisq= 1.4  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z     p
strataLOW 0.8008    2.2272   0.6876 1.165 0.244

Likelihood ratio test=1.29  on 1 df, p=0.2555
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SEC24B 

[1] 421
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     1.47    0.1885     0.241
strata=LOW  10       10    10.53    0.0264     0.241

 Chisq= 0.2  on 1 degrees of freedom, p= 0.6 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.4107    0.6632   0.8420 -0.488 0.626

Likelihood ratio test=0.22  on 1 df, p=0.6362
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRDX6 

[1] 422
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     4.86   0.00424   0.00847
strata=LOW  7        7     7.14   0.00288   0.00847

 Chisq= 0  on 1 degrees of freedom, p= 0.9 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z     p
strataLOW -0.05903   0.94268  0.64134 -0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.9267
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TMEM161B-DT 

[1] 423
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 4        4     3.59    0.0476    0.0767
strata=LOW  8        8     8.41    0.0203    0.0767

 Chisq= 0.1  on 1 degrees of freedom, p= 0.8 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.1816    0.8339   0.6566 -0.277 0.782

Likelihood ratio test=0.08  on 1 df, p=0.7834
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PGD 

[1] 424
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2    0.737     2.167      2.49
strata=LOW  10       10   11.263     0.142      2.49

 Chisq= 2.5  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -1.2855    0.2765   0.8715 -1.475 0.14

Likelihood ratio test=1.82  on 1 df, p=0.1779
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD RHOT1 

[1] 425
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.86     0.701     0.966
strata=LOW  9        9    10.14     0.128     0.966

 Chisq= 1  on 1 degrees of freedom, p= 0.3 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.7406    0.4768   0.7701 -0.962 0.336

Likelihood ratio test=0.88  on 1 df, p=0.3491
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ACSL1 

[1] 426
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.38     1.904      2.41
strata=LOW  9        9    10.62     0.247      2.41

 Chisq= 2.4  on 1 degrees of freedom, p= 0.1 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -1.1420    0.3192   0.7739 -1.476 0.14

Likelihood ratio test=1.98  on 1 df, p=0.1593
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD NEDD4 

[1] 427
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     4.15     0.829      1.51
strata=LOW  6        6     7.85     0.438      1.51

 Chisq= 1.5  on 1 degrees of freedom, p= 0.2 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z    p
strataLOW -0.8021    0.4484   0.6681 -1.201 0.23

Likelihood ratio test=1.48  on 1 df, p=0.2234
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ELOVL5 

[1] 428
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        2     2.49    0.0959     0.132
strata=LOW  10       10     9.51    0.0251     0.132

 Chisq= 0.1  on 1 degrees of freedom, p= 0.7 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z     p
strataLOW 0.291     1.338    0.804 0.362 0.717

Likelihood ratio test=0.14  on 1 df, p=0.7098
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD YY1AP1 

[1] 429
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.98     0.521     0.741
strata=LOW  9        9    10.02     0.103     0.741

 Chisq= 0.7  on 1 degrees of freedom, p= 0.4 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z     p
strataLOW -0.6540    0.5200   0.7729 -0.846 0.397

Likelihood ratio test=0.68  on 1 df, p=0.4079
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

Display the results only for genes where a significant difference in survival has been reported.

significant_genes
 [1] "NQO1"         "ALOXE3"       "TTPA"         "ALOX12B"      "SLC1A5"       "PRKAA2"       "FADS1"        "PRR5"         "LINC01134"    "ARHGEF26-AS1" "SLC16A1-AS1" 
[12] "BRDT"         "AR"           "PROK2"        "LINC00886"   
num_significant_genes <- length(significant_genes)

if (num_significant_genes > 0) {
  for (i in 1 : num_significant_genes) {
    project <- significant_projects[[i]]
    gene <- significant_genes[[i]]
    
    cat(project, gene, "\n\n")
    gene_df <- construct_gene_df(gene, project)
    
    survival <- compute_survival_diff(gene_df)
    cox <- compute_cox(gene_df)
    print(survival)
    cat("\n")
    print(cox)
    print(plot_survival(fit))
    
    cat("\n\n============================\n\n")
  } 
}
TCGA-COAD NQO1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     2.76      3.81      6.07
strata=LOW  6        6     9.24      1.14      6.07

 Chisq= 6.1  on 1 degrees of freedom, p= 0.01 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.8171    0.1625   0.8307 -2.187 0.0287

Likelihood ratio test=5.72  on 1 df, p=0.01675
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALOXE3 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9    10.99      0.36      4.79
strata=LOW  3        3     1.01      3.91      4.79

 Chisq= 4.8  on 1 degrees of freedom, p= 0.03 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z      p
strataLOW 1.635     5.130    0.828 1.975 0.0483

Likelihood ratio test=3.55  on 1 df, p=0.05946
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD TTPA 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9   11.041     0.377      5.53
strata=LOW  3        3    0.959     4.345      5.53

 Chisq= 5.5  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.9221    6.8355   0.9345 2.057 0.0397

Likelihood ratio test=4.19  on 1 df, p=0.04074
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ALOX12B 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7        4      2.26      4.42
strata=LOW  5        5        8      1.13      4.42

 Chisq= 4.4  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.6134    0.1992   0.8327 -1.938 0.0527

Likelihood ratio test=4.57  on 1 df, p=0.03252
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC1A5 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5      2.2     3.543      5.05
strata=LOW  7        7      9.8     0.798      5.05

 Chisq= 5  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.5318    0.2162   0.7433 -2.061 0.0393

Likelihood ratio test=4.39  on 1 df, p=0.03613
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRKAA2 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11       11   11.826    0.0577      4.29
strata=LOW   1        1    0.174    3.9134      4.29

 Chisq= 4.3  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW  2.350    10.488    1.415 1.661 0.0966

Likelihood ratio test=2.29  on 1 df, p=0.1301
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD FADS1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 5        5     2.16     3.716      5.74
strata=LOW  7        7     9.84     0.818      5.74

 Chisq= 5.7  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.8615    0.1554   0.8684 -2.144 0.0321

Likelihood ratio test=5.23  on 1 df, p=0.0222
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PRR5 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3     1.01      3.91      4.79
strata=LOW  9        9    10.99      0.36      4.79

 Chisq= 4.8  on 1 degrees of freedom, p= 0.03 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.6350    0.1949   0.8280 -1.975 0.0483

Likelihood ratio test=3.55  on 1 df, p=0.05946
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC01134 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7      4.1      2.06      3.95
strata=LOW  5        5      7.9      1.07      3.95

 Chisq= 4  on 1 degrees of freedom, p= 0.05 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

             coef exp(coef) se(coef)      z      p
strataLOW -1.5001    0.2231   0.8177 -1.835 0.0666

Likelihood ratio test=4.1  on 1 df, p=0.0428
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD ARHGEF26-AS1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10       10    11.44     0.181      4.35
strata=LOW   2        2     0.56     3.708      4.35

 Chisq= 4.4  on 1 degrees of freedom, p= 0.04 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

           coef exp(coef) se(coef)     z      p
strataLOW 1.848     6.344    1.011 1.827 0.0676

Likelihood ratio test=2.97  on 1 df, p=0.08482
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD SLC16A1-AS1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 3        3    0.834      5.63      7.28
strata=LOW  9        9   11.166      0.42      7.28

 Chisq= 7.3  on 1 degrees of freedom, p= 0.007 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z      p
strataLOW -2.52855   0.07977  1.17716 -2.148 0.0317

Likelihood ratio test=5.57  on 1 df, p=0.01826
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD BRDT 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=8, 38 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 7        7    7.875    0.0972         7
strata=LOW  1        1    0.125    6.1250         7

 Chisq= 7  on 1 degrees of freedom, p= 0.008 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

               coef exp(coef)  se(coef)     z     p
strataLOW 2.200e+01 3.598e+09 2.267e+04 0.001 0.999

Likelihood ratio test=4.16  on 1 df, p=0.04142
n= 8, number of events= 8 
   (38 observations deleted due to missingness)


============================

TCGA-COAD AR 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 8        8    10.51     0.601      5.91
strata=LOW  4        4     1.49     4.247      5.91

 Chisq= 5.9  on 1 degrees of freedom, p= 0.02 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW 1.9195    6.8176   0.8941 2.147 0.0318

Likelihood ratio test=4.94  on 1 df, p=0.02617
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD PROK2 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 6        6     2.39      5.45      8.74
strata=LOW  6        6     9.61      1.36      8.74

 Chisq= 8.7  on 1 degrees of freedom, p= 0.003 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

              coef exp(coef) se(coef)      z      p
strataLOW -2.58808   0.07516  1.09935 -2.354 0.0186

Likelihood ratio test=8.48  on 1 df, p=0.003595
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================

TCGA-COAD LINC00886 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=12, 34 observations deleted due to missingness.

            N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 9        9   11.257     0.453      8.56
strata=LOW  3        3    0.743     6.857      8.56

 Chisq= 8.6  on 1 degrees of freedom, p= 0.003 

Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)

            coef exp(coef) se(coef)     z      p
strataLOW  2.647    14.107    1.170 2.263 0.0236

Likelihood ratio test=6.16  on 1 df, p=0.01303
n= 12, number of events= 12 
   (34 observations deleted due to missingness)


============================


  1. De La Salle University, Manila, Philippines, ↩︎

  2. De La Salle University, Manila, Philippines, ↩︎

LS0tDQp0aXRsZTogIlN1cnZpdmFsIEFuYWx5c2lzIg0Kc3VidGl0bGU6ICJDb2xvcmVjdGFsIENhbmNlciB8IEZlcnJvcHRvc2lzIHwgVW5pcXVlIEdlbmVzIHBlciBSQ0QgVHlwZSB8IExvZyBGb2xkIENoYW5nZSINCmF1dGhvcjogDQogIC0gTWFyayBFZHdhcmQgTS4gR29uemFsZXNeW0RlIExhIFNhbGxlIFVuaXZlcnNpdHksIE1hbmlsYSwgUGhpbGlwcGluZXMsIGdvbnphbGVzLm1hcmtlZHdhcmRAZ21haWwuY29tXQ0KICAtIERyLiBBbmlzaCBNLlMuIFNocmVzdGhhXltEZSBMYSBTYWxsZSBVbml2ZXJzaXR5LCBNYW5pbGEsIFBoaWxpcHBpbmVzLCBhbmlzaC5zaHJlc3RoYUBkbHN1LmVkdS5waF0NCm91dHB1dDogaHRtbF9ub3RlYm9vaw0KLS0tDQoNCiMjIEkuIFByZWxpbWluYXJpZXMNCg0KIyMjIExvYWRpbmcgbGlicmFyaWVzDQoNCmBgYHtyLCB3YXJuaW5nPUZBTFNFLCBtZXNzYWdlPUZBTFNFfQ0KbGlicmFyeSgidGlkeXZlcnNlIikNCmxpYnJhcnkoInRpYmJsZSIpDQpsaWJyYXJ5KCJtc2lnZGJyIikNCmxpYnJhcnkoImdncGxvdDIiKQ0KbGlicmFyeSgiVENHQWJpb2xpbmtzIikNCmxpYnJhcnkoIlJOQXNlcVFDIikNCmxpYnJhcnkoIkRFU2VxMiIpDQpsaWJyYXJ5KCJlbnNlbWJsZGIiKQ0KbGlicmFyeSgicHVycnIiKQ0KbGlicmFyeSgibWFncml0dHIiKQ0KbGlicmFyeSgidnNuIikNCmxpYnJhcnkoIm1hdHJpeFN0YXRzIikNCmxpYnJhcnkoImRwbHlyIikNCmxpYnJhcnkoImdyZXgiKQ0KbGlicmFyeSgic3Vydm1pbmVyIikNCmxpYnJhcnkoInN1cnZpdmFsIikNCmBgYA0KDQojIyBJSS4gRG93bmxvYWRpbmcgdGhlIFRDR0EgZ2VuZSBleHByZXNzaW9uIGRhdGEgDQoNCkNyZWF0ZSBhIGZ1bmN0aW9uIGZvciBkb3dubG9hZGluZyBUQ0dBIGdlbmUgZXhwcmVzc2lvbiBkYXRhLiANCg0KRm9yIG1vcmUgZGV0YWlsZWQgZG9jdW1lbnRhdGlvbiwgcmVmZXIgdG8gYDIuIERpZmZlcmVudGlhbCBHZW5lIEV4cHJlc3Npb24gQW5hbHlzaXMgLSBUQ0dBLlJtZGAuDQoNCmBgYHtyfQ0KR0RDX0RJUiA9ICIuLi9kYXRhL3B1YmxpYy9HRENkYXRhIg0KDQpxdWVyeV9hbmRfZmlsdGVyX3NhbXBsZXMgPC0gZnVuY3Rpb24ocHJvamVjdCkgew0KICBxdWVyeV90dW1vciA8LSBHRENxdWVyeSgNCiAgICBwcm9qZWN0ID0gcHJvamVjdCwNCiAgICBkYXRhLmNhdGVnb3J5ID0gIlRyYW5zY3JpcHRvbWUgUHJvZmlsaW5nIiwNCiAgICBkYXRhLnR5cGUgPSAiR2VuZSBFeHByZXNzaW9uIFF1YW50aWZpY2F0aW9uIiwNCiAgICBleHBlcmltZW50YWwuc3RyYXRlZ3kgPSAiUk5BLVNlcSIsDQogICAgd29ya2Zsb3cudHlwZSA9ICJTVEFSIC0gQ291bnRzIiwNCiAgICBhY2Nlc3MgPSAib3BlbiIsDQogICAgc2FtcGxlLnR5cGUgPSAiUHJpbWFyeSBUdW1vciINCiAgKQ0KICB0dW1vciA8LSBnZXRSZXN1bHRzKHF1ZXJ5X3R1bW9yKQ0KDQogIHF1ZXJ5X25vcm1hbCA8LSBHRENxdWVyeSgNCiAgICBwcm9qZWN0ID0gcHJvamVjdCwNCiAgICBkYXRhLmNhdGVnb3J5ID0gIlRyYW5zY3JpcHRvbWUgUHJvZmlsaW5nIiwNCiAgICBkYXRhLnR5cGUgPSAiR2VuZSBFeHByZXNzaW9uIFF1YW50aWZpY2F0aW9uIiwNCiAgICBleHBlcmltZW50YWwuc3RyYXRlZ3kgPSAiUk5BLVNlcSIsDQogICAgd29ya2Zsb3cudHlwZSA9ICJTVEFSIC0gQ291bnRzIiwNCiAgICBhY2Nlc3MgPSAib3BlbiIsDQogICAgc2FtcGxlLnR5cGUgPSAiU29saWQgVGlzc3VlIE5vcm1hbCINCiAgKQ0KICBub3JtYWwgPC0gZ2V0UmVzdWx0cyhxdWVyeV9ub3JtYWwpDQoNCiAgc3VibWl0dGVyX2lkcyA8LSBpbm5lcl9qb2luKHR1bW9yLCBub3JtYWwsIGJ5ID0gImNhc2VzLnN1Ym1pdHRlcl9pZCIpICU+JQ0KICAgIGRwbHlyOjpzZWxlY3QoY2FzZXMuc3VibWl0dGVyX2lkKQ0KICB0dW1vciA8LSB0dW1vciAlPiUNCiAgICBkcGx5cjo6ZmlsdGVyKGNhc2VzLnN1Ym1pdHRlcl9pZCAlaW4lIHN1Ym1pdHRlcl9pZHMkY2FzZXMuc3VibWl0dGVyX2lkKQ0KICBub3JtYWwgPC0gbm9ybWFsICU+JQ0KICAgIGRwbHlyOjpmaWx0ZXIoY2FzZXMuc3VibWl0dGVyX2lkICVpbiUgc3VibWl0dGVyX2lkcyRjYXNlcy5zdWJtaXR0ZXJfaWQpDQoNCiAgc2FtcGxlcyA8LSByYmluZCh0dW1vciwgbm9ybWFsKQ0KICB1bmlxdWUoc2FtcGxlcyRzYW1wbGVfdHlwZSkNCg0KICBxdWVyeV9wcm9qZWN0IDwtIEdEQ3F1ZXJ5KA0KICAgIHByb2plY3QgPSBwcm9qZWN0LA0KICAgIGRhdGEuY2F0ZWdvcnkgPSAiVHJhbnNjcmlwdG9tZSBQcm9maWxpbmciLA0KICAgIGRhdGEudHlwZSA9ICJHZW5lIEV4cHJlc3Npb24gUXVhbnRpZmljYXRpb24iLA0KICAgIGV4cGVyaW1lbnRhbC5zdHJhdGVneSA9ICJSTkEtU2VxIiwNCiAgICB3b3JrZmxvdy50eXBlID0gIlNUQVIgLSBDb3VudHMiLA0KICAgIGFjY2VzcyA9ICJvcGVuIiwNCiAgICBzYW1wbGUudHlwZSA9IGMoIlNvbGlkIFRpc3N1ZSBOb3JtYWwiLCAiUHJpbWFyeSBUdW1vciIpLA0KICAgIGJhcmNvZGUgPSBhcy5saXN0KHNhbXBsZXMkc2FtcGxlLnN1Ym1pdHRlcl9pZCkNCiAgKQ0KDQogICMgSWYgdGhpcyBpcyB5b3VyIGZpcnN0IHRpbWUgcnVubmluZyB0aGlzIG5vdGVib29rIChpLmUuLCB5b3UgaGF2ZSBub3QgeWV0IGRvd25sb2FkZWQgdGhlIHJlc3VsdHMgb2YgdGhlIHF1ZXJ5IGluIHRoZSBwcmV2aW91cyBibG9jayksDQogICMgdW5jb21tZW50IHRoZSBjb2RlIGJsb2NrIGJlbG93DQoNCiAgIyBHRENkb3dubG9hZCgNCiAgIyAgIHF1ZXJ5X2NvYWQsDQogICMgICBkaXJlY3RvcnkgPSBHRENfRElSDQogICMgKQ0KDQogIHJldHVybihsaXN0KHNhbXBsZXMgPSBzYW1wbGVzLCBxdWVyeV9wcm9qZWN0ID0gcXVlcnlfcHJvamVjdCkpDQp9DQpgYGANCg0KRG93bmxvYWQgdGhlIFRDR0EgZ2VuZSBleHByZXNzaW9uIGRhdGEgZm9yIGNvbG9yZWN0YWwgY2FuY2VyIChUQ0dBLUNPQUQpLg0KDQpgYGB7ciwgZWNobyA9IFRSVUUsIG1lc3NhZ2UgPSBGQUxTRSwgcmVzdWx0cz0iaGlkZSJ9DQpwcm9qZWN0cyA8LSBjKCJUQ0dBLUNPQUQiKQ0KDQp3aXRoX3Jlc3VsdHNfcHJvamVjdHMgPC0gYygpDQoNCnNhbXBsZXMgPC0gbGlzdCgpDQpwcm9qZWN0X2RhdGEgPC0gbGlzdCgpDQoNCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICByZXN1bHQgPC0gdHJ5Q2F0Y2goDQogICAgew0KICAgICAgcmVzdWx0IDwtIHF1ZXJ5X2FuZF9maWx0ZXJfc2FtcGxlcyhwcm9qZWN0KQ0KICAgICAgc2FtcGxlc1tbcHJvamVjdF1dIDwtIHJlc3VsdCRzYW1wbGVzDQogICAgICBwcm9qZWN0X2RhdGFbW3Byb2plY3RdXSA8LSByZXN1bHQkcXVlcnlfcHJvamVjdA0KDQogICAgICB3aXRoX3Jlc3VsdHNfcHJvamVjdHMgPC0gYyh3aXRoX3Jlc3VsdHNfcHJvamVjdHMsIHByb2plY3QpDQogICAgfSwNCiAgICBlcnJvciA9IGZ1bmN0aW9uKGUpIHsNCg0KICAgIH0NCiAgKQ0KfQ0KYGBgDQoNClJ1bm5pbmcgdGhlIGNvZGUgYmxvY2sgYWJvdmUgc2hvdWxkIGdlbmVyYXRlIGFuZCBwb3B1bGF0ZSBhIGRpcmVjdG9yeSBuYW1lZCBgR0RDZGF0YWAuDQoNCiMjIElJSS4gRGF0YSBwcmVwcm9jZXNzaW5nDQoNCkNvbnN0cnVjdCB0aGUgUk5BLXNlcSBjb3VudCBtYXRyaXggZm9yIGVhY2ggY2FuY2VyIHR5cGUuDQoNCmBgYHtyLCBlY2hvID0gVFJVRSwgbWVzc2FnZSA9IEZBTFNFLCByZXN1bHRzPSJoaWRlIn0NCnRjZ2FfZGF0YSA8LSBsaXN0KCkNCnRjZ2FfbWF0cml4IDwtIGxpc3QoKQ0KDQpwcm9qZWN0cyA8LSB3aXRoX3Jlc3VsdHNfcHJvamVjdHMNCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICB0Y2dhX2RhdGFbW3Byb2plY3RdXSA8LSBHRENwcmVwYXJlKA0KICAgIHByb2plY3RfZGF0YVtbcHJvamVjdF1dLCANCiAgICBkaXJlY3RvcnkgPSBHRENfRElSLA0KICAgIHN1bW1hcml6ZWRFeHBlcmltZW50ID0gVFJVRQ0KICApDQp9DQpgYGANCg0KYGBge3J9DQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgY291bnRfbWF0cml4IDwtIGFzc2F5KHRjZ2FfZGF0YVtbcHJvamVjdF1dLCAidW5zdHJhbmRlZCIpDQoNCiAgIyBSZW1vdmUgZHVwbGljYXRlIGVudHJpZXMNCiAgY291bnRfbWF0cml4X2RmIDwtIGRhdGEuZnJhbWUoY291bnRfbWF0cml4KQ0KICBjb3VudF9tYXRyaXhfZGYgPC0gY291bnRfbWF0cml4X2RmWyFkdXBsaWNhdGVkKGNvdW50X21hdHJpeF9kZiksIF0NCiAgY291bnRfbWF0cml4IDwtIGRhdGEubWF0cml4KGNvdW50X21hdHJpeF9kZikNCiAgcm93bmFtZXMoY291bnRfbWF0cml4KSA8LSBjbGVhbmlkKHJvd25hbWVzKGNvdW50X21hdHJpeCkpDQogIGNvdW50X21hdHJpeCA8LSBjb3VudF9tYXRyaXhbIShkdXBsaWNhdGVkKHJvd25hbWVzKGNvdW50X21hdHJpeCkpIHwgZHVwbGljYXRlZChyb3duYW1lcyhjb3VudF9tYXRyaXgpLCBmcm9tTGFzdCA9IFRSVUUpKSwgXQ0KDQogIHRjZ2FfbWF0cml4W1twcm9qZWN0XV0gPC0gY291bnRfbWF0cml4DQp9DQpgYGANCkZvcm1hdCB0aGUgYHNhbXBsZXNgIHRhYmxlIHNvIHRoYXQgaXQgY2FuIGJlIGZlZCBhcyBpbnB1dCB0byBERVNlcTIuDQoNCmBgYHtyfQ0KZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogIHJvd25hbWVzKHNhbXBsZXNbW3Byb2plY3RdXSkgPC0gc2FtcGxlc1tbcHJvamVjdF1dJGNhc2VzDQogIHNhbXBsZXNbW3Byb2plY3RdXSA8LSBzYW1wbGVzW1twcm9qZWN0XV0gJT4lDQogICAgZHBseXI6OnNlbGVjdChjYXNlID0gImNhc2VzLnN1Ym1pdHRlcl9pZCIsIHR5cGUgPSAic2FtcGxlX3R5cGUiKQ0KICBzYW1wbGVzW1twcm9qZWN0XV0kdHlwZSA8LSBzdHJfcmVwbGFjZShzYW1wbGVzW1twcm9qZWN0XV0kdHlwZSwgIlNvbGlkIFRpc3N1ZSBOb3JtYWwiLCAibm9ybWFsIikNCiAgc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUgPC0gc3RyX3JlcGxhY2Uoc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUsICJQcmltYXJ5IFR1bW9yIiwgInR1bW9yIikNCn0NCmBgYA0KDQpERVNlcTIgcmVxdWlyZXMgdGhlIHJvdyBuYW1lcyBvZiBgc2FtcGxlc2Agc2hvdWxkIGJlIGlkZW50aWNhbCB0byB0aGUgY29sdW1uIG5hbWVzIG9mIGBjb3VudF9tYXRyaXhgLg0KDQpgYGB7ciwgZWNobyA9IFRSVUUsIHJlc3VsdHM9ImhpZGUifQ0KZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogIGNvbG5hbWVzKHRjZ2FfbWF0cml4W1twcm9qZWN0XV0pIDwtIGdzdWIoeCA9IGNvbG5hbWVzKHRjZ2FfbWF0cml4W1twcm9qZWN0XV0pLCBwYXR0ZXJuID0gIlxcLiIsIHJlcGxhY2VtZW50ID0gIi0iKQ0KICB0Y2dhX21hdHJpeFtbcHJvamVjdF1dIDwtIHRjZ2FfbWF0cml4W1twcm9qZWN0XV1bLCByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pXQ0KDQogICMgU2FuaXR5IGNoZWNrDQogIHByaW50KGFsbChjb2xuYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSA9PSByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pKSkNCn0NCmBgYA0KDQojIyBJVi4gRGlmZmVyZW50aWFsIGdlbmUgZXhwcmVzc2lvbiBhbmFseXNpcw0KDQpGb3IgbW9yZSBkZXRhaWxlZCBkb2N1bWVudGF0aW9uIG9uIG9idGFpbmluZyB0aGUgZ2VuZSBzZXQsIHJlZmVyIHRvIGA3LiBEaWZmZXJlbnRpYWwgR2VuZSBFeHByZXNzaW9uIEFuYWx5c2lzIC0gVENHQSAtIFBhbi1jYW5jZXIgLSBVbmlxdWUgR2VuZXMuUm1kYC4NCg0KYGBge3J9DQpSQ0RkYiA8LSAiLi4vZGF0YS9wdWJsaWMvcmNkLWdlbmUtbGlzdC91bmlxdWUtZ2VuZXMvbmVjcm9wdG9zaXMtZmVycm9wdG9zaXMtcHlyb3B0b3Npcy8iDQpgYGANCg0KV3JpdGUgdXRpbGl0eSBmdW5jdGlvbnMgZm9yIGZpbHRlcmluZyB0aGUgZ2VuZSBzZXRzLCBwZXJmb3JtaW5nIGRpZmZlcmVudGlhbCBnZW5lIGV4cHJlc3Npb24gYW5hbHlzaXMsIHBsb3R0aW5nIHRoZSByZXN1bHRzLCBhbmQgcGVyZm9ybWluZyB2YXJpYW5jZS1zdGFiaWxpemluZyB0cmFuc2Zvcm1hdGlvbi4NCg0KYGBge3J9DQpmaWx0ZXJfZ2VuZV9zZXRfYW5kX3BlcmZvcm1fZGdlYSA8LSBmdW5jdGlvbihnZW5lcykgew0KICB0Y2dhX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICByb3duYW1lcyhnZW5lcykgPC0gZ2VuZXMkZ2VuZV9pZA0KICAgIHRjZ2FfcmNkW1twcm9qZWN0XV0gPC0gdGNnYV9tYXRyaXhbW3Byb2plY3RdXVtyb3duYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSAlaW4lIGdlbmVzJGdlbmVfaWQsIF0NCiAgICB0Y2dhX3JjZFtbcHJvamVjdF1dIDwtIHRjZ2FfcmNkW1twcm9qZWN0XV1bLCByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pXQ0KICB9DQoNCiAgZGRzX3JjZCA8LSBsaXN0KCkNCiAgcmVzX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICBwcmludChwcm9qZWN0KQ0KICAgIHByaW50KCI9PT09PT09PT09PT09IikNCiAgICBkZHMgPC0gREVTZXFEYXRhU2V0RnJvbU1hdHJpeCgNCiAgICAgIGNvdW50RGF0YSA9IHRjZ2FfcmNkW1twcm9qZWN0XV0sDQogICAgICBjb2xEYXRhID0gc2FtcGxlc1tbcHJvamVjdF1dLA0KICAgICAgZGVzaWduID0gfnR5cGUNCiAgICApDQogICAgZGRzIDwtIGZpbHRlcl9nZW5lcyhkZHMsIG1pbl9jb3VudCA9IDEwKQ0KICAgIGRkcyR0eXBlIDwtIHJlbGV2ZWwoZGRzJHR5cGUsIHJlZiA9ICJub3JtYWwiKQ0KICAgIGRkc19yY2RbW3Byb2plY3RdXSA8LSBERVNlcShkZHMpDQogICAgcmVzX3JjZFtbcHJvamVjdF1dIDwtIHJlc3VsdHMoZGRzX3JjZFtbcHJvamVjdF1dKQ0KICB9DQoNCiAgZGVzZXEuYmJsLmRhdGEgPC0gbGlzdCgpDQoNCiAgZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogICAgZGVzZXEucmVzdWx0cyA8LSByZXNfcmNkW1twcm9qZWN0XV0NCiAgICBkZXNlcS5iYmwuZGF0YVtbcHJvamVjdF1dIDwtIGRhdGEuZnJhbWUoDQogICAgICByb3cubmFtZXMgPSByb3duYW1lcyhkZXNlcS5yZXN1bHRzKSwNCiAgICAgIGJhc2VNZWFuID0gZGVzZXEucmVzdWx0cyRiYXNlTWVhbiwNCiAgICAgIGxvZzJGb2xkQ2hhbmdlID0gZGVzZXEucmVzdWx0cyRsb2cyRm9sZENoYW5nZSwNCiAgICAgIGxmY1NFID0gZGVzZXEucmVzdWx0cyRsZmNTRSwNCiAgICAgIHN0YXQgPSBkZXNlcS5yZXN1bHRzJHN0YXQsDQogICAgICBwdmFsdWUgPSBkZXNlcS5yZXN1bHRzJHB2YWx1ZSwNCiAgICAgIHBhZGogPSBkZXNlcS5yZXN1bHRzJHBhZGosDQogICAgICBjYW5jZXJfdHlwZSA9IHByb2plY3QsDQogICAgICBnZW5lX3N5bWJvbCA9IGdlbmVzW3Jvd25hbWVzKGRlc2VxLnJlc3VsdHMpLCAiZ2VuZSJdDQogICAgKQ0KICB9DQoNCiAgZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gYmluZF9yb3dzKGRlc2VxLmJibC5kYXRhKQ0KICBkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCA8LSBkcGx5cjo6ZmlsdGVyKGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkLCBhYnMobG9nMkZvbGRDaGFuZ2UpID49IDEuNSAmIHBhZGogPCAwLjA1KQ0KDQogIHJldHVybihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCkNCn0NCmBgYA0KDQpgYGB7cn0NCnBsb3RfZGdlYSA8LSBmdW5jdGlvbihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCkgew0KICBzaXplcyA8LSBjKCI8MTBeLTE1IiA9IDQsICIxMF4tMTAiID0gMywgIjEwXi01IiA9IDIsICIwLjA1IiA9IDEpDQoNCiAgZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgJT4lDQogICAgbXV0YXRlKGZkcl9jYXRlZ29yeSA9IGN1dChwYWRqLA0KICAgICAgYnJlYWtzID0gYygtSW5mLCAxZS0xNSwgMWUtMTAsIDFlLTUsIDAuMDUpLA0KICAgICAgbGFiZWxzID0gYygiPDEwXi0xNSIsICIxMF4tMTAiLCAiMTBeLTUiLCAiMC4wNSIpLA0KICAgICAgcmlnaHQgPSBGQUxTRQ0KICAgICkpDQoNCiAgdG9wX2dlbmVzIDwtIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkICU+JQ0KICAgIGdyb3VwX2J5KGNhbmNlcl90eXBlKSAlPiUNCiAgICBtdXRhdGUocmFuayA9IHJhbmsoLWFicyhsb2cyRm9sZENoYW5nZSkpKSAlPiUNCiAgICBkcGx5cjo6ZmlsdGVyKHJhbmsgPD0gMTApICU+JQ0KICAgIHVuZ3JvdXAoKQ0KDQogIGdncGxvdCh0b3BfZ2VuZXMsIGFlcyh5ID0gY2FuY2VyX3R5cGUsIHggPSBnZW5lX3N5bWJvbCwgc2l6ZSA9IGZkcl9jYXRlZ29yeSwgZmlsbCA9IGxvZzJGb2xkQ2hhbmdlKSkgKw0KICAgIGdlb21fcG9pbnQoYWxwaGEgPSAwLjUsIHNoYXBlID0gMjEsIGNvbG9yID0gImJsYWNrIikgKw0KICAgIHNjYWxlX3NpemVfbWFudWFsKHZhbHVlcyA9IHNpemVzKSArDQogICAgc2NhbGVfZmlsbF9ncmFkaWVudDIobG93ID0gImJsdWUiLCBtaWQgPSAid2hpdGUiLCBoaWdoID0gInJlZCIsIGxpbWl0cyA9IGMobWluKGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkJGxvZzJGb2xkQ2hhbmdlKSwgbWF4KGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkJGxvZzJGb2xkQ2hhbmdlKSkpICsNCiAgICB0aGVtZV9taW5pbWFsKCkgKw0KICAgIHRoZW1lKA0KICAgICAgYXhpcy50ZXh0LnggPSBlbGVtZW50X3RleHQoc2l6ZSA9IDksIGFuZ2xlID0gOTAsIGhqdXN0ID0gMSkNCiAgICApICsNCiAgICB0aGVtZShsZWdlbmQucG9zaXRpb24gPSAiYm90dG9tIikgKw0KICAgIHRoZW1lKGxlZ2VuZC5wb3NpdGlvbiA9ICJib3R0b20iKSArDQogICAgbGFicyhzaXplID0gIkFkanVzdGVkIHAtdmFsdWUiLCBmaWxsID0gImxvZzIgRkMiLCB5ID0gIkNhbmNlciB0eXBlIiwgeCA9ICJHZW5lIikNCn0NCmBgYA0KDQpgYGB7cn0NCnBlcmZvcm1fdnNkIDwtIGZ1bmN0aW9uKGdlbmVzKSB7DQogIHRjZ2FfcmNkIDwtIGxpc3QoKQ0KDQogIGZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICAgIHJvd25hbWVzKGdlbmVzKSA8LSBnZW5lcyRnZW5lX2lkDQogICAgdGNnYV9yY2RbW3Byb2plY3RdXSA8LSB0Y2dhX21hdHJpeFtbcHJvamVjdF1dW3Jvd25hbWVzKHRjZ2FfbWF0cml4W1twcm9qZWN0XV0pICVpbiUgZ2VuZXMkZ2VuZV9pZCwgXQ0KICAgIHRjZ2FfcmNkW1twcm9qZWN0XV0gPC0gdGNnYV9yY2RbW3Byb2plY3RdXVssIHJvd25hbWVzKHNhbXBsZXNbW3Byb2plY3RdXSldDQogIH0NCg0KICB2c2RfcmNkIDwtIGxpc3QoKQ0KDQogIGZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICAgIHByaW50KHByb2plY3QpDQogICAgcHJpbnQoIj09PT09PT09PT09PT0iKQ0KICAgIGRkcyA8LSBERVNlcURhdGFTZXRGcm9tTWF0cml4KA0KICAgICAgY291bnREYXRhID0gdGNnYV9yY2RbW3Byb2plY3RdXSwNCiAgICAgIGNvbERhdGEgPSBzYW1wbGVzW1twcm9qZWN0XV0sDQogICAgICBkZXNpZ24gPSB+dHlwZQ0KICAgICkNCiAgICBkZHMgPC0gZmlsdGVyX2dlbmVzKGRkcywgbWluX2NvdW50ID0gMTApDQoNCiAgICAjIFBlcmZvcm0gdmFyaWFuY2Ugc3RhYmlsaXphdGlvbg0KICAgIGRkcyA8LSBlc3RpbWF0ZVNpemVGYWN0b3JzKGRkcykNCiAgICBuc3ViIDwtIHN1bShyb3dNZWFucyhjb3VudHMoZGRzLCBub3JtYWxpemVkID0gVFJVRSkpID4gMTApDQogICAgdnNkIDwtIHZzdChkZHMsIG5zdWIgPSBuc3ViKQ0KICAgIHZzZF9yY2RbW3Byb2plY3RdXSA8LSBhc3NheSh2c2QpDQogIH0NCg0KICByZXR1cm4odnNkX3JjZCkNCn0NCmBgYA0KDQoNCiMjIyMgRmVycm9wdG9zaXMNCg0KRmV0Y2ggdGhlIGdlbmUgc2V0IG9mIGludGVyZXN0Lg0KDQpgYGB7cn0NCmdlbmVzIDwtIHJlYWQuY3N2KHBhc3RlMChSQ0RkYiwgIkZlcnJvcHRvc2lzLmNzdiIpKQ0KcHJpbnQoZ2VuZXMpDQpnZW5lcyRnZW5lX2lkIDwtIGNsZWFuaWQoZ2VuZXMkZ2VuZV9pZCkNCmdlbmVzIDwtIGRpc3RpbmN0KGdlbmVzLCBnZW5lX2lkLCAua2VlcF9hbGwgPSBUUlVFKQ0KZ2VuZXMgPC0gc3Vic2V0KGdlbmVzLCBnZW5lX2lkICE9ICIiKQ0KZ2VuZXMNCmBgYA0KDQpGaWx0ZXIgdGhlIGdlbmVzIHRvIGluY2x1ZGUgb25seSB0aG9zZSBpbiB0aGUgZ2VuZSBzZXQgb2YgaW50ZXJlc3QsIGFuZCB0aGVuIHBlcmZvcm0gZGlmZmVyZW50aWFsIGdlbmUgZXhwcmVzc2lvbiBhbmFseXNpcy4NCg0KYGBge3J9DQpkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCA8LSBmaWx0ZXJfZ2VuZV9zZXRfYW5kX3BlcmZvcm1fZGdlYShnZW5lcykNCmRlc2VxLmJibC5kYXRhLmNvbWJpbmVkDQpgYGANCg0KUGxvdCB0aGUgcmVzdWx0cy4NCg0KYGBge3J9DQpwbG90X2RnZWEoZGVzZXEuYmJsLmRhdGEuY29tYmluZWQpDQpgYGANClBlcmZvcm0gdmFyaWFuY2Utc3RhYmlsaXppbmcgdHJhbnNmb3JtYXRpb24gZm9yIGZ1cnRoZXIgZG93bnN0cmVhbSBhbmFseXNpcyAoaS5lLiwgZm9yIHN1cnZpdmFsIGFuYWx5c2lzKS4NCg0KYGBge3IsIHdhcm5pbmc9RkFMU0V9DQp2c2QgPC0gcGVyZm9ybV92c2QoZ2VuZXMpDQpgYGANCg0KIyMgVi4gRG93bmxvYWRpbmcgdGhlIGNsaW5pY2FsIGRhdGENCg0KRG93bmxvYWQgY2xpbmljYWwgZGF0YSBmcm9tIFRDR0EsIGFuZCBwZXJmb3JtIHNvbWUgcHJlcHJvY2Vzc2luZzoNCi0gVGhlIGBkZWNlYXNlZGAgY29sdW1uIHNob3VsZCBiZSBgRkFMU0VgIGlmIHRoZSBwYXRpZW50IGlzIGFsaXZlIGFuZCBgVFJVRWAgb3RoZXJ3aXNlDQotIFRoZSBgb3ZlcmFsbF9zdXJ2aXZhbGAgY29sdW1uIHNob3VsZCByZWZsZWN0IHRoZSBmb2xsb3ctdXAgdGltZSBpZiB0aGUgcGF0aWVudCBpcyBhbGl2ZSBhbmQgdGhlIGRheXMgdG8gZGVhdGggb3RoZXJ3aXNlDQoNCmBgYHtyfQ0KZG93bmxvYWRfY2xpbmljYWxfZGF0YSA8LSBmdW5jdGlvbihwcm9qZWN0KSB7DQogIGNsaW5pY2FsX2RhdGEgPC0gR0RDcXVlcnlfY2xpbmljKHByb2plY3QpDQogIGNsaW5pY2FsX2RhdGEkZGVjZWFzZWQgPC0gaWZlbHNlKGNsaW5pY2FsX2RhdGEkdml0YWxfc3RhdHVzID09ICJBbGl2ZSIsIEZBTFNFLCBUUlVFKQ0KICBjbGluaWNhbF9kYXRhJG92ZXJhbGxfc3Vydml2YWwgPC0gaWZlbHNlKGNsaW5pY2FsX2RhdGEkdml0YWxfc3RhdHVzID09ICJBbGl2ZSIsDQogICAgY2xpbmljYWxfZGF0YSRkYXlzX3RvX2xhc3RfZm9sbG93X3VwLA0KICAgIGNsaW5pY2FsX2RhdGEkZGF5c190b19kZWF0aA0KICApDQoNCiAgcmV0dXJuKGNsaW5pY2FsX2RhdGEpDQp9DQpgYGANCg0KYGBge3J9DQp0Y2dhX2NsaW5pY2FsIDwtIGxpc3QoKQ0KZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogIHRjZ2FfY2xpbmljYWxbW3Byb2plY3RdXSA8LSBkb3dubG9hZF9jbGluaWNhbF9kYXRhKHByb2plY3QpDQp9DQpgYGANCg0KIyMgVkkuIFBlcmZvcm1pbmcgc3Vydml2YWwgYW5hbHlzaXMNCg0KV3JpdGUgdXRpbGl0eSBmdW5jdGlvbnMgZm9yIHBlcmZvcm1pbmcgc3Vydml2YWwgYW5hbHlzaXMuDQoNCg0KYGBge3J9DQpjb25zdHJ1Y3RfZ2VuZV9kZiA8LSBmdW5jdGlvbihnZW5lX29mX2ludGVyZXN0LCBwcm9qZWN0KSB7DQogIG5vcm1hbF9kZiA8LSB0Y2dhX21hdHJpeFtbcHJvamVjdF1dICU+JQ0KICAgIGFzLmRhdGEuZnJhbWUoKSAlPiUNCiAgICByb3duYW1lc190b19jb2x1bW4odmFyID0gImdlbmVfaWQiKSAlPiUNCiAgICBnYXRoZXIoa2V5ID0gImNhc2VfaWQiLCB2YWx1ZSA9ICJjb3VudHMiLCAtZ2VuZV9pZCkgJT4lDQogICAgbGVmdF9qb2luKC4sIGdlbmVzLCBieSA9ICJnZW5lX2lkIikgJT4lDQogICAgZHBseXI6OmZpbHRlcihnZW5lID09IGdlbmVfb2ZfaW50ZXJlc3QpICU+JQ0KICAgIGRwbHlyOjpmaWx0ZXIoY2FzZV9pZCAlaW4lIHJvd25hbWVzKHNhbXBsZXNbW3Byb2plY3RdXSAlPiUgZHBseXI6OmZpbHRlcih0eXBlID09ICJub3JtYWwiKSkpDQogIG5vcm1hbF9kZiRjYXNlX2lkIDwtIHBhc3RlMChzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKG5vcm1hbF9kZiRjYXNlX2lkKSwgIi0iKSwgYFtgLCAxKSwgJy0nLA0KICAgICAgICAgICAgICAgICAgICAgICAgICAgIHNhcHBseShzdHJzcGxpdChhcy5jaGFyYWN0ZXIobm9ybWFsX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDIpLCAnLScsIA0KICAgICAgICAgICAgICAgICAgICAgICAgICAgIHNhcHBseShzdHJzcGxpdChhcy5jaGFyYWN0ZXIobm9ybWFsX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDMpKQ0KICANCiAgdHVtb3JfZGYgPC0gdGNnYV9tYXRyaXhbW3Byb2plY3RdXSAlPiUNCiAgICAgIGFzLmRhdGEuZnJhbWUoKSAlPiUNCiAgICAgIHJvd25hbWVzX3RvX2NvbHVtbih2YXIgPSAiZ2VuZV9pZCIpICU+JQ0KICAgICAgZ2F0aGVyKGtleSA9ICJjYXNlX2lkIiwgdmFsdWUgPSAiY291bnRzIiwgLWdlbmVfaWQpICU+JQ0KICAgICAgbGVmdF9qb2luKC4sIGdlbmVzLCBieSA9ICJnZW5lX2lkIikgJT4lDQogICAgICBkcGx5cjo6ZmlsdGVyKGdlbmUgPT0gZ2VuZV9vZl9pbnRlcmVzdCkgJT4lDQogICAgICBkcGx5cjo6ZmlsdGVyKGNhc2VfaWQgJWluJSByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0gJT4lIGRwbHlyOjpmaWx0ZXIodHlwZSA9PSAidHVtb3IiKSkpDQogIHR1bW9yX2RmJGNhc2VfaWQgPC0gcGFzdGUwKHNhcHBseShzdHJzcGxpdChhcy5jaGFyYWN0ZXIodHVtb3JfZGYkY2FzZV9pZCksICItIiksIGBbYCwgMSksICctJywNCiAgICAgICAgICAgICAgICAgICAgICAgICAgICBzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKHR1bW9yX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDIpLCAnLScsIA0KICAgICAgICAgICAgICAgICAgICAgICAgICAgIHNhcHBseShzdHJzcGxpdChhcy5jaGFyYWN0ZXIodHVtb3JfZGYkY2FzZV9pZCksICItIiksIGBbYCwgMykpDQogIA0KICBnZW5lX2RmIDwtIGlubmVyX2pvaW4obm9ybWFsX2RmLCB0dW1vcl9kZiwgYnkgPSBjKCJnZW5lX2lkIiwgImNhc2VfaWQiLCAiZGVhdGh0eXBlIiwgImdlbmUiLCAiZGVzY3JpcHRpb24iLCAiZ2VuZV9iaW90eXBlIiwgInBtaWQiLCAiY29tbWVudCIpKQ0KICBnZW5lX2RmJGxvZ19mb2xkID0gbG9nMihnZW5lX2RmJGNvdW50cy55IC8gZ2VuZV9kZiRjb3VudHMueCkNCiAgDQogIGdlbmVfZGYkc3RyYXRhIDwtIGlmZWxzZShhYnMoZ2VuZV9kZiRsb2dfZm9sZCkgPj0gMS41LCAiSElHSCIsICJMT1ciKQ0KICBnZW5lX2RmIDwtIG1lcmdlKGdlbmVfZGYsIHRjZ2FfY2xpbmljYWxbW3Byb2plY3RdXSwgYnkueCA9ICJjYXNlX2lkIiwgYnkueSA9ICJzdWJtaXR0ZXJfaWQiKQ0KICANCiAgcmV0dXJuKGdlbmVfZGYpDQp9DQpgYGANCg0KYGBge3J9DQpjb21wdXRlX3N1cml2YWxfZml0IDwtIGZ1bmN0aW9uKGdlbmVfZGYpIHsNCiAgcmV0dXJuIChzdXJ2Zml0KFN1cnYob3ZlcmFsbF9zdXJ2aXZhbCwgZGVjZWFzZWQpIH4gc3RyYXRhLCBkYXRhID0gZ2VuZV9kZikpDQp9DQpgYGANCg0KYGBge3J9DQpjb21wdXRlX2NveCA8LSBmdW5jdGlvbihnZW5lX2RmKSB7DQogIHJldHVybiAoY294cGgoU3VydihvdmVyYWxsX3N1cnZpdmFsLCBkZWNlYXNlZCkgfiBzdHJhdGEsIGRhdGE9Z2VuZV9kZikpDQp9DQpgYGANCg0KYGBge3J9DQpwbG90X3N1cnZpdmFsIDwtIGZ1bmN0aW9uKGZpdCkgew0KICByZXR1cm4oZ2dzdXJ2cGxvdChmaXQsDQogICAgZGF0YSA9IGdlbmVfZGYsDQogICAgcHZhbCA9IFQsDQogICAgcmlzay50YWJsZSA9IFQsDQogICAgcmlzay50YWJsZS5oZWlnaHQgPSAwLjMNCiAgKSkNCn0NCmBgYA0KDQpgYGB7cn0NCmNvbXB1dGVfc3Vydml2YWxfZGlmZiA8LSBmdW5jdGlvbihnZW5lX2RmKSB7DQogIHJldHVybihzdXJ2ZGlmZihTdXJ2KG92ZXJhbGxfc3Vydml2YWwsIGRlY2Vhc2VkKSB+IHN0cmF0YSwgZGF0YSA9IGdlbmVfZGYpKQ0KfQ0KYGBgDQoNClBlcmZvcm0gc3Vydml2YWwgYW5hbHlzaXMgYnkgdGVzdGluZyBmb3IgdGhlIGRpZmZlcmVuY2UgaW4gdGhlIEthcGxhbi1NZWllciBjdXJ2ZXMgdXNpbmcgdGhlIEctcmhvIGZhbWlseSBvZiBIYXJyaW5ndG9uIGFuZCBGbGVtaW5nIHRlc3RzOiBodHRwczovL3JkcnIuaW8vY3Jhbi9zdXJ2aXZhbC9tYW4vc3VydmRpZmYuaHRtbA0KDQpPdXIgZ2VuZXMgb2YgaW50ZXJlc3QgYXJlIHRoZSBkaWZmZXJlbnRpYWxseSBleHByZXNzZWQgZ2VuZXMuDQoNCmBgYHtyfQ0Kc2lnbmlmaWNhbnRfcHJvamVjdHMgPC0gYygpDQpzaWduaWZpY2FudF9nZW5lcyA8LSBjKCkNCg0KY3RyIDwtIDENCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICBmb3IgKGdlbmUgaW4gYyhnZW5lcyRnZW5lKSkgew0KICAgIGNhdChwcm9qZWN0LCBnZW5lLCAiXG5cbiIpDQogICAgZXJyb3IgPC0gdHJ5Q2F0Y2ggKA0KICAgICAgew0KICAgICAgICBnZW5lX2RmIDwtIGNvbnN0cnVjdF9nZW5lX2RmKGdlbmUsIHByb2plY3QpDQogICAgICB9LA0KICAgICAgZXJyb3IgPSBmdW5jdGlvbihlKSB7DQogICAgICAgIGNhdCgiXG5cbj09PT09PT09PT09PT09PT09PT09PT09PT09PT1cblxuIikNCiAgICAgICAgZQ0KICAgICAgfQ0KICAgICkNCiAgICANCiAgICBpZihpbmhlcml0cyhlcnJvciwgImVycm9yIikpIG5leHQNCg0KICAgIGlmIChucm93KGdlbmVfZGYpID4gMCkgew0KICAgICAgdHJ5Q2F0Y2ggKA0KICAgICAgICB7DQogICAgICAgICAgZml0IDwtIGNvbXB1dGVfc3VyaXZhbF9maXQoZ2VuZV9kZikNCiAgICAgICAgICBzdXJ2aXZhbCA8LSBjb21wdXRlX3N1cnZpdmFsX2RpZmYoZ2VuZV9kZikNCiAgICAgICAgICBjb3ggPC0gY29tcHV0ZV9jb3goZ2VuZV9kZikNCiAgICAgICAgICBwcmludChjdHIpDQogICAgICAgICAgY3RyIDwtIGN0ciArIDENCiAgICAgICAgICBwcmludChzdXJ2aXZhbCkNCiAgICAgICAgICBjYXQoIlxuIikNCiAgICAgICAgICBwcmludChjb3gpDQogICAgICAgICAgcHJpbnQocGxvdF9zdXJ2aXZhbChmaXQpKQ0KICAgICAgICAgIGlmIChwY2hpc3Eoc3Vydml2YWwkY2hpc3EsIGxlbmd0aChzdXJ2aXZhbCRuKS0xLCBsb3dlci50YWlsID0gRkFMU0UpIDwgMC4wNSkgew0KICAgICAgICAgICAgc2lnbmlmaWNhbnRfcHJvamVjdHMgPC0gYyhzaWduaWZpY2FudF9wcm9qZWN0cywgcHJvamVjdCkNCiAgICAgICAgICAgIHNpZ25pZmljYW50X2dlbmVzIDwtIGMoc2lnbmlmaWNhbnRfZ2VuZXMsIGdlbmUpDQogICAgICAgICAgfQ0KICAgICAgICB9LA0KICAgICAgICBlcnJvciA9IGZ1bmN0aW9uKGUpIHsNCiAgICAgICAgfQ0KICAgICAgKQ0KICAgICAgDQogICAgfQ0KICAgIA0KICAgIGNhdCgiXG5cbj09PT09PT09PT09PT09PT09PT09PT09PT09PT1cblxuIikNCiAgfQ0KfQ0KYGBgDQoNCkRpc3BsYXkgdGhlIHJlc3VsdHMgb25seSBmb3IgZ2VuZXMgd2hlcmUgYSBzaWduaWZpY2FudCBkaWZmZXJlbmNlIGluIHN1cnZpdmFsIGhhcyBiZWVuIHJlcG9ydGVkLg0KDQpgYGB7cn0NCnNpZ25pZmljYW50X2dlbmVzDQpgYGANCg0KYGBge3J9DQpudW1fc2lnbmlmaWNhbnRfZ2VuZXMgPC0gbGVuZ3RoKHNpZ25pZmljYW50X2dlbmVzKQ0KDQppZiAobnVtX3NpZ25pZmljYW50X2dlbmVzID4gMCkgew0KICBmb3IgKGkgaW4gMSA6IG51bV9zaWduaWZpY2FudF9nZW5lcykgew0KICAgIHByb2plY3QgPC0gc2lnbmlmaWNhbnRfcHJvamVjdHNbW2ldXQ0KICAgIGdlbmUgPC0gc2lnbmlmaWNhbnRfZ2VuZXNbW2ldXQ0KICAgIA0KICAgIGNhdChwcm9qZWN0LCBnZW5lLCAiXG5cbiIpDQogICAgZ2VuZV9kZiA8LSBjb25zdHJ1Y3RfZ2VuZV9kZihnZW5lLCBwcm9qZWN0KQ0KICAgIA0KICAgIHN1cnZpdmFsIDwtIGNvbXB1dGVfc3Vydml2YWxfZGlmZihnZW5lX2RmKQ0KICAgIGNveCA8LSBjb21wdXRlX2NveChnZW5lX2RmKQ0KICAgIHByaW50KHN1cnZpdmFsKQ0KICAgIGNhdCgiXG4iKQ0KICAgIHByaW50KGNveCkNCiAgICBwcmludChwbG90X3N1cnZpdmFsKGZpdCkpDQogICAgDQogICAgY2F0KCJcblxuPT09PT09PT09PT09PT09PT09PT09PT09PT09PVxuXG4iKQ0KICB9IA0KfQ0KYGBg