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.

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 line below

  # GDCdownload(query_project)

  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]], 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 <- "temp/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) {
      fit <- compute_surival_fit(gene_df)
      tryCatch (
        {
          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 Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 38        9    10.62     0.246      2.25
strata=LOW   8        3     1.38     1.891      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.0275    2.7940   0.7142 1.439 0.15

Likelihood ratio test=1.81  on 1 df, p=0.1791
n= 46, number of events= 12 


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

TCGA-COAD TFAM 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.82    0.2362     0.334
strata=LOW  34       10     9.18    0.0724     0.334

 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.4556    1.5771   0.7952 0.573 0.567

Likelihood ratio test=0.36  on 1 df, p=0.55
n= 46, number of events= 12 


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

TCGA-COAD CREB5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        3     4.95     0.766      1.52
strata=LOW  26        9     7.05     0.538      1.52

 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.9363    2.5505   0.7856 1.192 0.233

Likelihood ratio test=1.69  on 1 df, p=0.1931
n= 46, number of events= 12 


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

TCGA-COAD NOS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        7     6.93  0.000614   0.00158
strata=LOW  20        5     5.07  0.000840   0.00158

 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.02426   0.97604  0.61006 -0.04 0.968

Likelihood ratio test=0  on 1 df, p=0.9683
n= 46, number of events= 12 


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

TCGA-COAD HULC  

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     3.95     0.229     0.365
strata=LOW  28        9     8.05     0.112     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.4104    1.5075   0.6837 0.6 0.548

Likelihood ratio test=0.38  on 1 df, p=0.5373
n= 46, number of events= 12 


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

TCGA-COAD PLXNB2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.52    0.0774     0.122
strata=LOW  32        9     8.48    0.0321     0.122

 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.2435    1.2757   0.6974 0.349 0.727

Likelihood ratio test=0.13  on 1 df, p=0.7232
n= 46, number of events= 12 


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

TCGA-COAD KIF20A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        7     6.89   0.00167   0.00442
strata=LOW  23        5     5.11   0.00225   0.00442

 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.04123   0.95961  0.62022 -0.066 0.947

Likelihood ratio test=0  on 1 df, p=0.947
n= 46, number of events= 12 


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

TCGA-COAD TIMP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        8     7.08     0.119     0.319
strata=LOW  20        4     4.92     0.171     0.319

 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.3566    0.7001   0.6345 -0.562 0.574

Likelihood ratio test=0.32  on 1 df, p=0.5693
n= 46, number of events= 12 


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

TCGA-COAD MIR615 



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

TCGA-COAD MIR93 

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

n=43, 3 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        5      6.5     0.347       0.9
strata=LOW  17        7      5.5     0.411       0.9

 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.5806    1.7871   0.6195 0.937 0.349

Likelihood ratio test=0.88  on 1 df, p=0.3488
n= 43, number of events= 12 
   (3 observations deleted due to missingness)


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

TCGA-COAD ENO3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        2     1.28    0.4003     0.461
strata=LOW  39       10    10.72    0.0479     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.5314    0.5878   0.7922 -0.671 0.502

Likelihood ratio test=0.4  on 1 df, p=0.5253
n= 46, number of events= 12 


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

TCGA-COAD MMD 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     2.39    0.1573     0.209
strata=LOW  34        9     9.61    0.0391     0.209

 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.3157    0.7293   0.6940 -0.455 0.649

Likelihood ratio test=0.2  on 1 df, p=0.6563
n= 46, number of events= 12 


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

TCGA-COAD NQO1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        6     4.49     0.510     0.872
strata=LOW  25        6     7.51     0.304     0.872

 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.5629    0.5696   0.6103 -0.922 0.356

Likelihood ratio test=0.85  on 1 df, p=0.3552
n= 46, number of events= 12 


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

TCGA-COAD MARCHF5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        3     2.45    0.1240     0.165
strata=LOW  36        9     9.55    0.0318     0.165

 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.2796    0.7561   0.6912 -0.405 0.686

Likelihood ratio test=0.16  on 1 df, p=0.6916
n= 46, number of events= 12 


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

TCGA-COAD JUN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     2.99     0.344     0.503
strata=LOW  29        8     9.01     0.114     0.503

 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.4606    0.6309   0.6551 -0.703 0.482

Likelihood ratio test=0.48  on 1 df, p=0.4897
n= 46, number of events= 12 


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

TCGA-COAD ALDH3A2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     4.34     0.412     0.699
strata=LOW  30        9     7.66     0.233     0.699

 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.5650    1.7595   0.6843 0.826 0.409

Likelihood ratio test=0.73  on 1 df, p=0.3921
n= 46, number of events= 12 


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

TCGA-COAD ALOX5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        6     6.86     0.107     0.268
strata=LOW  25        6     5.14     0.142     0.268

 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.3128    1.3672   0.6066 0.516 0.606

Likelihood ratio test=0.27  on 1 df, p=0.6051
n= 46, number of events= 12 


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

TCGA-COAD PARP9 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     4.92     0.751      1.55
strata=LOW  33        9     7.08     0.523      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.9637    2.6213   0.7998 1.205 0.228

Likelihood ratio test=1.72  on 1 df, p=0.1892
n= 46, number of events= 12 


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

TCGA-COAD GLRX5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.39    0.0457    0.0695
strata=LOW  32        9     8.61    0.0180    0.0695

 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.1820    1.1997   0.6916 0.263 0.792

Likelihood ratio test=0.07  on 1 df, p=0.79
n= 46, number of events= 12 


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

TCGA-COAD METTL14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3      3.8    0.1691     0.275
strata=LOW  30        9      8.2    0.0784     0.275

 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.3615    1.4354   0.6927 0.522 0.602

Likelihood ratio test=0.28  on 1 df, p=0.5939
n= 46, number of events= 12 


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

TCGA-COAD TOR2A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.98     0.320     0.462
strata=LOW  35       10     9.02     0.106     0.462

 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.5339    1.7056   0.7944 0.672 0.502

Likelihood ratio test=0.5  on 1 df, p=0.4802
n= 46, number of events= 12 


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

TCGA-COAD PARP14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        3     4.83     0.691      1.23
strata=LOW  27        9     7.17     0.465      1.23

 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.7368    2.0893   0.6780 1.087 0.277

Likelihood ratio test=1.3  on 1 df, p=0.2547
n= 46, number of events= 12 


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

TCGA-COAD MIR130B 



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

TCGA-COAD CERS6-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        5     5.52    0.0481     0.134
strata=LOW  33        7     6.48    0.0410     0.134

 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.2735    1.3145   0.7482 0.365 0.715

Likelihood ratio test=0.14  on 1 df, p=0.7098
n= 46, number of events= 12 


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

TCGA-COAD NFS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     2.65    0.0465    0.0641
strata=LOW  33        9     9.35    0.0132    0.0641

 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.1759    0.8387   0.6955 -0.253 0.8

Likelihood ratio test=0.06  on 1 df, p=0.8026
n= 46, number of events= 12 


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

TCGA-COAD SLC3A2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3      2.5    0.0990      0.13
strata=LOW  33        9      9.5    0.0261      0.13

 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.2454    0.7824   0.6824 -0.36 0.719

Likelihood ratio test=0.12  on 1 df, p=0.7242
n= 46, number of events= 12 


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

TCGA-COAD ZFAS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        7     5.34     0.514      1.01
strata=LOW  21        5     6.66     0.412      1.01

 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.6252    0.5352   0.6309 -0.991 0.322

Likelihood ratio test=1.02  on 1 df, p=0.3118
n= 46, number of events= 12 


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

TCGA-COAD PANX1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2     1.67    0.0645    0.0777
strata=LOW  38       10    10.33    0.0104    0.0777

 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.2202    0.8023   0.7920 -0.278 0.781

Likelihood ratio test=0.07  on 1 df, p=0.7856
n= 46, number of events= 12 


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

TCGA-COAD HSPB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     4.87     0.155     0.312
strata=LOW  30        8     7.13     0.106     0.312

 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.3813    1.4642   0.6864 0.555 0.579

Likelihood ratio test=0.32  on 1 df, p=0.5691
n= 46, number of events= 12 


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

TCGA-COAD CREB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2     3.02     0.347     0.507
strata=LOW  33       10     8.98     0.117     0.507

 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.5594    1.7497   0.7957 0.703 0.482

Likelihood ratio test=0.55  on 1 df, p=0.4594
n= 46, number of events= 12 


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

TCGA-COAD EZH2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        6     6.03  0.000141  0.000316
strata=LOW  26        6     5.97  0.000142  0.000316

 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.01085   1.01091  0.61035 0.018 0.986

Likelihood ratio test=0  on 1 df, p=0.9858
n= 46, number of events= 12 


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

TCGA-COAD SLC40A1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4     4.11   0.00290   0.00498
strata=LOW  27        8     7.89   0.00151   0.00498

 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.04581   1.04687  0.64894 0.071 0.944

Likelihood ratio test=0  on 1 df, p=0.9436
n= 46, number of events= 12 


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

TCGA-COAD PAQR3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2      2.5    0.0994     0.134
strata=LOW  35       10      9.5    0.0261     0.134

 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.2901    1.3366   0.7948 0.365 0.715

Likelihood ratio test=0.14  on 1 df, p=0.7075
n= 46, number of events= 12 


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

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 Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        3     6.23      1.67      3.94
strata=LOW  20        9     5.77      1.80      3.94

 Chisq= 3.9  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.2699    3.5606   0.6818 1.863 0.0625

Likelihood ratio test=3.96  on 1 df, p=0.04665
n= 46, number of events= 12 


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

TCGA-COAD DHODH 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1     1.72      0.30     0.363
strata=LOW  39       11    10.28      0.05     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.6263    1.8707   1.0558 0.593 0.553

Likelihood ratio test=0.42  on 1 df, p=0.5193
n= 46, number of events= 12 


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

TCGA-COAD PTPN18 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.77    0.1588     0.263
strata=LOW  29        9     8.23    0.0729     0.263

 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.3561    1.4277   0.6982 0.51 0.61

Likelihood ratio test=0.27  on 1 df, p=0.6028
n= 46, number of events= 12 


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

TCGA-COAD IARS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2     2.89    0.2754     0.376
strata=LOW  33       10     9.11    0.0875     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.4763    1.6101   0.7838 0.608 0.543

Likelihood ratio test=0.41  on 1 df, p=0.5237
n= 46, number of events= 12 


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

TCGA-COAD IL4R 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.49    0.0533    0.0981
strata=LOW  26        8     7.51    0.0318    0.0981

 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.2032    1.2254   0.6500 0.313 0.755

Likelihood ratio test=0.1  on 1 df, p=0.7532
n= 46, number of events= 12 


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

TCGA-COAD SENP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.18   0.01503    0.0195
strata=LOW  36       10     9.82   0.00334    0.0195

 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.1109    1.1173   0.7952 0.139 0.889

Likelihood ratio test=0.02  on 1 df, p=0.8879
n= 46, number of events= 12 


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

TCGA-COAD IFNA16 



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

TCGA-COAD SOX2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33       10     8.77     0.173     0.675
strata=LOW  13        2     3.23     0.469     0.675

 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.6354    0.5297   0.7860 -0.808 0.419

Likelihood ratio test=0.74  on 1 df, p=0.3897
n= 46, number of events= 12 


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

TCGA-COAD LIFR 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       11    10.56    0.0179     0.157
strata=LOW   7        1     1.44    0.1319     0.157

 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.4177    0.6585   1.0613 -0.394 0.694

Likelihood ratio test=0.17  on 1 df, p=0.6779
n= 46, number of events= 12 


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

TCGA-COAD MIR199A2 



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

TCGA-COAD COX4I2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.45    0.0597    0.0895
strata=LOW  32        9     8.55    0.0241    0.0895

 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.2046    1.2270   0.6851 0.299 0.765

Likelihood ratio test=0.09  on 1 df, p=0.762
n= 46, number of events= 12 


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

TCGA-COAD ATF2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.61    0.1030     0.162
strata=LOW  31        9     8.39    0.0443     0.162

 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.2783    1.3209   0.6927 0.402 0.688

Likelihood ratio test=0.17  on 1 df, p=0.6827
n= 46, number of events= 12 


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

TCGA-COAD ABCC5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        5      3.8     0.381     0.586
strata=LOW  29        7      8.2     0.177     0.586

 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.4610    0.6307   0.6074 -0.759 0.448

Likelihood ratio test=0.56  on 1 df, p=0.4529
n= 46, number of events= 12 


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

TCGA-COAD CCDC6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        4     2.98     0.353     0.503
strata=LOW  34        8     9.02     0.116     0.503

 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.4546    0.6347   0.6462 -0.703 0.482

Likelihood ratio test=0.48  on 1 df, p=0.49
n= 46, number of events= 12 


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

TCGA-COAD OTUB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  3        0    0.781    0.7811     0.857
strata=LOW  43       12   11.219    0.0544     0.857

 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 1.815e+01 7.607e+07 9.423e+03 0.002 0.998

Likelihood ratio test=1.64  on 1 df, p=0.201
n= 46, number of events= 12 


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

TCGA-COAD ALOXE3 

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

n=41, 5 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        9     9.23   0.00597    0.0268
strata=LOW  12        3     2.77   0.01993    0.0268

 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.1113    1.1178   0.6800 0.164 0.87

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


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

TCGA-COAD SCP2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        5     5.15   0.00431   0.00839
strata=LOW  25        7     6.85   0.00324   0.00839

 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.05643   1.05805  0.61604 0.092 0.927

Likelihood ratio test=0.01  on 1 df, p=0.927
n= 46, number of events= 12 


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

TCGA-COAD PHKG2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  5        1     1.27   0.05751    0.0662
strata=LOW  41       11    10.73   0.00681    0.0662

 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.271     1.311    1.056 0.257 0.798

Likelihood ratio test=0.07  on 1 df, p=0.7903
n= 46, number of events= 12 


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

TCGA-COAD MTDH 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.86    0.2576     0.349
strata=LOW  34       10     9.14    0.0806     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.4586    1.5819   0.7828 0.586 0.558

Likelihood ratio test=0.38  on 1 df, p=0.5393
n= 46, number of events= 12 


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

TCGA-COAD ACO1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     3.31    0.0288     0.042
strata=LOW  35        9     8.69    0.0110     0.042

 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.1397    1.1499   0.6825 0.205 0.838

Likelihood ratio test=0.04  on 1 df, p=0.8362
n= 46, number of events= 12 


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

TCGA-COAD MIR137 



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

TCGA-COAD OIP5-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.61    0.1030     0.162
strata=LOW  32        9     8.39    0.0443     0.162

 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.2783    1.3209   0.6927 0.402 0.688

Likelihood ratio test=0.17  on 1 df, p=0.6827
n= 46, number of events= 12 


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

TCGA-COAD MIR494 



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

TCGA-COAD MLLT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.63    0.0826     0.099
strata=LOW  37       10    10.37    0.0130     0.099

 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.2484    0.7801   0.7915 -0.314 0.754

Likelihood ratio test=0.09  on 1 df, p=0.7596
n= 46, number of events= 12 


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

TCGA-COAD MIR19B1 



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

TCGA-COAD RPTOR 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1      2.2     0.653     0.842
strata=LOW  38       11      9.8     0.146     0.842

 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.9346    2.5463   1.0557 0.885 0.376

Likelihood ratio test=1  on 1 df, p=0.317
n= 46, number of events= 12 


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

TCGA-COAD GCH1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.42    0.0986      0.15
strata=LOW  31        8     8.58    0.0393      0.15

 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.2503    0.7786   0.6469 -0.387 0.699

Likelihood ratio test=0.15  on 1 df, p=0.7016
n= 46, number of events= 12 


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

TCGA-COAD PARP16 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     2.72   0.02852    0.0396
strata=LOW  35        9     9.28   0.00837    0.0396

 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.1381    0.8710   0.6943 -0.199 0.842

Likelihood ratio test=0.04  on 1 df, p=0.8438
n= 46, number of events= 12 


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

TCGA-COAD MIR9-3 



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

TCGA-COAD CISD3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        4     5.79     0.552      1.23
strata=LOW  25        8     6.21     0.514      1.23

 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.6972    2.0081   0.6396 1.09 0.276

Likelihood ratio test=1.23  on 1 df, p=0.2667
n= 46, number of events= 12 


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

TCGA-COAD USP35 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  4        1    0.909  0.009191    0.0103
strata=LOW  42       11   11.091  0.000753    0.0103

 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.1076    0.8980   1.0630 -0.101 0.919

Likelihood ratio test=0.01  on 1 df, p=0.9204
n= 46, number of events= 12 


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

TCGA-COAD PRKAA1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     3.37    0.1163     0.176
strata=LOW  32        8     8.63    0.0455     0.176

 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.2706    0.7629   0.6467 -0.418 0.676

Likelihood ratio test=0.17  on 1 df, p=0.6788
n= 46, number of events= 12 


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

TCGA-COAD MAPK14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        3     1.56     1.328      1.58
strata=LOW  37        9    10.44     0.198      1.58

 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.8440    0.4300   0.6918 -1.22 0.222

Likelihood ratio test=1.31  on 1 df, p=0.2527
n= 46, number of events= 12 


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

TCGA-COAD GRIA3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 38        9    10.38     0.184      1.45
strata=LOW   8        3     1.62     1.179      1.45

 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.8305    2.2945   0.7103 1.169 0.242

Likelihood ratio test=1.22  on 1 df, p=0.2685
n= 46, number of events= 12 


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

TCGA-COAD KDM5C 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        3      2.6    0.0624    0.0851
strata=LOW  36        9      9.4    0.0172    0.0851

 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.2019    0.8171   0.6935 -0.291 0.771

Likelihood ratio test=0.08  on 1 df, p=0.774
n= 46, number of events= 12 


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

TCGA-COAD DECR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        3     4.37     0.430     0.733
strata=LOW  27        9     7.63     0.247     0.733

 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.5775    1.7816   0.6834 0.845 0.398

Likelihood ratio test=0.77  on 1 df, p=0.3807
n= 46, number of events= 12 


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

TCGA-COAD VCP 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1     2.97     1.303      1.79
strata=LOW  36       11     9.03     0.428      1.79

 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.311     3.710    1.050 1.249 0.212

Likelihood ratio test=2.21  on 1 df, p=0.1368
n= 46, number of events= 12 


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

TCGA-COAD MIR129-1 



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

TCGA-COAD PARP10 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     4.08     1.060         2
strata=LOW  37       10     7.92     0.546         2

 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.382     3.982    1.055 1.31 0.19

Likelihood ratio test=2.46  on 1 df, p=0.1166
n= 46, number of events= 12 


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

TCGA-COAD ULK2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     3.23   0.01610    0.0229
strata=LOW  34        9     8.77   0.00592    0.0229

 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.1026    1.1081   0.6786 0.151 0.88

Likelihood ratio test=0.02  on 1 df, p=0.8789
n= 46, number of events= 12 


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

TCGA-COAD CISD1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     2.66    0.0440      0.06
strata=LOW  35        9     9.34    0.0125      0.06

 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.1690    0.8445   0.6907 -0.245 0.807

Likelihood ratio test=0.06  on 1 df, p=0.8089
n= 46, number of events= 12 


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

TCGA-COAD MIR147A 



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

TCGA-COAD BBOX1-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 43       12   11.287     0.045     0.799
strata=LOW   3        0    0.713     0.713     0.799

 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 -1.819e+01  1.263e-08  9.926e+03 -0.002 0.999

Likelihood ratio test=1.51  on 1 df, p=0.2189
n= 46, number of events= 12 


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

TCGA-COAD RB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2      2.5    0.0994     0.134
strata=LOW  35       10      9.5    0.0261     0.134

 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.2901    1.3366   0.7948 0.365 0.715

Likelihood ratio test=0.14  on 1 df, p=0.7075
n= 46, number of events= 12 


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

TCGA-COAD TTPA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        9     7.84     0.172     0.535
strata=LOW  19        3     4.16     0.324     0.535

 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.4973    0.6082   0.6861 -0.725 0.469

Likelihood ratio test=0.56  on 1 df, p=0.4538
n= 46, number of events= 12 


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

TCGA-COAD CDC25A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     5.45     0.387     0.822
strata=LOW  30        8     6.55     0.322     0.822

 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.6144    1.8485   0.6875 0.894 0.372

Likelihood ratio test=0.86  on 1 df, p=0.3528
n= 46, number of events= 12 


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

TCGA-COAD PCAT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        7     7.36    0.0180     0.055
strata=LOW  17        5     4.64    0.0286     0.055

 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.1477    1.1592   0.6305 0.234 0.815

Likelihood ratio test=0.05  on 1 df, p=0.816
n= 46, number of events= 12 


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

TCGA-COAD DAZAP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  6        1     1.52    0.1807     0.214
strata=LOW  40       11    10.48    0.0263     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.4832    1.6212   1.0551 0.458 0.647

Likelihood ratio test=0.24  on 1 df, p=0.6253
n= 46, number of events= 12 


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

TCGA-COAD PEX2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3      2.5    0.0993     0.133
strata=LOW  35        9      9.5    0.0262     0.133

 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.2509    0.7781   0.6906 -0.363 0.716

Likelihood ratio test=0.13  on 1 df, p=0.7212
n= 46, number of events= 12 


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

TCGA-COAD MIR124-3 



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

TCGA-COAD TRIM21 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     2.05  0.001286   0.00163
strata=LOW  37       10     9.95  0.000265   0.00163

 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.03196   1.03247  0.79247 0.04 0.968

Likelihood ratio test=0  on 1 df, p=0.9677
n= 46, number of events= 12 


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

TCGA-COAD MEG3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        7     3.99      2.27      3.66
strata=LOW  27        5     8.01      1.13      3.66

 Chisq= 3.7  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.1588    0.3139   0.6371 -1.819 0.0689

Likelihood ratio test=3.48  on 1 df, p=0.06198
n= 46, number of events= 12 


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

TCGA-COAD GCLC 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.14   0.00861    0.0111
strata=LOW  35       10     9.86   0.00186    0.0111

 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.08357   1.08716  0.79463 0.105 0.916

Likelihood ratio test=0.01  on 1 df, p=0.9156
n= 46, number of events= 12 


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

TCGA-COAD IDH2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1     3.73     1.996      3.65
strata=LOW  38       11     8.27     0.899      3.65

 Chisq= 3.6  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.947e+01 2.869e+08 8.858e+03 0.002 0.998

Likelihood ratio test=6.29  on 1 df, p=0.01213
n= 46, number of events= 12 


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

TCGA-COAD FNDC5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        6     7.52     0.308      0.98
strata=LOW  22        6     4.48     0.518      0.98

 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.6492    1.9140   0.6660 0.975 0.33

Likelihood ratio test=0.98  on 1 df, p=0.3221
n= 46, number of events= 12 


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

TCGA-COAD FANCD2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.67    0.0958     0.167
strata=LOW  26        8     7.33    0.0610     0.167

 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.2555    1.2911   0.6273 0.407 0.684

Likelihood ratio test=0.17  on 1 df, p=0.6807
n= 46, number of events= 12 


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

TCGA-COAD LCN2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        7     7.33    0.0148    0.0405
strata=LOW  18        5     4.67    0.0232    0.0405

 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.1220    1.1297   0.6065 0.201 0.841

Likelihood ratio test=0.04  on 1 df, p=0.841
n= 46, number of events= 12 


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

TCGA-COAD TFR2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        8     7.83   0.00377    0.0123
strata=LOW  18        4     4.17   0.00707    0.0123

 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.07187   0.93065  0.64912 -0.111 0.912

Likelihood ratio test=0.01  on 1 df, p=0.9116
n= 46, number of events= 12 


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

TCGA-COAD PARP12 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.13   0.00391   0.00689
strata=LOW  26        8     7.87   0.00205   0.00689

 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.05449   1.05600  0.65647 0.083 0.934

Likelihood ratio test=0.01  on 1 df, p=0.9337
n= 46, number of events= 12 


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

TCGA-COAD NR1D1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     2.86    0.2597     0.383
strata=LOW  32       10     9.14    0.0813     0.383

 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.4920    1.6356   0.8033 0.612 0.54

Likelihood ratio test=0.41  on 1 df, p=0.5229
n= 46, number of events= 12 


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

TCGA-COAD ATG13 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        2     3.47     0.621     0.975
strata=LOW  31       10     8.53     0.252     0.975

 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.7685    2.1564   0.7968 0.964 0.335

Likelihood ratio test=1.06  on 1 df, p=0.3022
n= 46, number of events= 12 


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

TCGA-COAD TMSB4X 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        2     3.16     0.424     0.632
strata=LOW  30       10     8.84     0.151     0.632

 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.6231    1.8648   0.7961 0.783 0.434

Likelihood ratio test=0.69  on 1 df, p=0.4077
n= 46, number of events= 12 


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

TCGA-COAD CDK14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        4     5.35     0.340     0.688
strata=LOW  23        8     6.65     0.273     0.688

 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.5217    1.6849   0.6359 0.82 0.412

Likelihood ratio test=0.7  on 1 df, p=0.4043
n= 46, number of events= 12 


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

TCGA-COAD RP1-228H13.5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        6     3.64     1.537      2.48
strata=LOW  27        6     8.36     0.668      2.48

 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 -0.9992    0.3682   0.6591 -1.516 0.13

Likelihood ratio test=2.37  on 1 df, p=0.1236
n= 46, number of events= 12 


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

TCGA-COAD NOX3 

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

n=18, 28 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        5   4.9412    0.0007    0.0625
strata=LOW   1        0   0.0588    0.0588    0.0625

 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 -1.710e+01  3.760e-08  2.063e+04 -0.001 0.999

Likelihood ratio test=0.12  on 1 df, p=0.7277
n= 18, number of events= 5 
   (28 observations deleted due to missingness)


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

TCGA-COAD IFNA17 



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

TCGA-COAD ALOX12B 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33        7     6.95  0.000435   0.00124
strata=LOW  13        5     5.05  0.000598   0.00124

 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.02263   0.97763  0.64250 -0.035 0.972

Likelihood ratio test=0  on 1 df, p=0.9719
n= 46, number of events= 12 


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

TCGA-COAD PGRMC1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        5      3.2     1.008       1.5
strata=LOW  31        7      8.8     0.367       1.5

 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.7632    0.4662   0.6376 -1.197 0.231

Likelihood ratio test=1.4  on 1 df, p=0.2364
n= 46, number of events= 12 


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

TCGA-COAD ULK1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2     2.19   0.01732    0.0223
strata=LOW  38       10     9.81   0.00388    0.0223

 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.1183    1.1256   0.7925 0.149 0.881

Likelihood ratio test=0.02  on 1 df, p=0.8799
n= 46, number of events= 12 


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

TCGA-COAD TRIM26 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.26   0.03004     0.039
strata=LOW  35       10     9.74   0.00697     0.039

 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.1564    1.1693   0.7926 0.197 0.844

Likelihood ratio test=0.04  on 1 df, p=0.8412
n= 46, number of events= 12 


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

TCGA-COAD QSOX1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4      5.2     0.276     0.543
strata=LOW  26        8      6.8     0.211     0.543

 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.4646    1.5913   0.6359 0.731 0.465

Likelihood ratio test=0.55  on 1 df, p=0.4582
n= 46, number of events= 12 


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

TCGA-COAD ATM 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        6        5     0.198     0.374
strata=LOW  26        6        7     0.142     0.374

 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.3752    0.6872   0.6164 -0.609 0.543

Likelihood ratio test=0.37  on 1 df, p=0.5414
n= 46, number of events= 12 


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

TCGA-COAD MIB2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.33    0.0459    0.0621
strata=LOW  35       10     9.67    0.0111    0.0621

 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.1997    1.2210   0.8026 0.249 0.804

Likelihood ratio test=0.06  on 1 df, p=0.8
n= 46, number of events= 12 


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

TCGA-COAD SLC1A5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        5     2.62     2.170      3.12
strata=LOW  32        7     9.38     0.605      3.12

 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.1438    0.3186   0.6819 -1.677 0.0935

Likelihood ratio test=2.8  on 1 df, p=0.09428
n= 46, number of events= 12 


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

TCGA-COAD MIR2115 



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

TCGA-COAD LINC00336 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        5     6.18     0.225     0.515
strata=LOW  26        7     5.82     0.239     0.515

 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.4498    1.5681   0.6317 0.712 0.476

Likelihood ratio test=0.52  on 1 df, p=0.4692
n= 46, number of events= 12 


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

TCGA-COAD NDRG1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        5     5.89     0.135     0.316
strata=LOW  21        7     6.11     0.130     0.316

 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.351     1.421    0.627 0.56 0.576

Likelihood ratio test=0.31  on 1 df, p=0.5754
n= 46, number of events= 12 


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

TCGA-COAD TAFAZZIN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        3     3.66    0.1196     0.221
strata=LOW  36        9     8.34    0.0525     0.221

 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.3685    1.4456   0.7880 0.468 0.64

Likelihood ratio test=0.24  on 1 df, p=0.6275
n= 46, number of events= 12 


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

TCGA-COAD MIR135B 



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

TCGA-COAD GLS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        7     6.58    0.0271    0.0685
strata=LOW  17        5     5.42    0.0329    0.0685

 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.1651    0.8478   0.6316 -0.261 0.794

Likelihood ratio test=0.07  on 1 df, p=0.7924
n= 46, number of events= 12 


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

TCGA-COAD HELLS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        5     6.56     0.373     0.896
strata=LOW  21        7     5.44     0.450     0.896

 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.5874    1.7993   0.6292 0.934 0.351

Likelihood ratio test=0.91  on 1 df, p=0.341
n= 46, number of events= 12 


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

TCGA-COAD KLF2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4      5.2     0.278      0.53
strata=LOW  27        8      6.8     0.213      0.53

 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.4533    1.5735   0.6280 0.722 0.47

Likelihood ratio test=0.54  on 1 df, p=0.463
n= 46, number of events= 12 


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

TCGA-COAD TFAP2A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31        8     7.94  0.000519   0.00163
strata=LOW  15        4     4.06  0.001013   0.00163

 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.02552   0.97480  0.63173 -0.04 0.968

Likelihood ratio test=0  on 1 df, p=0.9677
n= 46, number of events= 12 


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

TCGA-COAD FURIN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     4.03  0.000207  0.000359
strata=LOW  30        8     7.97  0.000105  0.000359

 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.01244   1.01252  0.65655 0.019 0.985

Likelihood ratio test=0  on 1 df, p=0.9849
n= 46, number of events= 12 


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

TCGA-COAD CDH1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        8     4.32      3.12      5.56
strata=LOW  25        4     7.68      1.76      5.56

 Chisq= 5.6  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.6773    0.1869   0.7946 -2.111 0.0348

Likelihood ratio test=5.74  on 1 df, p=0.01663
n= 46, number of events= 12 


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

TCGA-COAD MIR6852 



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

TCGA-COAD MIR670 



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

TCGA-COAD TYRO3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        3     4.93     0.757      1.39
strata=LOW  26        9     7.07     0.528      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.7826    2.1872   0.6806 1.15 0.25

Likelihood ratio test=1.46  on 1 df, p=0.2274
n= 46, number of events= 12 


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

TCGA-COAD MIR4715 



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

TCGA-COAD ABHD12 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     3.55    0.0857     0.142
strata=LOW  28        9     8.45    0.0360     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.2668    1.3057   0.7089 0.376 0.707

Likelihood ratio test=0.15  on 1 df, p=0.7029
n= 46, number of events= 12 


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

TCGA-COAD ATG7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.88   0.00754   0.00935
strata=LOW  37       10    10.12   0.00140   0.00935

 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.07666   0.92621  0.79318 -0.097 0.923

Likelihood ratio test=0.01  on 1 df, p=0.9236
n= 46, number of events= 12 


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

TCGA-COAD MT1G 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 44       12   11.683   0.00861      0.33
strata=LOW   2        0    0.317   0.31718      0.33

 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 -1.706e+01  3.888e-08  8.828e+03 -0.002 0.998

Likelihood ratio test=0.65  on 1 df, p=0.4212
n= 46, number of events= 12 


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

TCGA-COAD SAT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     2.34    0.1873     0.248
strata=LOW  34        9     9.66    0.0453     0.248

 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.3454    0.7079   0.6966 -0.496 0.62

Likelihood ratio test=0.23  on 1 df, p=0.6282
n= 46, number of events= 12 


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

TCGA-COAD MIR182 



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

TCGA-COAD HOTAIR 

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

n=35, 11 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        8     7.52    0.0309     0.199
strata=LOW   9        1     1.48    0.1569     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.4782    0.6199   1.0809 -0.442 0.658

Likelihood ratio test=0.22  on 1 df, p=0.64
n= 35, number of events= 9 
   (11 observations deleted due to missingness)


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

TCGA-COAD PIR 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3      4.5     0.499     0.849
strata=LOW  29        9      7.5     0.299     0.849

 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.6154    1.8505   0.6784 0.907 0.364

Likelihood ratio test=0.89  on 1 df, p=0.3449
n= 46, number of events= 12 


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

TCGA-COAD ELAVL1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  3        1    0.891   0.01344    0.0148
strata=LOW  43       11   11.109   0.00108    0.0148

 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.1287    0.8793   1.0573 -0.122 0.903

Likelihood ratio test=0.01  on 1 df, p=0.9048
n= 46, number of events= 12 


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

TCGA-COAD ACADSB 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        5     4.31    0.1121     0.199
strata=LOW  28        7     7.69    0.0627     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.2833    0.7533   0.6367 -0.445 0.656

Likelihood ratio test=0.2  on 1 df, p=0.6568
n= 46, number of events= 12 


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

TCGA-COAD NCOA4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4     4.51    0.0587     0.102
strata=LOW  27        8     7.49    0.0354     0.102

 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.2013    1.2230   0.6326 0.318 0.75

Likelihood ratio test=0.1  on 1 df, p=0.7484
n= 46, number of events= 12 


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

TCGA-COAD IFNA10 



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

TCGA-COAD IFNA13 



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

TCGA-COAD MIR9-2 



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

TCGA-COAD RRM2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        5     6.33     0.278     0.647
strata=LOW  24        7     5.67     0.310     0.647

 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.5016    1.6514   0.6299 0.796 0.426

Likelihood ratio test=0.66  on 1 df, p=0.4176
n= 46, number of events= 12 


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

TCGA-COAD EPSTI1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        5     4.83   0.00589    0.0115
strata=LOW  27        7     7.17   0.00397    0.0115

 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.06725   0.93497  0.62846 -0.107 0.915

Likelihood ratio test=0.01  on 1 df, p=0.9151
n= 46, number of events= 12 


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

TCGA-COAD LINC00551 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        5     4.82   0.00649    0.0128
strata=LOW  21        7     7.18   0.00436    0.0128

 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.07235   0.93020  0.63941 -0.113 0.91

Likelihood ratio test=0.01  on 1 df, p=0.9099
n= 46, number of events= 12 


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

TCGA-COAD SLC25A28 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1      1.8    0.3533     0.433
strata=LOW  39       11     10.2    0.0622     0.433

 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.6815    1.9769   1.0558 0.645 0.519

Likelihood ratio test=0.5  on 1 df, p=0.48
n= 46, number of events= 12 


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

TCGA-COAD LINC00973 

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

n=21, 25 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        6    5.646    0.0222     0.381
strata=LOW   2        0    0.354    0.3539     0.381

 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 -1.812e+01  1.352e-08  1.393e+04 -0.001 0.999

Likelihood ratio test=0.73  on 1 df, p=0.3914
n= 21, number of events= 6 
   (25 observations deleted due to missingness)


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

TCGA-COAD MIR378A 

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

n=41, 5 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        8     7.43    0.0433     0.145
strata=LOW  11        3     3.57    0.0903     0.145

 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.2668    0.7659   0.7016 -0.38 0.704

Likelihood ratio test=0.15  on 1 df, p=0.6993
n= 41, number of events= 11 
   (5 observations deleted due to missingness)


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

TCGA-COAD MGST1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        4     5.52     0.419      0.88
strata=LOW  24        8     6.48     0.358      0.88

 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.5897    1.8034   0.6369 0.926 0.355

Likelihood ratio test=0.89  on 1 df, p=0.3461
n= 46, number of events= 12 


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

TCGA-COAD MIB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     4.33     0.408     0.729
strata=LOW  28        9     7.67     0.230     0.729

 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.5844    1.7939   0.6939 0.842 0.4

Likelihood ratio test=0.76  on 1 df, p=0.3844
n= 46, number of events= 12 


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

TCGA-COAD SRC 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     3.17   0.00935    0.0132
strata=LOW  33        9     8.83   0.00336    0.0132

 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.07822   1.08136  0.67975 0.115 0.908

Likelihood ratio test=0.01  on 1 df, p=0.9079
n= 46, number of events= 12 


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

TCGA-COAD ATG5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     4.03  0.000281   0.00045
strata=LOW  30        8     7.97  0.000142   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.01339   1.01348  0.63144 0.021 0.983

Likelihood ratio test=0  on 1 df, p=0.9831
n= 46, number of events= 12 


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

TCGA-COAD ACVR1B 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.53    0.0630     0.117
strata=LOW  26        8     7.47    0.0382     0.117

 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.2221    1.2487   0.6503 0.341 0.733

Likelihood ratio test=0.12  on 1 df, p=0.7312
n= 46, number of events= 12 


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

TCGA-COAD NT5DC2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     4.31     0.397     0.747
strata=LOW  29        9     7.69     0.222     0.747

 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.6661    1.9466   0.7847 0.849 0.396

Likelihood ratio test=0.82  on 1 df, p=0.3648
n= 46, number of events= 12 


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

TCGA-COAD PIK3CA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        2     3.34     0.539     0.828
strata=LOW  30       10     8.66     0.208     0.828

 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.7098    2.0336   0.7961 0.892 0.373

Likelihood ratio test=0.9  on 1 df, p=0.3423
n= 46, number of events= 12 


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

TCGA-COAD NUPR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        3     3.94     0.225     0.355
strata=LOW  27        9     8.06     0.110     0.355

 Chisq= 0.4  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.4029    1.4962   0.6808 0.592 0.554

Likelihood ratio test=0.37  on 1 df, p=0.543
n= 46, number of events= 12 


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

TCGA-COAD AKT1S1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1     2.37     0.791      1.05
strata=LOW  38       11     9.63     0.194      1.05

 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 1.035     2.814    1.057 0.979 0.327

Likelihood ratio test=1.25  on 1 df, p=0.2627
n= 46, number of events= 12 


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

TCGA-COAD MIR19A 



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

TCGA-COAD USP7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     2.53     0.847      1.15
strata=LOW  32        8     9.47     0.227      1.15

 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.6842    0.5045   0.6508 -1.051 0.293

Likelihood ratio test=1.04  on 1 df, p=0.3076
n= 46, number of events= 12 


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

TCGA-COAD TMSB4Y 

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

n=34, 12 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.63    0.0859     0.258
strata=LOW  14        4     3.37    0.1181     0.258

 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.3893    1.4759   0.7709 0.505 0.614

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


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

TCGA-COAD SIAH2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.99  6.23e-05  7.81e-05
strata=LOW  37       10    10.01  1.24e-05  7.81e-05

 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.006999  0.993025  0.792041 -0.009 0.993

Likelihood ratio test=0  on 1 df, p=0.993
n= 46, number of events= 12 


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

TCGA-COAD MIR29A 



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

TCGA-COAD CHAC1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        5     5.31    0.0182    0.0379
strata=LOW  27        7     6.69    0.0144    0.0379

 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.1238    1.1318   0.6358 0.195 0.846

Likelihood ratio test=0.04  on 1 df, p=0.8449
n= 46, number of events= 12 


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

TCGA-COAD LINC00616 



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

TCGA-COAD PRKAA2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       11    10.83   0.00257    0.0276
strata=LOW   7        1     1.17   0.02383    0.0276

 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.1766    0.8381   1.0645 -0.166 0.868

Likelihood ratio test=0.03  on 1 df, p=0.8652
n= 46, number of events= 12 


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

TCGA-COAD LONP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        1     2.02     0.514     0.668
strata=LOW  35       11     9.98     0.104     0.668

 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.8433    2.3241   1.0628 0.794 0.427

Likelihood ratio test=0.78  on 1 df, p=0.3774
n= 46, number of events= 12 


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

TCGA-COAD PPARG 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        7     4.51     1.368      2.53
strata=LOW  24        5     7.49     0.825      2.53

 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.0588    0.3469   0.6956 -1.522 0.128

Likelihood ratio test=2.56  on 1 df, p=0.1097
n= 46, number of events= 12 


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

TCGA-COAD MAPK1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.55    0.0844     0.132
strata=LOW  31        9     8.45    0.0354     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.2503    1.2844   0.6918 0.362 0.718

Likelihood ratio test=0.13  on 1 df, p=0.7133
n= 46, number of events= 12 


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

TCGA-COAD PEX6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     3.74    0.1476     0.228
strata=LOW  35        9     8.26    0.0669     0.228

 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.3247    1.3836   0.6827 0.476 0.634

Likelihood ratio test=0.24  on 1 df, p=0.6268
n= 46, number of events= 12 


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

TCGA-COAD PPARA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     3.65    0.0345    0.0546
strata=LOW  29        8     8.35    0.0151    0.0546

 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.1510    0.8598   0.6471 -0.233 0.815

Likelihood ratio test=0.05  on 1 df, p=0.8165
n= 46, number of events= 12 


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

TCGA-COAD ACSL4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.64    0.0358    0.0541
strata=LOW  31        8     8.36    0.0156    0.0541

 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.1466    0.8636   0.6308 -0.232 0.816

Likelihood ratio test=0.05  on 1 df, p=0.8175
n= 46, number of events= 12 


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

TCGA-COAD ANO6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        2     3.38     0.563     0.874
strata=LOW  30       10     8.62     0.221     0.874

 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.7293    2.0737   0.7970 0.915 0.36

Likelihood ratio test=0.95  on 1 df, p=0.3292
n= 46, number of events= 12 


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

TCGA-COAD YTHDC2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        5     3.87     0.329      0.54
strata=LOW  30        7     8.13     0.157      0.54

 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.4626    0.6297   0.6348 -0.729 0.466

Likelihood ratio test=0.53  on 1 df, p=0.4681
n= 46, number of events= 12 


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

TCGA-COAD MIR103A1 



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

TCGA-COAD INTS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        2     3.13     0.406     0.607
strata=LOW  31       10     8.87     0.143     0.607

 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.6127    1.8455   0.7982 0.768 0.443

Likelihood ratio test=0.66  on 1 df, p=0.4175
n= 46, number of events= 12 


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

TCGA-COAD PTPN6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     3.21   0.01386    0.0208
strata=LOW  30        9     8.79   0.00506    0.0208

 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.1003    1.1055   0.6959 0.144 0.885

Likelihood ratio test=0.02  on 1 df, p=0.8847
n= 46, number of events= 12 


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

TCGA-COAD SMAD7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        6     5.15     0.141     0.274
strata=LOW  25        6     6.85     0.106     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.3221    0.7246   0.6178 -0.521 0.602

Likelihood ratio test=0.27  on 1 df, p=0.6009
n= 46, number of events= 12 


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

TCGA-COAD ATG16L1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1     1.72      0.30     0.363
strata=LOW  39       11    10.28      0.05     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.6263    1.8707   1.0558 0.593 0.553

Likelihood ratio test=0.42  on 1 df, p=0.5193
n= 46, number of events= 12 


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

TCGA-COAD LINC00976 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28       10     7.59     0.763      2.22
strata=LOW  18        2     4.41     1.315      2.22

 Chisq= 2.2  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.1127    0.3287   0.7846 -1.418 0.156

Likelihood ratio test=2.47  on 1 df, p=0.116
n= 46, number of events= 12 


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

TCGA-COAD H19 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        5     5.43    0.0334      0.07
strata=LOW  18        7     6.57    0.0275      0.07

 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.1646    1.1790   0.6229 0.264 0.792

Likelihood ratio test=0.07  on 1 df, p=0.7913
n= 46, number of events= 12 


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

TCGA-COAD FADS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        5     5.25   0.01188    0.0229
strata=LOW  25        7     6.75   0.00924    0.0229

 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.09183   1.09617  0.60740 0.151 0.88

Likelihood ratio test=0.02  on 1 df, p=0.8797
n= 46, number of events= 12 


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

TCGA-COAD CHP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        6     6.14   0.00302   0.00734
strata=LOW  21        6     5.86   0.00316   0.00734

 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.05376   1.05524  0.62749 0.086 0.932

Likelihood ratio test=0.01  on 1 df, p=0.9318
n= 46, number of events= 12 


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

TCGA-COAD PRR5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     2.05    0.4390     0.555
strata=LOW  34        9     9.95    0.0905     0.555

 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.5099    0.6005   0.6921 -0.737 0.461

Likelihood ratio test=0.5  on 1 df, p=0.4777
n= 46, number of events= 12 


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

TCGA-COAD CFL1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4     4.49    0.0533    0.0981
strata=LOW  27        8     7.51    0.0318    0.0981

 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.2032    1.2254   0.6500 0.313 0.755

Likelihood ratio test=0.1  on 1 df, p=0.7532
n= 46, number of events= 12 


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

TCGA-COAD MIR382 



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

TCGA-COAD LAMP2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.53    0.0788     0.129
strata=LOW  29        9     8.47    0.0328     0.129

 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.2535    1.2885   0.7073 0.358 0.72

Likelihood ratio test=0.13  on 1 df, p=0.7164
n= 46, number of events= 12 


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

TCGA-COAD PTPN14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.32    0.0312    0.0477
strata=LOW  32        9     8.68    0.0119    0.0477

 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.1520    1.1641   0.6965 0.218 0.827

Likelihood ratio test=0.05  on 1 df, p=0.8257
n= 46, number of events= 12 


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

TCGA-COAD AGPAT3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        5      4.6    0.0354    0.0667
strata=LOW  28        7      7.4    0.0220    0.0667

 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.1649    0.8480   0.6390 -0.258 0.796

Likelihood ratio test=0.07  on 1 df, p=0.7964
n= 46, number of events= 12 


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

TCGA-COAD STING1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        1     2.54     0.935      1.22
strata=LOW  35       11     9.46     0.251      1.22

 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 1.103     3.014    1.050 1.051 0.293

Likelihood ratio test=1.49  on 1 df, p=0.2227
n= 46, number of events= 12 


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

TCGA-COAD ABCC1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.16   0.00791    0.0112
strata=LOW  31        9     8.84   0.00282    0.0112

 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.0720    1.0747   0.6803 0.106 0.916

Likelihood ratio test=0.01  on 1 df, p=0.9153
n= 46, number of events= 12 


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

TCGA-COAD IFNA5 



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

TCGA-COAD MIR140 

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

n=21, 25 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     3.74    0.0180     0.278
strata=LOW   1        1     1.26    0.0534     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 -1.811e+01  1.368e-08  1.623e+04 -0.001 0.999

Likelihood ratio test=0.54  on 1 df, p=0.4639
n= 21, number of events= 5 
   (25 observations deleted due to missingness)


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

TCGA-COAD MYB 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     2.22     1.419      1.84
strata=LOW  32        8     9.78     0.323      1.84

 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.8530    0.4261   0.6485 -1.315 0.188

Likelihood ratio test=1.6  on 1 df, p=0.2064
n= 46, number of events= 12 


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

TCGA-COAD IFNA6 



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

TCGA-COAD IFNA14 



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

TCGA-COAD BDNF-AS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     3.76    0.0158    0.0255
strata=LOW  30        8     8.24    0.0072    0.0255

 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.1033    0.9018   0.6477 -0.16 0.873

Likelihood ratio test=0.03  on 1 df, p=0.8737
n= 46, number of events= 12 


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

TCGA-COAD TRIB2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     3.23   0.01648    0.0248
strata=LOW  33        9     8.77   0.00607    0.0248

 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.1096    1.1158   0.6961 0.157 0.875

Likelihood ratio test=0.03  on 1 df, p=0.8741
n= 46, number of events= 12 


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

TCGA-COAD MALAT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        4     4.92     0.171     0.316
strata=LOW  28        8     7.08     0.119     0.316

 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.3539    1.4247   0.6328 0.559 0.576

Likelihood ratio test=0.32  on 1 df, p=0.5708
n= 46, number of events= 12 


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

TCGA-COAD FH 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2     3.04     0.357     0.521
strata=LOW  33       10     8.96     0.121     0.521

 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.5661    1.7614   0.7947 0.712 0.476

Likelihood ratio test=0.56  on 1 df, p=0.4531
n= 46, number of events= 12 


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

TCGA-COAD PEX10 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1     1.64    0.2477     0.304
strata=LOW  38       11    10.36    0.0391     0.304

 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.577     1.781    1.062 0.543 0.587

Likelihood ratio test=0.34  on 1 df, p=0.5584
n= 46, number of events= 12 


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

TCGA-COAD SCD 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        7     7.05  0.000295  0.000825
strata=LOW  16        5     4.95  0.000420  0.000825

 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.01803   1.01820  0.62793 0.029 0.977

Likelihood ratio test=0  on 1 df, p=0.9771
n= 46, number of events= 12 


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

TCGA-COAD FTL 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        6     4.41     0.576      1.07
strata=LOW  24        6     7.59     0.334      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.6777    0.5078   0.6654 -1.019 0.308

Likelihood ratio test=1.07  on 1 df, p=0.3007
n= 46, number of events= 12 


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

TCGA-COAD TSC1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     2.89   0.00383   0.00521
strata=LOW  32        9     9.11   0.00122   0.00521

 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.04897   0.95221  0.67834 -0.072 0.942

Likelihood ratio test=0.01  on 1 df, p=0.9427
n= 46, number of events= 12 


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

TCGA-COAD BRD3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2      2.1   0.00488    0.0062
strata=LOW  37       10      9.9   0.00104    0.0062

 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.0624    1.0644   0.7923 0.079 0.937

Likelihood ratio test=0.01  on 1 df, p=0.9368
n= 46, number of events= 12 


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

TCGA-COAD SLC16A1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        5     5.54    0.0530     0.123
strata=LOW  22        7     6.46    0.0454     0.123

 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.2258    1.2533   0.6439 0.351 0.726

Likelihood ratio test=0.12  on 1 df, p=0.7262
n= 46, number of events= 12 


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

TCGA-COAD MIR132 



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

TCGA-COAD MIR375 



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

TCGA-COAD MIOX 

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

n=43, 3 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 34       10     9.65    0.0128    0.0671
strata=LOW   9        2     2.35    0.0525    0.0671

 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.2025    0.8167   0.7833 -0.259 0.796

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


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

TCGA-COAD ATXN8OS 



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

TCGA-COAD KLHDC3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        1     2.31     0.740     0.968
strata=LOW  37       11     9.69     0.176     0.968

 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.9971    2.7105   1.0558 0.944 0.345

Likelihood ratio test=1.16  on 1 df, p=0.282
n= 46, number of events= 12 


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

TCGA-COAD MICU1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.65    0.0345    0.0546
strata=LOW  31        8     8.35    0.0151    0.0546

 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.1510    0.8598   0.6471 -0.233 0.815

Likelihood ratio test=0.05  on 1 df, p=0.8165
n= 46, number of events= 12 


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

TCGA-COAD CBS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        6     7.77     0.405      1.39
strata=LOW  17        6     4.23     0.745      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.7032    2.0203   0.6084 1.156 0.248

Likelihood ratio test=1.28  on 1 df, p=0.2571
n= 46, number of events= 12 


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

TCGA-COAD HUWE1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        2     3.85     0.893      1.38
strata=LOW  31       10     8.15     0.422      1.38

 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.8911    2.4377   0.7832 1.138 0.255

Likelihood ratio test=1.54  on 1 df, p=0.2151
n= 46, number of events= 12 


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

TCGA-COAD LINC00472 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 37       10     9.76    0.0057    0.0314
strata=LOW   9        2     2.24    0.0249    0.0314

 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.1386    0.8705   0.7834 -0.177 0.86

Likelihood ratio test=0.03  on 1 df, p=0.8575
n= 46, number of events= 12 


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

TCGA-COAD FGF21 

[1] 176
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 10        2    1.675    0.0631     0.392
strata=LOW   1        0    0.325    0.3250     0.392

 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 -1.930e+01  4.137e-09  2.481e+04 -0.001 0.999

Likelihood ratio test=0.71  on 1 df, p=0.3983
n= 11, number of events= 2 
   (35 observations deleted due to missingness)


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

TCGA-COAD MIR34A 



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

TCGA-COAD IDH1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        5     4.16    0.1689     0.293
strata=LOW  29        7     7.84    0.0897     0.293

 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.3429    0.7097   0.6367 -0.539 0.59

Likelihood ratio test=0.29  on 1 df, p=0.591
n= 46, number of events= 12 


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

TCGA-COAD GSK3B 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.11   0.00367   0.00542
strata=LOW  32        9     8.89   0.00128   0.00542

 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.05127   1.05261  0.69651 0.074 0.941

Likelihood ratio test=0.01  on 1 df, p=0.9411
n= 46, number of events= 12 


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

TCGA-COAD KDM4A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.35    0.0276    0.0508
strata=LOW  26        8     7.65    0.0156    0.0508

 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.1483    1.1598   0.6581 0.225 0.822

Likelihood ratio test=0.05  on 1 df, p=0.8211
n= 46, number of events= 12 


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

TCGA-COAD PEX12 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.71    0.1849     0.258
strata=LOW  35       10     9.29    0.0539     0.258

 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.4013    1.4937   0.7956 0.504 0.614

Likelihood ratio test=0.27  on 1 df, p=0.6006
n= 46, number of events= 12 


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

TCGA-COAD IDO1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        8     5.36      1.30      2.71
strata=LOW  23        4     6.64      1.05      2.71

 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.0107    0.3640   0.6376 -1.585 0.113

Likelihood ratio test=2.65  on 1 df, p=0.1037
n= 46, number of events= 12 


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

TCGA-COAD BCAT2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        2     4.08     1.058      1.86
strata=LOW  30       10     7.92     0.545      1.86

 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.0411    2.8324   0.7978 1.305 0.192

Likelihood ratio test=2.02  on 1 df, p=0.1549
n= 46, number of events= 12 


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

TCGA-COAD ADAM23 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        6     5.22    0.1174     0.225
strata=LOW  25        6     6.78    0.0903     0.225

 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.2870    0.7505   0.6075 -0.472 0.637

Likelihood ratio test=0.22  on 1 df, p=0.6357
n= 46, number of events= 12 


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

TCGA-COAD PEX3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.93  0.002815   0.00351
strata=LOW  37       10    10.07  0.000538   0.00351

 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.04701   0.95408  0.79343 -0.059 0.953

Likelihood ratio test=0  on 1 df, p=0.953
n= 46, number of events= 12 


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

TCGA-COAD ATP5MC3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.93     0.219     0.365
strata=LOW  31        9     8.07     0.106     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.4167    1.5170   0.6943 0.6 0.548

Likelihood ratio test=0.38  on 1 df, p=0.5386
n= 46, number of events= 12 


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

TCGA-COAD AQP5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33        9     8.22    0.0734     0.295
strata=LOW  13        3     3.78    0.1598     0.295

 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.4243    0.6542   0.7867 -0.539 0.59

Likelihood ratio test=0.32  on 1 df, p=0.5736
n= 46, number of events= 12 


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

TCGA-COAD ADAMTS9-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       12     9.99     0.406      2.47
strata=LOW   7        0     2.01     2.013      2.47

 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.933e+01  4.021e-09  1.003e+04 -0.002 0.998

Likelihood ratio test=4.45  on 1 df, p=0.0348
n= 46, number of events= 12 


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

TCGA-COAD ACSL3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.77    0.2140       0.3
strata=LOW  34       10     9.23    0.0642       0.3

 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.4317    1.5399   0.7944 0.543 0.587

Likelihood ratio test=0.32  on 1 df, p=0.5715
n= 46, number of events= 12 


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

TCGA-COAD DDR2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33       10     9.32    0.0494      0.23
strata=LOW  13        2     2.68    0.1719      0.23

 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.3745    0.6877   0.7854 -0.477 0.634

Likelihood ratio test=0.25  on 1 df, p=0.6205
n= 46, number of events= 12 


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

TCGA-COAD TERT 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        6     3.49     1.801      2.66
strata=LOW  29        6     8.51     0.739      2.66

 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 -0.9570    0.3840   0.6089 -1.572 0.116

Likelihood ratio test=2.45  on 1 df, p=0.1174
n= 46, number of events= 12 


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

TCGA-COAD IFNA7 



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

TCGA-COAD ECH1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     4.97     0.188     0.353
strata=LOW  29        8     7.03     0.132     0.353

 Chisq= 0.4  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.3752    1.4553   0.6350 0.591 0.555

Likelihood ratio test=0.36  on 1 df, p=0.5494
n= 46, number of events= 12 


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

TCGA-COAD CS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.89     0.277     0.396
strata=LOW  34       10     9.11     0.088     0.396

 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.4953    1.6410   0.7952 0.623 0.533

Likelihood ratio test=0.43  on 1 df, p=0.5144
n= 46, number of events= 12 


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

TCGA-COAD AMN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 36        8     8.96     0.103     0.584
strata=LOW  10        4     3.04     0.305     0.584

 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.5251    1.6906   0.6943 0.756 0.449

Likelihood ratio test=0.53  on 1 df, p=0.4675
n= 46, number of events= 12 


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

TCGA-COAD DUOX2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        8     7.92  0.000861   0.00315
strata=LOW  16        4     4.08  0.001669   0.00315

 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.03846   0.96227  0.68532 -0.056 0.955

Likelihood ratio test=0  on 1 df, p=0.9551
n= 46, number of events= 12 


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

TCGA-COAD MBOAT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        4     5.42     0.372     0.768
strata=LOW  23        8     6.58     0.307     0.768

 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.5526    1.7377   0.6379 0.866 0.386

Likelihood ratio test=0.78  on 1 df, p=0.3783
n= 46, number of events= 12 


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

TCGA-COAD RNF113A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.61    0.0934     0.115
strata=LOW  37       10    10.39    0.0145     0.115

 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.2733    0.7608   0.8080 -0.338 0.735

Likelihood ratio test=0.11  on 1 df, p=0.7415
n= 46, number of events= 12 


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

TCGA-COAD MIR138-1 



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

TCGA-COAD MIR144 



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

TCGA-COAD P4HB 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     2.14   0.00861    0.0111
strata=LOW  37       10     9.86   0.00186    0.0111

 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.08357   1.08716  0.79463 0.105 0.916

Likelihood ratio test=0.01  on 1 df, p=0.9156
n= 46, number of events= 12 


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

TCGA-COAD MIR338 



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

TCGA-COAD PTGS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        6     6.38    0.0226    0.0528
strata=LOW  23        6     5.62    0.0256    0.0528

 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.1395    1.1497   0.6076 0.23 0.818

Likelihood ratio test=0.05  on 1 df, p=0.8181
n= 46, number of events= 12 


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

TCGA-COAD ASAH2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     3.42     0.587     0.902
strata=LOW  32       10     8.58     0.234     0.902

 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.7373    2.0903   0.7937 0.929 0.353

Likelihood ratio test=0.99  on 1 df, p=0.3207
n= 46, number of events= 12 


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

TCGA-COAD MIR522 



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

TCGA-COAD GALNT14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        5     6.89     0.519      1.31
strata=LOW  25        7     5.11     0.700      1.31

 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.7058    2.0255   0.6284 1.123 0.261

Likelihood ratio test=1.32  on 1 df, p=0.2508
n= 46, number of events= 12 


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

TCGA-COAD KDM4C 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        5     3.42     0.731      1.12
strata=LOW  31        7     8.58     0.291      1.12

 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.6585    0.5176   0.6343 -1.038 0.299

Likelihood ratio test=1.06  on 1 df, p=0.3034
n= 46, number of events= 12 


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

TCGA-COAD FXN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     2.04  0.000845   0.00107
strata=LOW  37       10     9.96  0.000173   0.00107

 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.02585   1.02618  0.79188 0.033 0.974

Likelihood ratio test=0  on 1 df, p=0.9739
n= 46, number of events= 12 


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

TCGA-COAD MEF2C 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        7     6.73     0.011    0.0284
strata=LOW  18        5     5.27     0.014    0.0284

 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.1060    0.8995   0.6287 -0.169 0.866

Likelihood ratio test=0.03  on 1 df, p=0.8656
n= 46, number of events= 12 


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

TCGA-COAD MDM2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     3.73    0.1431     0.237
strata=LOW  28        9     8.27    0.0645     0.237

 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.3399    1.4048   0.7010 0.485 0.628

Likelihood ratio test=0.24  on 1 df, p=0.6212
n= 46, number of events= 12 


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

TCGA-COAD MAP3K14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.61    0.1440     0.197
strata=LOW  35       10     9.39    0.0401     0.197

 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.3508    1.4203   0.7941 0.442 0.659

Likelihood ratio test=0.21  on 1 df, p=0.6479
n= 46, number of events= 12 


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

TCGA-COAD MDM4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        4     2.38     1.107      1.46
strata=LOW  34        8     9.62     0.274      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.7643    0.4657   0.6478 -1.18 0.238

Likelihood ratio test=1.3  on 1 df, p=0.2547
n= 46, number of events= 12 


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

TCGA-COAD ASMTL-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        5     4.82   0.00688    0.0131
strata=LOW  27        7     7.18   0.00462    0.0131

 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.0718    0.9307   0.6265 -0.115 0.909

Likelihood ratio test=0.01  on 1 df, p=0.9089
n= 46, number of events= 12 


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

TCGA-COAD NEAT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        4     4.62    0.0823     0.142
strata=LOW  25        8     7.38    0.0514     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.2358    1.2660   0.6273 0.376 0.707

Likelihood ratio test=0.14  on 1 df, p=0.7043
n= 46, number of events= 12 


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

TCGA-COAD COPZ1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  6        2     1.05    0.8481     0.956
strata=LOW  40       10    10.95    0.0817     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.7611    0.4672   0.7969 -0.955 0.34

Likelihood ratio test=0.78  on 1 df, p=0.3766
n= 46, number of events= 12 


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

TCGA-COAD PLIN2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     2.83     0.483     0.713
strata=LOW  30        8     9.17     0.149     0.713

 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.5634    0.5693   0.6759 -0.834 0.405

Likelihood ratio test=0.67  on 1 df, p=0.4119
n= 46, number of events= 12 


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

TCGA-COAD FADS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        4     4.64    0.0888     0.154
strata=LOW  26        8     7.36    0.0561     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.2453    1.2780   0.6270 0.391 0.696

Likelihood ratio test=0.16  on 1 df, p=0.6927
n= 46, number of events= 12 


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

TCGA-COAD MIR7-1 



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

TCGA-COAD TXN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.69     0.130     0.208
strata=LOW  31        9     8.31     0.058     0.208

 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.3149    1.3701   0.6926 0.455 0.649

Likelihood ratio test=0.21  on 1 df, p=0.6431
n= 46, number of events= 12 


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

TCGA-COAD MIR302A 



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

TCGA-COAD EGLN2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.29   0.02560    0.0368
strata=LOW  31        9     8.71   0.00967    0.0368

 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.1301    1.1389   0.6789 0.192 0.848

Likelihood ratio test=0.04  on 1 df, p=0.8466
n= 46, number of events= 12 


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

TCGA-COAD NCOA3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        5     3.92     0.295     0.509
strata=LOW  25        7     8.08     0.143     0.509

 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.4604    0.6310   0.6506 -0.708 0.479

Likelihood ratio test=0.5  on 1 df, p=0.4801
n= 46, number of events= 12 


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

TCGA-COAD SREBF1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1     3.13     1.449      2.04
strata=LOW  36       11     8.87     0.511      2.04

 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.385     3.996    1.050 1.32 0.187

Likelihood ratio test=2.52  on 1 df, p=0.1125
n= 46, number of events= 12 


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

TCGA-COAD LINC01134 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        7      3.8      2.69      4.47
strata=LOW  28        5      8.2      1.25      4.47

 Chisq= 4.5  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.3915    0.2487   0.7074 -1.967 0.0492

Likelihood ratio test=4.35  on 1 df, p=0.037
n= 46, number of events= 12 


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

TCGA-COAD MYCN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        1      4.4      2.63       4.4
strata=LOW  27       11      7.6      1.52       4.4

 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.902     6.697    1.049 1.812 0.0699

Likelihood ratio test=5.37  on 1 df, p=0.02054
n= 46, number of events= 12 


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

TCGA-COAD IFNA4 



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

TCGA-COAD DPEP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 41       11   11.264    0.0062     0.104
strata=LOW   5        1    0.736    0.0950     0.104

 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.341     1.406    1.063 0.321 0.748

Likelihood ratio test=0.09  on 1 df, p=0.7588
n= 46, number of events= 12 


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

TCGA-COAD VDAC2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     4.56    0.0688      0.12
strata=LOW  29        8     7.44    0.0422      0.12

 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.2188    1.2446   0.6327 0.346 0.73

Likelihood ratio test=0.12  on 1 df, p=0.7273
n= 46, number of events= 12 


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

TCGA-COAD PCBP2-OT1 

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

n=40, 6 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        6     5.51    0.0433     0.148
strata=LOW  12        3     3.49    0.0684     0.148

 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.3229    0.7240   0.8421 -0.383 0.701

Likelihood ratio test=0.15  on 1 df, p=0.6945
n= 40, number of events= 9 
   (6 observations deleted due to missingness)


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

TCGA-COAD KEAP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1     1.93    0.4455     0.556
strata=LOW  39       11    10.07    0.0852     0.556

 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.7683    2.1562   1.0561 0.728 0.467

Likelihood ratio test=0.65  on 1 df, p=0.4209
n= 46, number of events= 12 


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

TCGA-COAD RPL8 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        1     3.29     1.595      2.33
strata=LOW  32       11     8.71     0.603      2.33

 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.471     4.355    1.053 1.398 0.162

Likelihood ratio test=2.87  on 1 df, p=0.09032
n= 46, number of events= 12 


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

TCGA-COAD ALOX12 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        2      3.6     0.714      1.15
strata=LOW  30       10      8.4     0.307      1.15

 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.8296    2.2925   0.7964 1.042 0.298

Likelihood ratio test=1.25  on 1 df, p=0.2629
n= 46, number of events= 12 


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

TCGA-COAD ACSF2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31        7     7.23   0.00708    0.0214
strata=LOW  15        5     4.77   0.01072    0.0214

 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.09352   1.09803  0.63878 0.146 0.884

Likelihood ratio test=0.02  on 1 df, p=0.8841
n= 46, number of events= 12 


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

TCGA-COAD KDM5A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.78    0.1620     0.251
strata=LOW  29        9     8.22    0.0746     0.251

 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.3394    1.4040   0.6811 0.498 0.618

Likelihood ratio test=0.26  on 1 df, p=0.6101
n= 46, number of events= 12 


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

TCGA-COAD NRAS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     3.46    0.0827     0.127
strata=LOW  30        8     8.54    0.0336     0.127

 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.2300    0.7945   0.6469 -0.356 0.722

Likelihood ratio test=0.12  on 1 df, p=0.7244
n= 46, number of events= 12 


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

TCGA-COAD MIR30E 



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

TCGA-COAD OGFRP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        4     3.83   0.00768    0.0141
strata=LOW  34        8     8.17   0.00360    0.0141

 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.08058   0.92258  0.67915 -0.119 0.906

Likelihood ratio test=0.01  on 1 df, p=0.9061
n= 46, number of events= 12 


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

TCGA-COAD TF 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 32        7     8.32     0.208     0.715
strata=LOW  14        5     3.68     0.471     0.715

 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.5104    1.6659   0.6097 0.837 0.403

Likelihood ratio test=0.68  on 1 df, p=0.4083
n= 46, number of events= 12 


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

TCGA-COAD ETV4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 44       12   11.683   0.00861      0.33
strata=LOW   2        0    0.317   0.31718      0.33

 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 -1.706e+01  3.888e-08  8.828e+03 -0.002 0.998

Likelihood ratio test=0.65  on 1 df, p=0.4212
n= 46, number of events= 12 


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

TCGA-COAD PLA2G6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     3.54    0.0611    0.0951
strata=LOW  32        8     8.46    0.0255    0.0951

 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.1995    0.8192   0.6477 -0.308 0.758

Likelihood ratio test=0.09  on 1 df, p=0.7598
n= 46, number of events= 12 


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

TCGA-COAD POR 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     2.18    0.3093     0.411
strata=LOW  34        9     9.82    0.0686     0.411

 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.4511    0.6369   0.7098 -0.635 0.525

Likelihood ratio test=0.38  on 1 df, p=0.5365
n= 46, number of events= 12 


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

TCGA-COAD BRPF1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.39    0.0631    0.0834
strata=LOW  36       10     9.61    0.0157    0.0834

 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.2285    1.2567   0.7928 0.288 0.773

Likelihood ratio test=0.09  on 1 df, p=0.7683
n= 46, number of events= 12 


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

TCGA-COAD TMBIM4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.33     0.136     0.204
strata=LOW  31        8     8.67     0.052     0.204

 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.2910    0.7475   0.6466 -0.45 0.653

Likelihood ratio test=0.2  on 1 df, p=0.6563
n= 46, number of events= 12 


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

TCGA-COAD KRAS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.29   0.02598    0.0389
strata=LOW  31        9     8.71   0.00982    0.0389

 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.1363    1.1460   0.6915 0.197 0.844

Likelihood ratio test=0.04  on 1 df, p=0.8424
n= 46, number of events= 12 


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

TCGA-COAD AHCY 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        5     5.05  0.000564   0.00113
strata=LOW  26        7     6.95  0.000411   0.00113

 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.02114   1.02137  0.63011 0.034 0.973

Likelihood ratio test=0  on 1 df, p=0.9732
n= 46, number of events= 12 


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

TCGA-COAD MIR34C 



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

TCGA-COAD ATG3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2     1.63    0.0859     0.103
strata=LOW  38       10    10.37    0.0135     0.103

 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.2535    0.7761   0.7922 -0.32 0.749

Likelihood ratio test=0.1  on 1 df, p=0.7551
n= 46, number of events= 12 


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

TCGA-COAD MIR30B 



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

TCGA-COAD LYRM1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        4      3.7    0.0245    0.0448
strata=LOW  35        8      8.3    0.0109    0.0448

 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.1435    0.8664   0.6787 -0.211 0.833

Likelihood ratio test=0.04  on 1 df, p=0.8344
n= 46, number of events= 12 


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

TCGA-COAD SIRT6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     4.94     0.762      1.43
strata=LOW  28        9     7.06     0.533      1.43

 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.797     2.219    0.684 1.165 0.244

Likelihood ratio test=1.49  on 1 df, p=0.2219
n= 46, number of events= 12 


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

TCGA-COAD KMT2D 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     3.46    0.0620    0.0913
strata=LOW  30        9     8.54    0.0252    0.0913

 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.2051    1.2276   0.6797 0.302 0.763

Likelihood ratio test=0.09  on 1 df, p=0.7595
n= 46, number of events= 12 


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

TCGA-COAD LPIN1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     3.85     0.893      1.38
strata=LOW  32       10     8.15     0.422      1.38

 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.8911    2.4377   0.7832 1.138 0.255

Likelihood ratio test=1.54  on 1 df, p=0.2151
n= 46, number of events= 12 


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

TCGA-COAD MBOAT2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     4.09     0.291     0.498
strata=LOW  28        9     7.91     0.150     0.498

 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.4851    1.6243   0.6937 0.699 0.484

Likelihood ratio test=0.52  on 1 df, p=0.4722
n= 46, number of events= 12 


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

TCGA-COAD KDM3B 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     2.81   0.01333    0.0188
strata=LOW  33        9     9.19   0.00407    0.0188

 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.09516   0.90923  0.69478 -0.137 0.891

Likelihood ratio test=0.02  on 1 df, p=0.8917
n= 46, number of events= 12 


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

TCGA-COAD ARHGEF26-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 35       10    10.27   0.00687    0.0508
strata=LOW  11        2     1.73   0.04066    0.0508

 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.1814    1.1989   0.8058 0.225 0.822

Likelihood ratio test=0.05  on 1 df, p=0.8248
n= 46, number of events= 12 


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

TCGA-COAD MIR9-1 



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

TCGA-COAD AIFM2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        1     2.93     1.275      1.84
strata=LOW  35       11     9.07     0.412      1.84

 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.333     3.793    1.057 1.261 0.207

Likelihood ratio test=2.23  on 1 df, p=0.1353
n= 46, number of events= 12 


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

TCGA-COAD PRDX1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        1     2.84     1.191       1.7
strata=LOW  33       11     9.16     0.369       1.7

 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 1.289     3.630    1.058 1.218 0.223

Likelihood ratio test=2.06  on 1 df, p=0.1512
n= 46, number of events= 12 


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

TCGA-COAD FOXO4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        4     5.01     0.202     0.414
strata=LOW  23        8     6.99     0.145     0.414

 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.4164    1.5164   0.6517 0.639 0.523

Likelihood ratio test=0.42  on 1 df, p=0.5189
n= 46, number of events= 12 


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

TCGA-COAD BMAL1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        7      4.7     1.124      2.01
strata=LOW  25        5      7.3     0.724      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 -0.8761    0.4164   0.6367 -1.376 0.169

Likelihood ratio test=1.99  on 1 df, p=0.158
n= 46, number of events= 12 


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

TCGA-COAD MIR127 



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

TCGA-COAD TGFBR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1     2.38     0.804      1.07
strata=LOW  36       11     9.62     0.199      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 1.044     2.840    1.057 0.988 0.323

Likelihood ratio test=1.28  on 1 df, p=0.2579
n= 46, number of events= 12 


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

TCGA-COAD NR1D2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        4     3.57    0.0510    0.0802
strata=LOW  28        8     8.43    0.0216    0.0802

 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.1835    0.8324   0.6489 -0.283 0.777

Likelihood ratio test=0.08  on 1 df, p=0.7788
n= 46, number of events= 12 


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

TCGA-COAD FZD7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        6     4.38     0.596      1.01
strata=LOW  27        6     7.62     0.343      1.01

 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.6059    0.5456   0.6123 -0.989 0.322

Likelihood ratio test=0.98  on 1 df, p=0.3212
n= 46, number of events= 12 


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

TCGA-COAD G6PD 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1      4.2      2.44      4.55
strata=LOW  36       11      7.8      1.31      4.55

 Chisq= 4.6  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.958e+01 3.191e+08 8.354e+03 0.002 0.998

Likelihood ratio test=7.6  on 1 df, p=0.005825
n= 46, number of events= 12 


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

TCGA-COAD HRAS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  5        0     1.42     1.415      1.68
strata=LOW  41       12    10.58     0.189      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 1.928e+01 2.360e+08 1.184e+04 0.002 0.999

Likelihood ratio test=3.08  on 1 df, p=0.07905
n= 46, number of events= 12 


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

TCGA-COAD SLC38A1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     3.19     0.443     0.665
strata=LOW  32       10     8.81     0.160     0.665

 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.6391    1.8947   0.7965 0.802 0.422

Likelihood ratio test=0.72  on 1 df, p=0.3955
n= 46, number of events= 12 


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

TCGA-COAD SLC39A14 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.75   0.01622    0.0261
strata=LOW  31        8     8.25   0.00738    0.0261

 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.1047    0.9006   0.6479 -0.162 0.872

Likelihood ratio test=0.03  on 1 df, p=0.8721
n= 46, number of events= 12 


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

TCGA-COAD MIR21 



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

TCGA-COAD MIR1-1 



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

TCGA-COAD PROM2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33       10     8.72     0.189     0.758
strata=LOW  13        2     3.28     0.502     0.758

 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.6874    0.5029   0.8026 -0.857 0.392

Likelihood ratio test=0.83  on 1 df, p=0.3614
n= 46, number of events= 12 


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

TCGA-COAD NFE2L2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     3.44    0.0925     0.141
strata=LOW  30        8     8.56    0.0371     0.141

 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.2427    0.7845   0.6467 -0.375 0.707

Likelihood ratio test=0.14  on 1 df, p=0.71
n= 46, number of events= 12 


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

TCGA-COAD GABARAPL1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4     4.36    0.0294    0.0496
strata=LOW  27        8     7.64    0.0168    0.0496

 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.1405    1.1509   0.6318 0.222 0.824

Likelihood ratio test=0.05  on 1 df, p=0.823
n= 46, number of events= 12 


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

TCGA-COAD MIR335 



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

TCGA-COAD PTEN 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        4     4.22   0.01119    0.0196
strata=LOW  28        8     7.78   0.00606    0.0196

 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.09071   1.09495  0.64888 0.14 0.889

Likelihood ratio test=0.02  on 1 df, p=0.8885
n= 46, number of events= 12 


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

TCGA-COAD PARP4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        5     3.36     0.803      1.24
strata=LOW  28        7     8.64     0.312      1.24

 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.7048    0.4942   0.6444 -1.094 0.274

Likelihood ratio test=1.18  on 1 df, p=0.2779
n= 46, number of events= 12 


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

TCGA-COAD MS4A15 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 34        9     10.4     0.189      1.53
strata=LOW  12        3      1.6     1.232      1.53

 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.8670    2.3798   0.7218 1.201 0.23

Likelihood ratio test=1.3  on 1 df, p=0.2548
n= 46, number of events= 12 


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

TCGA-COAD TIMM9 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.16   0.01118    0.0144
strata=LOW  36       10     9.84   0.00245    0.0144

 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.0951    1.0998   0.7936 0.12 0.905

Likelihood ratio test=0.01  on 1 df, p=0.9037
n= 46, number of events= 12 


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

TCGA-COAD PARP3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        3     2.43     0.134     0.173
strata=LOW  37        9     9.57     0.034     0.173

 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.2811    0.7549   0.6790 -0.414 0.679

Likelihood ratio test=0.16  on 1 df, p=0.6855
n= 46, number of events= 12 


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

TCGA-COAD WIPI1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        6     5.65    0.0219    0.0472
strata=LOW  26        6     6.35    0.0195    0.0472

 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.1331    0.8754   0.6131 -0.217 0.828

Likelihood ratio test=0.05  on 1 df, p=0.8285
n= 46, number of events= 12 


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

TCGA-COAD SNX5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.32    0.0317     0.049
strata=LOW  32        9     8.68    0.0122     0.049

 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.1547    1.1673   0.6997 0.221 0.825

Likelihood ratio test=0.05  on 1 df, p=0.8234
n= 46, number of events= 12 


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

TCGA-COAD LINC00239 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        5     6.31     0.273     0.634
strata=LOW  28        7     5.69     0.303     0.634

 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.4967    1.6433   0.6301 0.788 0.43

Likelihood ratio test=0.64  on 1 df, p=0.4223
n= 46, number of events= 12 


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

TCGA-COAD PIEZO1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.36    0.0387     0.056
strata=LOW  31        9     8.64    0.0150     0.056

 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.1605    1.1741   0.6788 0.236 0.813

Likelihood ratio test=0.06  on 1 df, p=0.811
n= 46, number of events= 12 


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

TCGA-COAD AKR1C2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 37       10    10.36    0.0123    0.0952
strata=LOW   9        2     1.64    0.0772    0.0952

 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.2478    1.2812   0.8052 0.308 0.758

Likelihood ratio test=0.09  on 1 df, p=0.7637
n= 46, number of events= 12 


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

TCGA-COAD MIR4443 



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

TCGA-COAD SLC16A1-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        3     5.16     0.905      1.73
strata=LOW  22        9     6.84     0.683      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.8699    2.3867   0.6814 1.277 0.202

Likelihood ratio test=1.81  on 1 df, p=0.1785
n= 46, number of events= 12 


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

TCGA-COAD FAR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2     3.04     0.357     0.521
strata=LOW  33       10     8.96     0.121     0.521

 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.5661    1.7614   0.7947 0.712 0.476

Likelihood ratio test=0.56  on 1 df, p=0.4531
n= 46, number of events= 12 


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

TCGA-COAD CISD2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     3.02     0.347     0.507
strata=LOW  34       10     8.98     0.117     0.507

 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.5594    1.7497   0.7957 0.703 0.482

Likelihood ratio test=0.55  on 1 df, p=0.4594
n= 46, number of events= 12 


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

TCGA-COAD MAPK3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        5     5.47    0.0398    0.0828
strata=LOW  24        7     6.53    0.0333    0.0828

 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.1778    1.1946   0.6187 0.287 0.774

Likelihood ratio test=0.08  on 1 df, p=0.7735
n= 46, number of events= 12 


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

TCGA-COAD CYGB 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        5      5.3    0.0171    0.0332
strata=LOW  24        7      6.7    0.0135    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.1107    1.1171   0.6079 0.182 0.855

Likelihood ratio test=0.03  on 1 df, p=0.8552
n= 46, number of events= 12 


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

TCGA-COAD MLST8 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  4        0     1.04    1.0358      1.18
strata=LOW  42       12    10.96    0.0978      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 1.820e+01 8.043e+07 8.269e+03 0.002 0.998

Likelihood ratio test=2.21  on 1 df, p=0.1375
n= 46, number of events= 12 


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

TCGA-COAD PANX2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        6     6.79    0.0927     0.232
strata=LOW  23        6     5.21    0.1209     0.232

 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.2922    1.3394   0.6087 0.48 0.631

Likelihood ratio test=0.23  on 1 df, p=0.6303
n= 46, number of events= 12 


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

TCGA-COAD PEBP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        1     2.47     0.875      1.17
strata=LOW  37       11     9.53     0.227      1.17

 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 1.089     2.971    1.056 1.031 0.302

Likelihood ratio test=1.41  on 1 df, p=0.2349
n= 46, number of events= 12 


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

TCGA-COAD PARP8 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.45    0.0585    0.0915
strata=LOW  31        9     8.55    0.0236    0.0915

 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.2106    1.2344   0.6973 0.302 0.763

Likelihood ratio test=0.09  on 1 df, p=0.7598
n= 46, number of events= 12 


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

TCGA-COAD GJA1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     2.26    0.2386      0.31
strata=LOW  35        9     9.74    0.0555      0.31

 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.3835    0.6815   0.6926 -0.554 0.58

Likelihood ratio test=0.29  on 1 df, p=0.59
n= 46, number of events= 12 


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

TCGA-COAD BAP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1     2.05     0.539     0.681
strata=LOW  39       11     9.95     0.111     0.681

 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.8459    2.3300   1.0555 0.801 0.423

Likelihood ratio test=0.8  on 1 df, p=0.3704
n= 46, number of events= 12 


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

TCGA-COAD MAP3K11 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     4.49    0.0533    0.0981
strata=LOW  29        8     7.51    0.0318    0.0981

 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.2032    1.2254   0.6500 0.313 0.755

Likelihood ratio test=0.1  on 1 df, p=0.7532
n= 46, number of events= 12 


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

TCGA-COAD TTBK2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        4     5.62     0.468      1.01
strata=LOW  24        8     6.38     0.413      1.01

 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.6342    1.8856   0.6400 0.991 0.322

Likelihood ratio test=1.02  on 1 df, p=0.3129
n= 46, number of events= 12 


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

TCGA-COAD MIR214 



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

TCGA-COAD PARP15 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        6     4.94     0.227     0.434
strata=LOW  21        6     7.06     0.159     0.434

 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.4082    0.6648   0.6233 -0.655 0.513

Likelihood ratio test=0.43  on 1 df, p=0.511
n= 46, number of events= 12 


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

TCGA-COAD HDDC3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  5        1     1.21   0.03697     0.043
strata=LOW  41       11    10.79   0.00415     0.043

 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.2201    1.2462   1.0636 0.207 0.836

Likelihood ratio test=0.05  on 1 df, p=0.8314
n= 46, number of events= 12 


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

TCGA-COAD MIR10A 



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

TCGA-COAD CGAS 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        5      3.8     0.382     0.592
strata=LOW  25        7      8.2     0.177     0.592

 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.4656    0.6277   0.6107 -0.763 0.446

Likelihood ratio test=0.57  on 1 df, p=0.4506
n= 46, number of events= 12 


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

TCGA-COAD SIRT2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2      2.6    0.1370     0.188
strata=LOW  33       10      9.4    0.0378     0.188

 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.3426    1.4086   0.7949 0.431 0.666

Likelihood ratio test=0.2  on 1 df, p=0.6562
n= 46, number of events= 12 


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

TCGA-COAD PPARD 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        5     5.48    0.0419    0.0961
strata=LOW  23        7     6.52    0.0352    0.0961

 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.1992    1.2204   0.6433 0.31 0.757

Likelihood ratio test=0.1  on 1 df, p=0.7571
n= 46, number of events= 12 


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

TCGA-COAD EGR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        6     6.69    0.0710     0.174
strata=LOW  26        6     5.31    0.0894     0.174

 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.2526    1.2874   0.6073 0.416 0.677

Likelihood ratio test=0.17  on 1 df, p=0.6767
n= 46, number of events= 12 


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

TCGA-COAD AQP3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        7     7.54    0.0388     0.111
strata=LOW  22        5     4.46    0.0655     0.111

 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.2022    1.2241   0.6079 0.333 0.739

Likelihood ratio test=0.11  on 1 df, p=0.7404
n= 46, number of events= 12 


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

TCGA-COAD HSF1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        0     2.82     2.816      3.81
strata=LOW  37       12     9.18     0.863      3.81

 Chisq= 3.8  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.949e+01 2.926e+08 8.752e+03 0.002 0.998

Likelihood ratio test=6.53  on 1 df, p=0.0106
n= 46, number of events= 12 


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

TCGA-COAD MIR18A 



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

TCGA-COAD OSBPL9 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     2.88    0.2678     0.382
strata=LOW  32       10     9.12    0.0845     0.382

 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.4865    1.6265   0.7949 0.612 0.541

Likelihood ratio test=0.41  on 1 df, p=0.5221
n= 46, number of events= 12 


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

TCGA-COAD SESN2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        5     6.25     0.249     0.622
strata=LOW  19        7     5.75     0.270     0.622

 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.4887    1.6301   0.6247 0.782 0.434

Likelihood ratio test=0.61  on 1 df, p=0.434
n= 46, number of events= 12 


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

TCGA-COAD BECN1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.19    0.0108    0.0161
strata=LOW  29        9     8.81    0.0039    0.0161

 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.08831   1.09232  0.69600 0.127 0.899

Likelihood ratio test=0.02  on 1 df, p=0.8985
n= 46, number of events= 12 


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

TCGA-COAD FTMT 



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

TCGA-COAD HCAR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 36        8     8.15   0.00289    0.0114
strata=LOW  10        4     3.85   0.00612    0.0114

 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.07288   1.07560  0.68359 0.107 0.915

Likelihood ratio test=0.01  on 1 df, p=0.9156
n= 46, number of events= 12 


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

TCGA-COAD HILPDA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        8     8.67    0.0518     0.203
strata=LOW  16        4     3.33    0.1348     0.203

 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.2911    1.3380   0.6477 0.45 0.653

Likelihood ratio test=0.2  on 1 df, p=0.6567
n= 46, number of events= 12 


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

TCGA-COAD GSTM1 

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

n=45, 1 observation deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        6     7.38     0.258     0.711
strata=LOW  18        6     4.62     0.412     0.711

 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.5058    1.6583   0.6062 0.834 0.404

Likelihood ratio test=0.7  on 1 df, p=0.4029
n= 45, number of events= 12 
   (1 observation deleted due to missingness)


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

TCGA-COAD MIR222 

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

n=23, 23 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        2    2.584     0.132     0.965
strata=LOW   2        1    0.416     0.818     0.965

 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 1.158     3.182    1.242 0.932 0.351

Likelihood ratio test=0.74  on 1 df, p=0.3887
n= 23, number of events= 3 
   (23 observations deleted due to missingness)


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

TCGA-COAD RARRES2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        6     7.04     0.154     0.417
strata=LOW  23        6     4.96     0.219     0.417

 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.3983    1.4893   0.6208 0.642 0.521

Likelihood ratio test=0.41  on 1 df, p=0.5195
n= 46, number of events= 12 


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

TCGA-COAD BRD4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        2     1.24    0.4588     0.525
strata=LOW  39       10    10.76    0.0531     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.5665    0.5675   0.7921 -0.715 0.474

Likelihood ratio test=0.46  on 1 df, p=0.4998
n= 46, number of events= 12 


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

TCGA-COAD SOCS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     1.99     0.512     0.658
strata=LOW  34        9    10.01     0.102     0.658

 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.5665    0.5675   0.7077 -0.8 0.423

Likelihood ratio test=0.6  on 1 df, p=0.4401
n= 46, number of events= 12 


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

TCGA-COAD MIR17 



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

TCGA-COAD GDF15 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 35       11     7.02      2.26      6.54
strata=LOW  11        1     4.98      3.19      6.54

 Chisq= 6.5  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.986e+01  2.372e-09  7.863e+03 -0.003 0.998

Likelihood ratio test=10.22  on 1 df, p=0.001387
n= 46, number of events= 12 


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

TCGA-COAD ARF6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.71     0.136     0.218
strata=LOW  29        9     8.29     0.061     0.218

 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.3216    1.3794   0.6919 0.465 0.642

Likelihood ratio test=0.22  on 1 df, p=0.6355
n= 46, number of events= 12 


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

TCGA-COAD CDO1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 32        8     8.93     0.096     0.412
strata=LOW  14        4     3.07     0.279     0.412

 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.4173    1.5178   0.6545 0.638 0.524

Likelihood ratio test=0.39  on 1 df, p=0.5303
n= 46, number of events= 12 


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

TCGA-COAD CAMKK2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2      2.2    0.0179     0.023
strata=LOW  35       10      9.8    0.0040     0.023

 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.1202    1.1278   0.7928 0.152 0.879

Likelihood ratio test=0.02  on 1 df, p=0.8781
n= 46, number of events= 12 


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

TCGA-COAD LINC01606 

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

n=26, 20 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        6    6.448    0.0311     0.423
strata=LOW   3        1    0.552    0.3632     0.423

 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.7358    2.0872   1.1574 0.636 0.525

Likelihood ratio test=0.35  on 1 df, p=0.5517
n= 26, number of events= 7 
   (20 observations deleted due to missingness)


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

TCGA-COAD BACH1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.63    0.0381    0.0602
strata=LOW  31        8     8.37    0.0165    0.0602

 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.1587    0.8532   0.6478 -0.245 0.806

Likelihood ratio test=0.06  on 1 df, p=0.8075
n= 46, number of events= 12 


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

TCGA-COAD DPP4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        7     6.57    0.0287     0.069
strata=LOW  21        5     5.43    0.0347     0.069

 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.1595    0.8526   0.6077 -0.262 0.793

Likelihood ratio test=0.07  on 1 df, p=0.7926
n= 46, number of events= 12 


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

TCGA-COAD PPP1R13L 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     3.08     0.275     0.507
strata=LOW  33        8     8.92     0.095     0.507

 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.4801    0.6187   0.6809 -0.705 0.481

Likelihood ratio test=0.46  on 1 df, p=0.4974
n= 46, number of events= 12 


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

TCGA-COAD MIR150 



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

TCGA-COAD FLT3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        6     7.01     0.145     0.402
strata=LOW  16        6     4.99     0.204     0.402

 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.3824    1.4657   0.6069 0.63 0.529

Likelihood ratio test=0.39  on 1 df, p=0.5322
n= 46, number of events= 12 


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

TCGA-COAD MAP1LC3A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     4.05  0.000734   0.00119
strata=LOW  30        8     7.95  0.000375   0.00119

 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.02179   1.02203  0.63278 0.034 0.973

Likelihood ratio test=0  on 1 df, p=0.9725
n= 46, number of events= 12 


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

TCGA-COAD A2M-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        7     6.52    0.0357    0.0883
strata=LOW  17        5     5.48    0.0424    0.0883

 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.1867    0.8297   0.6291 -0.297 0.767

Likelihood ratio test=0.09  on 1 df, p=0.7649
n= 46, number of events= 12 


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

TCGA-COAD PDSS2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     3.35    0.1240     0.188
strata=LOW  33        8     8.65    0.0481     0.188

 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.2804    0.7555   0.6484 -0.432 0.665

Likelihood ratio test=0.18  on 1 df, p=0.6688
n= 46, number of events= 12 


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

TCGA-COAD DNAJB6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        0    0.969    0.9694      1.08
strata=LOW  39       12   11.031    0.0852      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 1.817e+01 7.812e+07 8.500e+03 0.002 0.998

Likelihood ratio test=2.05  on 1 df, p=0.1526
n= 46, number of events= 12 


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

TCGA-COAD SUV39H1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        1      3.1     1.423      2.01
strata=LOW  35       11      8.9     0.496      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 1.379     3.971    1.052 1.311 0.19

Likelihood ratio test=2.48  on 1 df, p=0.1156
n= 46, number of events= 12 


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

TCGA-COAD LPCAT3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        5     6.08     0.192     0.458
strata=LOW  20        7     5.92     0.197     0.458

 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.4180    1.5189   0.6216 0.672 0.501

Likelihood ratio test=0.45  on 1 df, p=0.501
n= 46, number of events= 12 


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

TCGA-COAD MIR761 



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

TCGA-COAD CDCA3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        6     5.34    0.0825     0.174
strata=LOW  28        6     6.66    0.0661     0.174

 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.2569    0.7734   0.6170 -0.416 0.677

Likelihood ratio test=0.17  on 1 df, p=0.6787
n= 46, number of events= 12 


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

TCGA-COAD EPAS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        7     6.38    0.0599     0.154
strata=LOW  19        5     5.62    0.0680     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.2566    0.7737   0.6545 -0.392 0.695

Likelihood ratio test=0.16  on 1 df, p=0.6919
n= 46, number of events= 12 


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

TCGA-COAD SLC11A2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.82    0.2380     0.324
strata=LOW  35       10     9.18    0.0731     0.324

 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.4434    1.5580   0.7852 0.565 0.572

Likelihood ratio test=0.35  on 1 df, p=0.555
n= 46, number of events= 12 


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

TCGA-COAD CREB3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.45    0.0836     0.112
strata=LOW  35       10     9.55    0.0215     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.2649    1.3033   0.7941 0.334 0.739

Likelihood ratio test=0.12  on 1 df, p=0.7322
n= 46, number of events= 12 


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

TCGA-COAD ATF3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 20        7     4.57     1.288      2.23
strata=LOW  26        5     7.43     0.793      2.23

 Chisq= 2.2  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 -0.9118    0.4018   0.6305 -1.446 0.148

Likelihood ratio test=2.2  on 1 df, p=0.1384
n= 46, number of events= 12 


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

TCGA-COAD TGFB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.75     0.152     0.233
strata=LOW  32        9     8.25     0.069     0.233

 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.3269    1.3867   0.6804 0.48 0.631

Likelihood ratio test=0.24  on 1 df, p=0.6231
n= 46, number of events= 12 


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

TCGA-COAD SMG9 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2     2.15   0.01082    0.0139
strata=LOW  38       10     9.85   0.00237    0.0139

 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.09344   1.09795  0.79317 0.118 0.906

Likelihood ratio test=0.01  on 1 df, p=0.9054
n= 46, number of events= 12 


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

TCGA-COAD NOX4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 35       10     9.44    0.0333     0.164
strata=LOW  11        2     2.56    0.1227     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.3182    0.7274   0.7898 -0.403 0.687

Likelihood ratio test=0.17  on 1 df, p=0.6774
n= 46, number of events= 12 


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

TCGA-COAD MIR27A 



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

TCGA-COAD FOXP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        3     3.67    0.1239     0.202
strata=LOW  29        9     8.33    0.0547     0.202

 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.3126    1.3669   0.6985 0.447 0.655

Likelihood ratio test=0.21  on 1 df, p=0.6487
n= 46, number of events= 12 


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

TCGA-COAD SNCA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        7     8.17     0.167     0.595
strata=LOW  17        5     3.83     0.357     0.595

 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.4924    1.6362   0.6446 0.764 0.445

Likelihood ratio test=0.58  on 1 df, p=0.4463
n= 46, number of events= 12 


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

TCGA-COAD ENPP2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        6     7.17     0.189     0.546
strata=LOW  16        6     4.83     0.281     0.546

 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.4453    1.5610   0.6073 0.733 0.463

Likelihood ratio test=0.53  on 1 df, p=0.4681
n= 46, number of events= 12 


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

TCGA-COAD BRD2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        2     2.83    0.2447     0.346
strata=LOW  33       10     9.17    0.0756     0.346

 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.4629    1.5887   0.7942 0.583 0.56

Likelihood ratio test=0.37  on 1 df, p=0.5428
n= 46, number of events= 12 


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

TCGA-COAD ISCU 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     2.77   0.01978    0.0274
strata=LOW  35        9     9.23   0.00593    0.0274

 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.1144    0.8919   0.6913 -0.166 0.869

Likelihood ratio test=0.03  on 1 df, p=0.8695
n= 46, number of events= 12 


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

TCGA-COAD PHF21A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     2.55    0.0790     0.108
strata=LOW  34        9     9.45    0.0213     0.108

 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.2277    0.7963   0.6956 -0.327 0.743

Likelihood ratio test=0.1  on 1 df, p=0.7472
n= 46, number of events= 12 


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

TCGA-COAD PARP6 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2      2.5    0.0984     0.128
strata=LOW  38       10      9.5    0.0258     0.128

 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.2793    1.3223   0.7835 0.357 0.721

Likelihood ratio test=0.13  on 1 df, p=0.7137
n= 46, number of events= 12 


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

TCGA-COAD ZEB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        9     8.56    0.0226    0.0843
strata=LOW  17        3     3.44    0.0562    0.0843

 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.1989    0.8196   0.6861 -0.29 0.772

Likelihood ratio test=0.09  on 1 df, p=0.7689
n= 46, number of events= 12 


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

TCGA-COAD LIG3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.25   0.02735    0.0358
strata=LOW  36       10     9.75   0.00631    0.0358

 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.1502    1.1621   0.7953 0.189 0.85

Likelihood ratio test=0.04  on 1 df, p=0.848
n= 46, number of events= 12 


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

TCGA-COAD PEDS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1     1.89     0.422     0.515
strata=LOW  38       11    10.11     0.079     0.515

 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.7391    2.0941   1.0527 0.702 0.483

Likelihood ratio test=0.6  on 1 df, p=0.4381
n= 46, number of events= 12 


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

TCGA-COAD RPPH1 



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

TCGA-COAD GFRA1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 36       11     9.68     0.181      1.02
strata=LOW  10        1     2.32     0.754      1.02

 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 -1.0266    0.3582   1.0615 -0.967 0.334

Likelihood ratio test=1.21  on 1 df, p=0.2711
n= 46, number of events= 12 


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

TCGA-COAD AQP8 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 45       12   11.745   0.00552     0.263
strata=LOW   1        0    0.255   0.25468     0.263

 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 -1.705e+01  3.926e-08  9.835e+03 -0.002 0.999

Likelihood ratio test=0.52  on 1 df, p=0.4717
n= 46, number of events= 12 


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

TCGA-COAD SIRT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.44    0.0561    0.0859
strata=LOW  31        9     8.56    0.0225    0.0859

 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.2023    1.2242   0.6915 0.293 0.77

Likelihood ratio test=0.09  on 1 df, p=0.767
n= 46, number of events= 12 


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

TCGA-COAD MIR15A 



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

TCGA-COAD AKR1C3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 29        5     7.32     0.733      2.22
strata=LOW  17        7     4.68     1.146      2.22

 Chisq= 2.2  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 0.8822    2.4163   0.6103 1.446 0.148

Likelihood ratio test=2.08  on 1 df, p=0.1493
n= 46, number of events= 12 


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

TCGA-COAD DLD 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     3.71    0.0230    0.0368
strata=LOW  29        8     8.29    0.0103    0.0368

 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.1242    0.8832   0.6478 -0.192 0.848

Likelihood ratio test=0.04  on 1 df, p=0.8486
n= 46, number of events= 12 


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

TCGA-COAD USP11 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.97     0.315     0.433
strata=LOW  36       10     9.03     0.103     0.433

 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.5101    1.6655   0.7834 0.651 0.515

Likelihood ratio test=0.47  on 1 df, p=0.493
n= 46, number of events= 12 


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

TCGA-COAD SREBF2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     3.66    0.0311    0.0495
strata=LOW  33        8     8.34    0.0137    0.0495

 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.1441    0.8658   0.6481 -0.222 0.824

Likelihood ratio test=0.05  on 1 df, p=0.825
n= 46, number of events= 12 


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

TCGA-COAD MIR190A 



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

TCGA-COAD IFNA8 



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

TCGA-COAD KDM6B 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     3.96     0.235     0.402
strata=LOW  30        9     8.04     0.116     0.402

 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.4398    1.5525   0.6990 0.629 0.529

Likelihood ratio test=0.42  on 1 df, p=0.5192
n= 46, number of events= 12 


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

TCGA-COAD ACOT1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        5     4.08     0.208     0.356
strata=LOW  27        7     7.92     0.107     0.356

 Chisq= 0.4  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.3785    0.6849   0.6378 -0.593 0.553

Likelihood ratio test=0.35  on 1 df, p=0.554
n= 46, number of events= 12 


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

TCGA-COAD RELA 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.94  0.001648   0.00205
strata=LOW  37       10    10.06  0.000318   0.00205

 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.03587   0.96477  0.79191 -0.045 0.964

Likelihood ratio test=0  on 1 df, p=0.964
n= 46, number of events= 12 


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

TCGA-COAD SLC39A7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3     3.19    0.0108    0.0161
strata=LOW  34        9     8.81    0.0039    0.0161

 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.08831   1.09232  0.69600 0.127 0.899

Likelihood ratio test=0.02  on 1 df, p=0.8985
n= 46, number of events= 12 


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

TCGA-COAD POM121L12 



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

TCGA-COAD MIR101-1 



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

TCGA-COAD GABPB1-AS1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        2     3.49     0.638     0.942
strata=LOW  32       10     8.51     0.262     0.942

 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.7435    2.1032   0.7837 0.949 0.343

Likelihood ratio test=1.04  on 1 df, p=0.3076
n= 46, number of events= 12 


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

TCGA-COAD EGFR 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        5     4.75   0.01307    0.0254
strata=LOW  24        7     7.25   0.00857    0.0254

 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.1016    0.9034   0.6384 -0.159 0.874

Likelihood ratio test=0.03  on 1 df, p=0.8735
n= 46, number of events= 12 


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

TCGA-COAD BRD7 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     3.28    0.0232    0.0346
strata=LOW  33        9     8.72    0.0087    0.0346

 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.1287    1.1374   0.6920 0.186 0.852

Likelihood ratio test=0.04  on 1 df, p=0.8512
n= 46, number of events= 12 


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

TCGA-COAD MIR1287 



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

TCGA-COAD MIR23A 



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

TCGA-COAD LCE2C 



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

TCGA-COAD ADAMTS13 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.63    0.0383    0.0579
strata=LOW  31        8     8.37    0.0166    0.0579

 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.1517    0.8592   0.6311 -0.24 0.81

Likelihood ratio test=0.06  on 1 df, p=0.8114
n= 46, number of events= 12 


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

TCGA-COAD SIRT3 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.91   0.00217   0.00343
strata=LOW  31        8     8.09   0.00105   0.00343

 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.03701   0.96366  0.63219 -0.059 0.953

Likelihood ratio test=0  on 1 df, p=0.9534
n= 46, number of events= 12 


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

TCGA-COAD CIRBP 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     3.65    0.0345    0.0546
strata=LOW  32        8     8.35    0.0151    0.0546

 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.1510    0.8598   0.6471 -0.233 0.815

Likelihood ratio test=0.05  on 1 df, p=0.8165
n= 46, number of events= 12 


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

TCGA-COAD BRDT 

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

n=23, 23 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        7     5.79     0.255     0.927
strata=LOW   5        1     2.21     0.666     0.927

 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.9906    0.3714   1.0711 -0.925 0.355

Likelihood ratio test=1.08  on 1 df, p=0.2979
n= 23, number of events= 8 
   (23 observations deleted due to missingness)


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

TCGA-COAD KIF4A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        5     6.28     0.262     0.607
strata=LOW  24        7     5.72     0.288     0.607

 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.4865    1.6266   0.6303 0.772 0.44

Likelihood ratio test=0.62  on 1 df, p=0.4323
n= 46, number of events= 12 


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

TCGA-COAD CPEB1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 38       12    10.08     0.368      2.46
strata=LOW   8        0     1.92     1.925      2.46

 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.940e+01  3.766e-09  1.038e+04 -0.002 0.999

Likelihood ratio test=4.34  on 1 df, p=0.03718
n= 46, number of events= 12 


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

TCGA-COAD LINC01833 

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

n=39, 7 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31       10     7.86     0.583      2.83
strata=LOW   8        0     2.14     2.141      2.83

 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.946e+01  3.547e-09  9.962e+03 -0.002 0.998

Likelihood ratio test=4.91  on 1 df, p=0.02664
n= 39, number of events= 10 
   (7 observations deleted due to missingness)


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

TCGA-COAD MAPKAP1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        2     1.61    0.0966     0.115
strata=LOW  39       10    10.39    0.0149     0.115

 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.2683    0.7647   0.7921 -0.339 0.735

Likelihood ratio test=0.11  on 1 df, p=0.7416
n= 46, number of events= 12 


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

TCGA-COAD ATF4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        3      1.8     0.806     0.988
strata=LOW  39        9     10.2     0.142     0.988

 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.6755    0.5089   0.6925 -0.975 0.329

Likelihood ratio test=0.86  on 1 df, p=0.3537
n= 46, number of events= 12 


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

TCGA-COAD SLC7A11 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 35        9      8.7    0.0106    0.0409
strata=LOW  11        3      3.3    0.0280    0.0409

 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.1381    0.8710   0.6836 -0.202 0.84

Likelihood ratio test=0.04  on 1 df, p=0.8383
n= 46, number of events= 12 


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

TCGA-COAD EMC2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        2     1.99  6.23e-05  7.81e-05
strata=LOW  37       10    10.01  1.24e-05  7.81e-05

 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.006999  0.993025  0.792041 -0.009 0.993

Likelihood ratio test=0  on 1 df, p=0.993
n= 46, number of events= 12 


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

TCGA-COAD WWTR1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        8     6.33     0.442      1.05
strata=LOW  22        4     5.67     0.493      1.05

 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.6842    0.5045   0.6799 -1.006 0.314

Likelihood ratio test=1.1  on 1 df, p=0.2932
n= 46, number of events= 12 


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

TCGA-COAD HSPA5 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     2.76    0.2112     0.283
strata=LOW  35       10     9.24    0.0632     0.283

 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.4139    1.5128   0.7831 0.529 0.597

Likelihood ratio test=0.3  on 1 df, p=0.5814
n= 46, number of events= 12 


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

TCGA-COAD BEX1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       10    10.14   0.00185    0.0127
strata=LOW   7        2     1.86   0.01007    0.0127

 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.09056   1.09479  0.80296 0.113 0.91

Likelihood ratio test=0.01  on 1 df, p=0.9109
n= 46, number of events= 12 


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

TCGA-COAD PML 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  4        1     1.51    0.1696     0.201
strata=LOW  42       11    10.49    0.0243     0.201

 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.4711    1.6017   1.0588 0.445 0.656

Likelihood ratio test=0.22  on 1 df, p=0.6359
n= 46, number of events= 12 


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

TCGA-COAD MIR142 



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

TCGA-COAD AEBP2 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.45    0.0836     0.112
strata=LOW  36       10     9.55    0.0215     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.2649    1.3033   0.7941 0.334 0.739

Likelihood ratio test=0.12  on 1 df, p=0.7322
n= 46, number of events= 12 


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

TCGA-COAD GPAT4 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        3     2.23     0.262      0.34
strata=LOW  36        9     9.77     0.060      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.4019    0.6690   0.6936 -0.579 0.562

Likelihood ratio test=0.32  on 1 df, p=0.5733
n= 46, number of events= 12 


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

TCGA-COAD CA9 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       10    10.38    0.0139     0.105
strata=LOW   7        2     1.62    0.0888     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.2546    1.2900   0.7870 0.324 0.746

Likelihood ratio test=0.1  on 1 df, p=0.7527
n= 46, number of events= 12 


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

TCGA-COAD STK11 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1      2.2     0.653     0.842
strata=LOW  38       11      9.8     0.146     0.842

 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.9346    2.5463   1.0557 0.885 0.376

Likelihood ratio test=1  on 1 df, p=0.317
n= 46, number of events= 12 


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

TCGA-COAD TBK1 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        3     2.85   0.00778    0.0111
strata=LOW  33        9     9.15   0.00242    0.0111

 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.07343   0.92920  0.69723 -0.105 0.916

Likelihood ratio test=0.01  on 1 df, p=0.9165
n= 46, number of events= 12 


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

TCGA-COAD CDKN2A 

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

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30       10     8.21     0.392       1.3
strata=LOW  16        2     3.79     0.848       1.3

 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.8678    0.4199   0.7836 -1.107 0.268

Likelihood ratio test=1.45  on 1 df, p=0.2286
n= 46, number of events= 12 


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

TCGA-COAD DCAF7 

[1] 367
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.47    0.0894      0.12
strata=LOW  34       10     9.53    0.0232      0.12

 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.2737    1.3148   0.7934 0.345 0.73

Likelihood ratio test=0.13  on 1 df, p=0.7233
n= 46, number of events= 12 


============================

TCGA-COAD MTF1 

[1] 368
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        4     4.17   0.00707    0.0123
strata=LOW  27        8     7.83   0.00377    0.0123

 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.07181   1.07445  0.64876 0.111 0.912

Likelihood ratio test=0.01  on 1 df, p=0.9117
n= 46, number of events= 12 


============================

TCGA-COAD MEG8 

[1] 369
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=45, 1 observation deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        9     8.05     0.112     0.356
strata=LOW  19        3     3.95     0.228     0.356

 Chisq= 0.4  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.402     0.669    0.678 -0.593 0.553

Likelihood ratio test=0.37  on 1 df, p=0.5421
n= 45, number of events= 12 
   (1 observation deleted due to missingness)


============================

TCGA-COAD CLTRN 

[1] 370
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     4.66     0.591      1.14
strata=LOW  31        9     7.34     0.375      1.14

 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.8161    2.2617   0.7849 1.04 0.298

Likelihood ratio test=1.27  on 1 df, p=0.2607
n= 46, number of events= 12 


============================

TCGA-COAD PARP11 

[1] 371
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     4.78     0.662      1.21
strata=LOW  28        9     7.22     0.438      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.7354    2.0864   0.6839 1.075 0.282

Likelihood ratio test=1.26  on 1 df, p=0.2609
n= 46, number of events= 12 


============================

TCGA-COAD GABARAPL2 

[1] 372
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        4     3.65    0.0345    0.0546
strata=LOW  31        8     8.35    0.0151    0.0546

 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.1510    0.8598   0.6471 -0.233 0.815

Likelihood ratio test=0.05  on 1 df, p=0.8165
n= 46, number of events= 12 


============================

TCGA-COAD CDKN1A 

[1] 373
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 32        7     7.61    0.0495      0.17
strata=LOW  14        5     4.39    0.0859      0.17

 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.2657    1.3043   0.6452 0.412 0.681

Likelihood ratio test=0.17  on 1 df, p=0.6843
n= 46, number of events= 12 


============================

TCGA-COAD NEDD4L 

[1] 374
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        6        7     0.142     0.369
strata=LOW  21        6        5     0.198     0.369

 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.3693    1.4467   0.6108 0.605 0.545

Likelihood ratio test=0.37  on 1 df, p=0.5444
n= 46, number of events= 12 


============================

TCGA-COAD AR 

[1] 375
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        8     8.31    0.0117    0.0412
strata=LOW  18        4     3.69    0.0264    0.0412

 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.1298    1.1386   0.6398 0.203 0.839

Likelihood ratio test=0.04  on 1 df, p=0.8401
n= 46, number of events= 12 


============================

TCGA-COAD MIR20A 



============================

TCGA-COAD HMOX1 

[1] 376
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31        5     6.96     0.553       1.7
strata=LOW  15        7     5.04     0.765       1.7

 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.8058    2.2385   0.6315 1.276 0.202

Likelihood ratio test=1.61  on 1 df, p=0.2047
n= 46, number of events= 12 


============================

TCGA-COAD ZFP36 

[1] 377
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        6     5.72    0.0139    0.0304
strata=LOW  22        6     6.28    0.0126    0.0304

 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.1083    0.8974   0.6213 -0.174 0.862

Likelihood ratio test=0.03  on 1 df, p=0.8615
n= 46, number of events= 12 


============================

TCGA-COAD MIR744 

[1] 378
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=33, 13 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        6     7.32     0.238     0.936
strata=LOW  10        4     2.68     0.651     0.936

 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.6417    1.8998   0.6745 0.951 0.341

Likelihood ratio test=0.87  on 1 df, p=0.3508
n= 33, number of events= 10 
   (13 observations deleted due to missingness)


============================

TCGA-COAD CTSB 

[1] 379
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        3     3.01  7.02e-05   0.00013
strata=LOW  39        9     8.99  2.35e-05   0.00013

 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.00895   1.00899  0.78553 0.011 0.991

Likelihood ratio test=0  on 1 df, p=0.9909
n= 46, number of events= 12 


============================

TCGA-COAD AGPS 

[1] 380
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        4     3.55    0.0578    0.0901
strata=LOW  32        8     8.45    0.0243    0.0901

 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.1940    0.8236   0.6474 -0.3 0.764

Likelihood ratio test=0.09  on 1 df, p=0.766
n= 46, number of events= 12 


============================

TCGA-COAD MT1DP 

[1] 381
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 38        8     9.63     0.277      2.26
strata=LOW   8        4     2.37     1.130      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 0.9853    2.6785   0.6823 1.444 0.149

Likelihood ratio test=1.77  on 1 df, p=0.1836
n= 46, number of events= 12 


============================

TCGA-COAD SNX4 

[1] 382
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        4     3.44    0.0925     0.141
strata=LOW  30        8     8.56    0.0371     0.141

 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.2427    0.7845   0.6467 -0.375 0.707

Likelihood ratio test=0.14  on 1 df, p=0.71
n= 46, number of events= 12 


============================

TCGA-COAD NR4A1 

[1] 383
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        6     4.75     0.328     0.585
strata=LOW  29        6     7.25     0.215     0.585

 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.4625    0.6297   0.6097 -0.759 0.448

Likelihood ratio test=0.58  on 1 df, p=0.447
n= 46, number of events= 12 


============================

TCGA-COAD MFN2 

[1] 384
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        4     3.42    0.0983     0.153
strata=LOW  28        8     8.58    0.0392     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.2553    0.7747   0.6544 -0.39 0.696

Likelihood ratio test=0.15  on 1 df, p=0.699
n= 46, number of events= 12 


============================

TCGA-COAD SELENOI 

[1] 385
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        3     3.57    0.0901     0.145
strata=LOW  28        9     8.43    0.0381     0.145

 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.2651    1.3036   0.6994 0.379 0.705

Likelihood ratio test=0.15  on 1 df, p=0.7003
n= 46, number of events= 12 


============================

TCGA-COAD AGAP2-AS1 

[1] 386
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        8     5.38      1.28      2.52
strata=LOW  21        4     6.62      1.04      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.0322    0.3562   0.6789 -1.521 0.128

Likelihood ratio test=2.61  on 1 df, p=0.1065
n= 46, number of events= 12 


============================

TCGA-COAD TRIM46 

[1] 387
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        5      2.5     2.485      3.48
strata=LOW  31        7      9.5     0.656      3.48

 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.1915    0.3038   0.6757 -1.763 0.0778

Likelihood ratio test=3.07  on 1 df, p=0.07966
n= 46, number of events= 12 


============================

TCGA-COAD CYB5R1 

[1] 388
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     3.01     0.325     0.467
strata=LOW  33        8     8.99     0.109     0.467

 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.4384    0.6451   0.6469 -0.678 0.498

Likelihood ratio test=0.44  on 1 df, p=0.5057
n= 46, number of events= 12 


============================

TCGA-COAD PARK7 

[1] 389
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1     2.74     1.106      1.55
strata=LOW  36       11     9.26     0.327      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 1.238     3.449    1.058 1.17 0.242

Likelihood ratio test=1.88  on 1 df, p=0.1704
n= 46, number of events= 12 


============================

TCGA-COAD CARS1 

[1] 390
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        2     1.31    0.3647     0.423
strata=LOW  39       10    10.69    0.0447     0.423

 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.5115    0.5996   0.7951 -0.643 0.52

Likelihood ratio test=0.37  on 1 df, p=0.5413
n= 46, number of events= 12 


============================

TCGA-COAD NOX1 

[1] 391
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        4     3.65    0.0327     0.054
strata=LOW  24        8     8.35    0.0143     0.054

 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.1536    0.8576   0.6618 -0.232 0.816

Likelihood ratio test=0.05  on 1 df, p=0.8173
n= 46, number of events= 12 


============================

TCGA-COAD VDR 

[1] 392
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        7     5.67     0.314     0.753
strata=LOW  20        5     6.33     0.281     0.753

 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.6038    0.5467   0.7050 -0.856 0.392

Likelihood ratio test=0.78  on 1 df, p=0.3759
n= 46, number of events= 12 


============================

TCGA-COAD PROK2 

[1] 393
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        6      4.6     0.425     0.771
strata=LOW  21        6      7.4     0.265     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.5424    0.5813   0.6242 -0.869 0.385

Likelihood ratio test=0.76  on 1 df, p=0.3833
n= 46, number of events= 12 


============================

TCGA-COAD FABP4 

[1] 394
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 41       11    10.74    0.0061    0.0608
strata=LOW   5        1     1.26    0.0522    0.0608

 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.2611    0.7702   1.0618 -0.246 0.806

Likelihood ratio test=0.06  on 1 df, p=0.7992
n= 46, number of events= 12 


============================

TCGA-COAD ABCB10 

[1] 395
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.23   0.01638    0.0243
strata=LOW  32        9     8.77   0.00603    0.0243

 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.1076    1.1136   0.6911 0.156 0.876

Likelihood ratio test=0.02  on 1 df, p=0.8754
n= 46, number of events= 12 


============================

TCGA-COAD CP 

[1] 396
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 39       10     9.67    0.0113    0.0598
strata=LOW   7        2     2.33    0.0468    0.0598

 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.1914    0.8258   0.7841 -0.244 0.807

Likelihood ratio test=0.06  on 1 df, p=0.8034
n= 46, number of events= 12 


============================

TCGA-COAD MIR4735 



============================

TCGA-COAD MIR130A 



============================

TCGA-COAD TUG1 

[1] 397
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     2.95     0.374     0.532
strata=LOW  33        8     9.05     0.122     0.532

 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.4672    0.6268   0.6464 -0.723 0.47

Likelihood ratio test=0.5  on 1 df, p=0.4784
n= 46, number of events= 12 


============================

TCGA-COAD MIR9-3HG 

[1] 398
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 30        7     7.69    0.0617     0.209
strata=LOW  16        5     4.31    0.1099     0.209

 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.2888    1.3348   0.6341 0.455 0.649

Likelihood ratio test=0.2  on 1 df, p=0.6532
n= 46, number of events= 12 


============================

TCGA-COAD MIR196C 



============================

TCGA-COAD IFNA21 

[1] 399
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=17, 29 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        2    3.217      0.46       2.6
strata=LOW   2        2    0.783      1.89       2.6

 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.766     5.849    1.235 1.43 0.153

Likelihood ratio test=2.2  on 1 df, p=0.1382
n= 17, number of events= 4 
   (29 observations deleted due to missingness)


============================

TCGA-COAD RP11-274B21.9 

[1] 400
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=45, 1 observation deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        7     5.82     0.239     0.519
strata=LOW  21        5     6.18     0.225     0.519

 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.4527    0.6359   0.6333 -0.715 0.475

Likelihood ratio test=0.53  on 1 df, p=0.4677
n= 45, number of events= 12 
   (1 observation deleted due to missingness)


============================

TCGA-COAD PVT1 

[1] 401
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 32        8     7.76   0.00733    0.0254
strata=LOW  14        4     4.24   0.01343    0.0254

 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.1089    0.8969   0.6833 -0.159 0.873

Likelihood ratio test=0.03  on 1 df, p=0.8724
n= 46, number of events= 12 


============================

TCGA-COAD MIR539 



============================

TCGA-COAD IFNA2 



============================

TCGA-COAD TFRC 

[1] 402
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        6     4.35     0.629      1.19
strata=LOW  31        6     7.65     0.357      1.19

 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.6561    0.5189   0.6108 -1.074 0.283

Likelihood ratio test=1.11  on 1 df, p=0.2914
n= 46, number of events= 12 


============================

TCGA-COAD ALOX15B 

[1] 403
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 33        9     7.47     0.314     0.956
strata=LOW  13        3     4.53     0.517     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.6850    0.5041   0.7113 -0.963 0.336

Likelihood ratio test=1.01  on 1 df, p=0.3146
n= 46, number of events= 12 


============================

TCGA-COAD MPC1 

[1] 404
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        6     6.62    0.0575     0.147
strata=LOW  19        6     5.38    0.0707     0.147

 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.2341    1.2637   0.6114 0.383 0.702

Likelihood ratio test=0.15  on 1 df, p=0.7031
n= 46, number of events= 12 


============================

TCGA-COAD MTCH1 

[1] 405
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        1     2.31     0.740     0.968
strata=LOW  38       11     9.69     0.176     0.968

 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.9971    2.7105   1.0558 0.944 0.345

Likelihood ratio test=1.16  on 1 df, p=0.282
n= 46, number of events= 12 


============================

TCGA-COAD MIR324 

[1] 406
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=39, 7 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 25        7      5.7     0.294     0.749
strata=LOW  14        3      4.3     0.391     0.749

 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.6193    0.5383   0.7241 -0.855 0.392

Likelihood ratio test=0.78  on 1 df, p=0.3769
n= 39, number of events= 10 
   (7 observations deleted due to missingness)


============================

TCGA-COAD SNHG14 

[1] 407
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 27        8     8.37    0.0162    0.0582
strata=LOW  19        4     3.63    0.0373    0.0582

 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.1547    1.1673   0.6420 0.241 0.81

Likelihood ratio test=0.06  on 1 df, p=0.8108
n= 46, number of events= 12 


============================

TCGA-COAD PDK4 

[1] 408
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 43       10    10.94    0.0809     0.943
strata=LOW   3        2     1.06    0.8354     0.943

 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.7539    2.1253   0.7941 0.949 0.342

Likelihood ratio test=0.77  on 1 df, p=0.38
n= 46, number of events= 12 


============================

TCGA-COAD DUOX1 

[1] 409
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     5.03     0.818      1.65
strata=LOW  31        9     6.97     0.590      1.65

 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.8929    2.4421   0.7133 1.252 0.211

Likelihood ratio test=1.74  on 1 df, p=0.1874
n= 46, number of events= 12 


============================

TCGA-COAD LINC00886 

[1] 410
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 24        9     7.35     0.371      1.03
strata=LOW  22        3     4.65     0.587      1.03

 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.6782    0.5075   0.6805 -0.997 0.319

Likelihood ratio test=1.08  on 1 df, p=0.2982
n= 46, number of events= 12 


============================

TCGA-COAD NF2 

[1] 411
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  8        2     1.94  0.001648   0.00205
strata=LOW  38       10    10.06  0.000318   0.00205

 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.03587   0.96477  0.79191 -0.045 0.964

Likelihood ratio test=0  on 1 df, p=0.964
n= 46, number of events= 12 


============================

TCGA-COAD MIR149 

[1] 412
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=16, 30 observations deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        5    4.768    0.0113     0.251
strata=LOW   1        0    0.232    0.2317     0.251

 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 -1.813e+01  1.339e-08  1.724e+04 -0.001 0.999

Likelihood ratio test=0.48  on 1 df, p=0.4874
n= 16, number of events= 5 
   (30 observations deleted due to missingness)


============================

TCGA-COAD CYP4F8 

[1] 413
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

n=45, 1 observation deleted due to missingness.

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        6     5.21     0.121     0.257
strata=LOW  17        5     5.79     0.109     0.257

 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.3284    0.7201   0.6505 -0.505 0.614

Likelihood ratio test=0.26  on 1 df, p=0.6106
n= 45, number of events= 11 
   (1 observation deleted due to missingness)


============================

TCGA-COAD AKR1C1 

[1] 414
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31        8     7.54    0.0283     0.092
strata=LOW  15        4     4.46    0.0478     0.092

 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.2072    0.8129   0.6841 -0.303 0.762

Likelihood ratio test=0.09  on 1 df, p=0.7587
n= 46, number of events= 12 


============================

TCGA-COAD PRKCA 

[1] 415
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        6     3.88     1.158      1.91
strata=LOW  27        6     8.12     0.553      1.91

 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.8678    0.4199   0.6481 -1.339 0.181

Likelihood ratio test=1.84  on 1 df, p=0.1747
n= 46, number of events= 12 


============================

TCGA-COAD CD44 

[1] 416
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        6     6.11   0.00194   0.00439
strata=LOW  25        6     5.89   0.00201   0.00439

 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.04042   1.04125  0.60993 0.066 0.947

Likelihood ratio test=0  on 1 df, p=0.9471
n= 46, number of events= 12 


============================

TCGA-COAD FBXW7 

[1] 417
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 15        3     3.06   0.00123    0.0018
strata=LOW  31        9     8.94   0.00042    0.0018

 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.02952   1.02996  0.69617 0.042 0.966

Likelihood ratio test=0  on 1 df, p=0.9661
n= 46, number of events= 12 


============================

TCGA-COAD YAP1 

[1] 418
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        2     2.59    0.1330     0.175
strata=LOW  36       10     9.41    0.0365     0.175

 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.7833 0.416 0.677

Likelihood ratio test=0.19  on 1 df, p=0.667
n= 46, number of events= 12 


============================

TCGA-COAD MTOR 

[1] 419
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     3.59    0.0981     0.147
strata=LOW  30        9     8.41    0.0419     0.147

 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.2605    1.2976   0.6805 0.383 0.702

Likelihood ratio test=0.15  on 1 df, p=0.6966
n= 46, number of events= 12 


============================

TCGA-COAD RICTOR 

[1] 420
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        3     4.96     0.776      1.58
strata=LOW  25        9     7.04     0.547      1.58

 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.8524    2.3454   0.6968 1.223 0.221

Likelihood ratio test=1.63  on 1 df, p=0.2021
n= 46, number of events= 12 


============================

TCGA-COAD WIPI2 

[1] 421
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        1      2.1     0.574     0.731
strata=LOW  37       11      9.9     0.121     0.731

 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.8751    2.3992   1.0561 0.829 0.407

Likelihood ratio test=0.86  on 1 df, p=0.3527
n= 46, number of events= 12 


============================

TCGA-COAD IREB2 

[1] 422
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.48    0.0674     0.104
strata=LOW  32        9     8.52    0.0276     0.104

 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.2228    1.2496   0.6920 0.322 0.747

Likelihood ratio test=0.11  on 1 df, p=0.744
n= 46, number of events= 12 


============================

TCGA-COAD GOT1 

[1] 423
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        3     5.47     1.115      2.32
strata=LOW  25        9     6.53     0.934      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.0039    2.7290   0.6855 1.464 0.143

Likelihood ratio test=2.39  on 1 df, p=0.1219
n= 46, number of events= 12 


============================

TCGA-COAD CD82 

[1] 424
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        5      3.3     0.874       1.6
strata=LOW  35        7      8.7     0.332       1.6

 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.7812    0.4579   0.6321 -1.236 0.217

Likelihood ratio test=1.4  on 1 df, p=0.2368
n= 46, number of events= 12 


============================

TCGA-COAD MAPK9 

[1] 425
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  9        4     1.96     2.129      2.67
strata=LOW  37        8    10.04     0.415      2.67

 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.0198    0.3607   0.6502 -1.568 0.117

Likelihood ratio test=2.23  on 1 df, p=0.1358
n= 46, number of events= 12 


============================

TCGA-COAD LGMN 

[1] 426
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 16        3     3.97     0.235     0.393
strata=LOW  30        9     8.03     0.116     0.393

 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.4311    1.5389   0.6927 0.622 0.534

Likelihood ratio test=0.41  on 1 df, p=0.5233
n= 46, number of events= 12 


============================

TCGA-COAD PARP2 

[1] 427
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  7        1     1.39    0.1084     0.127
strata=LOW  39       11    10.61    0.0142     0.127

 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.3739    1.4534   1.0566 0.354 0.723

Likelihood ratio test=0.14  on 1 df, p=0.7101
n= 46, number of events= 12 


============================

TCGA-COAD MIR16-1 



============================

TCGA-COAD ATG4D 

[1] 428
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        3     5.51     1.145      2.41
strata=LOW  27        9     6.49     0.972      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.0237    2.7836   0.6867 1.491 0.136

Likelihood ratio test=2.48  on 1 df, p=0.1152
n= 46, number of events= 12 


============================

TCGA-COAD RBMS1 

[1] 429
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        5     4.29    0.1162     0.191
strata=LOW  28        7     7.71    0.0648     0.191

 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.264     0.768    0.606 -0.436 0.663

Likelihood ratio test=0.19  on 1 df, p=0.6648
n= 46, number of events= 12 


============================

TCGA-COAD GSTZ1 

[1] 430
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        3     6.28      1.72      4.34
strata=LOW  24        9     5.72      1.89      4.34

 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 1.3458    3.8414   0.6905 1.949 0.0513

Likelihood ratio test=4.3  on 1 df, p=0.03818
n= 46, number of events= 12 


============================

TCGA-COAD SRSF9 

[1] 431
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  2        0    0.572    0.5719     0.612
strata=LOW  44       12   11.428    0.0286     0.612

 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 1.811e+01 7.312e+07 1.093e+04 0.002 0.999

Likelihood ratio test=1.18  on 1 df, p=0.2768
n= 46, number of events= 12 


============================

TCGA-COAD HIF1A 

[1] 432
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 13        4     3.51    0.0689     0.103
strata=LOW  33        8     8.49    0.0285     0.103

 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.2021    0.8170   0.6316 -0.32 0.749

Likelihood ratio test=0.1  on 1 df, p=0.7513
n= 46, number of events= 12 


============================

TCGA-COAD FNDC3B 

[1] 433
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        5     4.16    0.1712     0.304
strata=LOW  27        7     7.84    0.0907     0.304

 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.3546    0.7014   0.6466 -0.548 0.583

Likelihood ratio test=0.3  on 1 df, p=0.5838
n= 46, number of events= 12 


============================

TCGA-COAD RHEBP1 



============================

TCGA-COAD PSEN1 

[1] 434
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     3.96  0.000355  0.000592
strata=LOW  29        8     8.04  0.000175  0.000592

 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.01577   0.98436  0.64810 -0.024 0.981

Likelihood ratio test=0  on 1 df, p=0.9806
n= 46, number of events= 12 


============================

TCGA-COAD ADIPOQ 

[1] 435
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 44       11   11.223   0.00442    0.0701
strata=LOW   2        1    0.777   0.06386    0.0701

 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.2805    1.3237   1.0624 0.264 0.792

Likelihood ratio test=0.06  on 1 df, p=0.799
n= 46, number of events= 12 


============================

TCGA-COAD MUC1 

[1] 436
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 31        6     7.58     0.328      1.11
strata=LOW  15        6     4.42     0.563      1.11

 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.6460    1.9079   0.6209 1.04 0.298

Likelihood ratio test=1.04  on 1 df, p=0.3068
n= 46, number of events= 12 


============================

TCGA-COAD CAV1 

[1] 437
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 28        8     8.18   0.00400    0.0136
strata=LOW  18        4     3.82   0.00856    0.0136

 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.07421   1.07703  0.63760 0.116 0.907

Likelihood ratio test=0.01  on 1 df, p=0.9076
n= 46, number of events= 12 


============================

TCGA-COAD SEC24B 

[1] 438
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        2     2.88    0.2678     0.382
strata=LOW  34       10     9.12    0.0845     0.382

 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.4865    1.6265   0.7949 0.612 0.541

Likelihood ratio test=0.41  on 1 df, p=0.5221
n= 46, number of events= 12 


============================

TCGA-COAD PRDX6 

[1] 439
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 23        5     5.53    0.0505     0.107
strata=LOW  23        7     6.47    0.0432     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.2031    1.2251   0.6210 0.327 0.744

Likelihood ratio test=0.11  on 1 df, p=0.7433
n= 46, number of events= 12 


============================

TCGA-COAD TMEM161B-DT 

[1] 440
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 17        4     4.22   0.01119    0.0196
strata=LOW  29        8     7.78   0.00606    0.0196

 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.09071   1.09495  0.64888 0.14 0.889

Likelihood ratio test=0.02  on 1 df, p=0.8885
n= 46, number of events= 12 


============================

TCGA-COAD PGD 

[1] 441
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH  6        2      1.3    0.3825     0.441
strata=LOW  40       10     10.7    0.0463     0.441

 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.5211    0.5939   0.7931 -0.657 0.511

Likelihood ratio test=0.39  on 1 df, p=0.5333
n= 46, number of events= 12 


============================

TCGA-COAD RHOT1 

[1] 442
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        3     2.29    0.2177     0.286
strata=LOW  35        9     9.71    0.0514     0.286

 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.3706    0.6903   0.6962 -0.532 0.595

Likelihood ratio test=0.27  on 1 df, p=0.6039
n= 46, number of events= 12 


============================

TCGA-COAD ACSL1 

[1] 443
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 14        3     3.36    0.0379     0.055
strata=LOW  32        9     8.64    0.0147     0.055

 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.1593    1.1727   0.6798 0.234 0.815

Likelihood ratio test=0.06  on 1 df, p=0.8126
n= 46, number of events= 12 


============================

TCGA-COAD NEDD4 

[1] 444
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        6      4.6     0.426     0.753
strata=LOW  27        6      7.4     0.265     0.753

 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.5286    0.5894   0.6158 -0.858 0.391

Likelihood ratio test=0.74  on 1 df, p=0.3891
n= 46, number of events= 12 


============================

TCGA-COAD ELOVL5 

[1] 445
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 11        2     3.61     0.715      1.15
strata=LOW  35       10     8.39     0.307      1.15

 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.8438    2.3252   0.8069 1.046 0.296

Likelihood ratio test=1.27  on 1 df, p=0.2599
n= 46, number of events= 12 


============================

TCGA-COAD YY1AP1 

[1] 446
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12        3      2.3     0.216     0.283
strata=LOW  34        9      9.7     0.051     0.283

 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.3674    0.6926   0.6945 -0.529 0.597

Likelihood ratio test=0.27  on 1 df, p=0.6062
n= 46, number of events= 12 


============================

Display the results only for genes where a significant difference in survival has been reported.

significant_genes
[1] "NOX5"      "CDH1"      "LINC01134" "MYCN"      "G6PD"      "GDF15"     "GSTZ1"    
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 NOX5 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 26        3     6.23      1.67      3.94
strata=LOW  20        9     5.77      1.80      3.94

 Chisq= 3.9  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.2699    3.5606   0.6818 1.863 0.0625

Likelihood ratio test=3.96  on 1 df, p=0.04665
n= 46, number of events= 12 


============================

TCGA-COAD CDH1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 21        8     4.32      3.12      5.56
strata=LOW  25        4     7.68      1.76      5.56

 Chisq= 5.6  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.6773    0.1869   0.7946 -2.111 0.0348

Likelihood ratio test=5.74  on 1 df, p=0.01663
n= 46, number of events= 12 


============================

TCGA-COAD LINC01134 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 18        7      3.8      2.69      4.47
strata=LOW  28        5      8.2      1.25      4.47

 Chisq= 4.5  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.3915    0.2487   0.7074 -1.967 0.0492

Likelihood ratio test=4.35  on 1 df, p=0.037
n= 46, number of events= 12 


============================

TCGA-COAD MYCN 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 19        1      4.4      2.63       4.4
strata=LOW  27       11      7.6      1.52       4.4

 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.902     6.697    1.049 1.812 0.0699

Likelihood ratio test=5.37  on 1 df, p=0.02054
n= 46, number of events= 12 


============================

TCGA-COAD G6PD 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 10        1      4.2      2.44      4.55
strata=LOW  36       11      7.8      1.31      4.55

 Chisq= 4.6  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.958e+01 3.191e+08 8.354e+03 0.002 0.998

Likelihood ratio test=7.6  on 1 df, p=0.005825
n= 46, number of events= 12 


============================

TCGA-COAD GDF15 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 35       11     7.02      2.26      6.54
strata=LOW  11        1     4.98      3.19      6.54

 Chisq= 6.5  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.986e+01  2.372e-09  7.863e+03 -0.003 0.998

Likelihood ratio test=10.22  on 1 df, p=0.001387
n= 46, number of events= 12 


============================

TCGA-COAD GSTZ1 

Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata, 
    data = gene_df)

             N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 22        3     6.28      1.72      4.34
strata=LOW  24        9     5.72      1.89      4.34

 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 1.3458    3.8414   0.6905 1.949 0.0513

Likelihood ratio test=4.3  on 1 df, p=0.03818
n= 46, number of events= 12 


============================


  1. De La Salle University, Manila, Philippines, ↩︎

  2. De La Salle University, Manila, Philippines, ↩︎

LS0tDQp0aXRsZTogIlN1cnZpdmFsIEFuYWx5c2lzIg0Kc3VidGl0bGU6ICJDb2xvcmVjdGFsIENhbmNlciB8IEZlcnJvcHRvc2lzIHwgVW5pcXVlIEdlbmVzIHBlciBSQ0QgVHlwZSB8IExvZyBGb2xkIENoYW5nZSINCmF1dGhvcjogDQogIC0gTWFyayBFZHdhcmQgTS4gR29uemFsZXNeW0RlIExhIFNhbGxlIFVuaXZlcnNpdHksIE1hbmlsYSwgUGhpbGlwcGluZXMsIGdvbnphbGVzLm1hcmtlZHdhcmRAZ21haWwuY29tXQ0KICAtIERyLiBBbmlzaCBNLlMuIFNocmVzdGhhXltEZSBMYSBTYWxsZSBVbml2ZXJzaXR5LCBNYW5pbGEsIFBoaWxpcHBpbmVzLCBhbmlzaC5zaHJlc3RoYUBkbHN1LmVkdS5waF0NCm91dHB1dDogaHRtbF9ub3RlYm9vaw0KLS0tDQoNCiMjIEkuIFByZWxpbWluYXJpZXMNCg0KIyMjIExvYWRpbmcgbGlicmFyaWVzDQoNCmBgYHtyLCB3YXJuaW5nPUZBTFNFLCBtZXNzYWdlPUZBTFNFfQ0KbGlicmFyeSgidGlkeXZlcnNlIikNCmxpYnJhcnkoInRpYmJsZSIpDQpsaWJyYXJ5KCJtc2lnZGJyIikNCmxpYnJhcnkoImdncGxvdDIiKQ0KbGlicmFyeSgiVENHQWJpb2xpbmtzIikNCmxpYnJhcnkoIlJOQXNlcVFDIikNCmxpYnJhcnkoIkRFU2VxMiIpDQpsaWJyYXJ5KCJlbnNlbWJsZGIiKQ0KbGlicmFyeSgicHVycnIiKQ0KbGlicmFyeSgibWFncml0dHIiKQ0KbGlicmFyeSgidnNuIikNCmxpYnJhcnkoIm1hdHJpeFN0YXRzIikNCmxpYnJhcnkoImRwbHlyIikNCmxpYnJhcnkoImdyZXgiKQ0KbGlicmFyeSgic3Vydm1pbmVyIikNCmxpYnJhcnkoInN1cnZpdmFsIikNCmBgYA0KDQojIyBJSS4gRG93bmxvYWRpbmcgdGhlIFRDR0EgZ2VuZSBleHByZXNzaW9uIGRhdGEgDQoNCkNyZWF0ZSBhIGZ1bmN0aW9uIGZvciBkb3dubG9hZGluZyBUQ0dBIGdlbmUgZXhwcmVzc2lvbiBkYXRhLiANCg0KRm9yIG1vcmUgZGV0YWlsZWQgZG9jdW1lbnRhdGlvbiwgcmVmZXIgdG8gYDIuIERpZmZlcmVudGlhbCBHZW5lIEV4cHJlc3Npb24gQW5hbHlzaXMgLSBUQ0dBLlJtZGAuDQoNCmBgYHtyfQ0KcXVlcnlfYW5kX2ZpbHRlcl9zYW1wbGVzIDwtIGZ1bmN0aW9uKHByb2plY3QpIHsNCiAgcXVlcnlfdHVtb3IgPC0gR0RDcXVlcnkoDQogICAgcHJvamVjdCA9IHByb2plY3QsDQogICAgZGF0YS5jYXRlZ29yeSA9ICJUcmFuc2NyaXB0b21lIFByb2ZpbGluZyIsDQogICAgZGF0YS50eXBlID0gIkdlbmUgRXhwcmVzc2lvbiBRdWFudGlmaWNhdGlvbiIsDQogICAgZXhwZXJpbWVudGFsLnN0cmF0ZWd5ID0gIlJOQS1TZXEiLA0KICAgIHdvcmtmbG93LnR5cGUgPSAiU1RBUiAtIENvdW50cyIsDQogICAgYWNjZXNzID0gIm9wZW4iLA0KICAgIHNhbXBsZS50eXBlID0gIlByaW1hcnkgVHVtb3IiDQogICkNCiAgdHVtb3IgPC0gZ2V0UmVzdWx0cyhxdWVyeV90dW1vcikNCg0KICBxdWVyeV9ub3JtYWwgPC0gR0RDcXVlcnkoDQogICAgcHJvamVjdCA9IHByb2plY3QsDQogICAgZGF0YS5jYXRlZ29yeSA9ICJUcmFuc2NyaXB0b21lIFByb2ZpbGluZyIsDQogICAgZGF0YS50eXBlID0gIkdlbmUgRXhwcmVzc2lvbiBRdWFudGlmaWNhdGlvbiIsDQogICAgZXhwZXJpbWVudGFsLnN0cmF0ZWd5ID0gIlJOQS1TZXEiLA0KICAgIHdvcmtmbG93LnR5cGUgPSAiU1RBUiAtIENvdW50cyIsDQogICAgYWNjZXNzID0gIm9wZW4iLA0KICAgIHNhbXBsZS50eXBlID0gIlNvbGlkIFRpc3N1ZSBOb3JtYWwiDQogICkNCiAgbm9ybWFsIDwtIGdldFJlc3VsdHMocXVlcnlfbm9ybWFsKQ0KDQogIHN1Ym1pdHRlcl9pZHMgPC0gaW5uZXJfam9pbih0dW1vciwgbm9ybWFsLCBieSA9ICJjYXNlcy5zdWJtaXR0ZXJfaWQiKSAlPiUNCiAgICBkcGx5cjo6c2VsZWN0KGNhc2VzLnN1Ym1pdHRlcl9pZCkNCiAgdHVtb3IgPC0gdHVtb3IgJT4lDQogICAgZHBseXI6OmZpbHRlcihjYXNlcy5zdWJtaXR0ZXJfaWQgJWluJSBzdWJtaXR0ZXJfaWRzJGNhc2VzLnN1Ym1pdHRlcl9pZCkNCiAgbm9ybWFsIDwtIG5vcm1hbCAlPiUNCiAgICBkcGx5cjo6ZmlsdGVyKGNhc2VzLnN1Ym1pdHRlcl9pZCAlaW4lIHN1Ym1pdHRlcl9pZHMkY2FzZXMuc3VibWl0dGVyX2lkKQ0KDQogIHNhbXBsZXMgPC0gcmJpbmQodHVtb3IsIG5vcm1hbCkNCiAgdW5pcXVlKHNhbXBsZXMkc2FtcGxlX3R5cGUpDQoNCiAgcXVlcnlfcHJvamVjdCA8LSBHRENxdWVyeSgNCiAgICBwcm9qZWN0ID0gcHJvamVjdCwNCiAgICBkYXRhLmNhdGVnb3J5ID0gIlRyYW5zY3JpcHRvbWUgUHJvZmlsaW5nIiwNCiAgICBkYXRhLnR5cGUgPSAiR2VuZSBFeHByZXNzaW9uIFF1YW50aWZpY2F0aW9uIiwNCiAgICBleHBlcmltZW50YWwuc3RyYXRlZ3kgPSAiUk5BLVNlcSIsDQogICAgd29ya2Zsb3cudHlwZSA9ICJTVEFSIC0gQ291bnRzIiwNCiAgICBhY2Nlc3MgPSAib3BlbiIsDQogICAgc2FtcGxlLnR5cGUgPSBjKCJTb2xpZCBUaXNzdWUgTm9ybWFsIiwgIlByaW1hcnkgVHVtb3IiKSwNCiAgICBiYXJjb2RlID0gYXMubGlzdChzYW1wbGVzJHNhbXBsZS5zdWJtaXR0ZXJfaWQpDQogICkNCg0KICAjIElmIHRoaXMgaXMgeW91ciBmaXJzdCB0aW1lIHJ1bm5pbmcgdGhpcyBub3RlYm9vayAoaS5lLiwgeW91IGhhdmUgbm90IHlldCBkb3dubG9hZGVkIHRoZSByZXN1bHRzIG9mIHRoZSBxdWVyeSBpbiB0aGUgcHJldmlvdXMgYmxvY2spLA0KICAjIHVuY29tbWVudCB0aGUgbGluZSBiZWxvdw0KDQogICMgR0RDZG93bmxvYWQocXVlcnlfcHJvamVjdCkNCg0KICByZXR1cm4obGlzdChzYW1wbGVzID0gc2FtcGxlcywgcXVlcnlfcHJvamVjdCA9IHF1ZXJ5X3Byb2plY3QpKQ0KfQ0KYGBgDQoNCkRvd25sb2FkIHRoZSBUQ0dBIGdlbmUgZXhwcmVzc2lvbiBkYXRhIGZvciBjb2xvcmVjdGFsIGNhbmNlciAoVENHQS1DT0FEKS4NCg0KYGBge3IsIGVjaG8gPSBUUlVFLCBtZXNzYWdlID0gRkFMU0UsIHJlc3VsdHM9ImhpZGUifQ0KcHJvamVjdHMgPC0gYygiVENHQS1DT0FEIikNCg0Kd2l0aF9yZXN1bHRzX3Byb2plY3RzIDwtIGMoKQ0KDQpzYW1wbGVzIDwtIGxpc3QoKQ0KcHJvamVjdF9kYXRhIDwtIGxpc3QoKQ0KDQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgcmVzdWx0IDwtIHRyeUNhdGNoKA0KICAgIHsNCiAgICAgIHJlc3VsdCA8LSBxdWVyeV9hbmRfZmlsdGVyX3NhbXBsZXMocHJvamVjdCkNCiAgICAgIHNhbXBsZXNbW3Byb2plY3RdXSA8LSByZXN1bHQkc2FtcGxlcw0KICAgICAgcHJvamVjdF9kYXRhW1twcm9qZWN0XV0gPC0gcmVzdWx0JHF1ZXJ5X3Byb2plY3QNCg0KICAgICAgd2l0aF9yZXN1bHRzX3Byb2plY3RzIDwtIGMod2l0aF9yZXN1bHRzX3Byb2plY3RzLCBwcm9qZWN0KQ0KICAgIH0sDQogICAgZXJyb3IgPSBmdW5jdGlvbihlKSB7DQoNCiAgICB9DQogICkNCn0NCmBgYA0KDQpSdW5uaW5nIHRoZSBjb2RlIGJsb2NrIGFib3ZlIHNob3VsZCBnZW5lcmF0ZSBhbmQgcG9wdWxhdGUgYSBkaXJlY3RvcnkgbmFtZWQgYEdEQ2RhdGFgLg0KDQojIyBJSUkuIERhdGEgcHJlcHJvY2Vzc2luZw0KDQpDb25zdHJ1Y3QgdGhlIFJOQS1zZXEgY291bnQgbWF0cml4IGZvciBlYWNoIGNhbmNlciB0eXBlLg0KDQpgYGB7ciwgZWNobyA9IFRSVUUsIG1lc3NhZ2UgPSBGQUxTRSwgcmVzdWx0cz0iaGlkZSJ9DQp0Y2dhX2RhdGEgPC0gbGlzdCgpDQp0Y2dhX21hdHJpeCA8LSBsaXN0KCkNCg0KcHJvamVjdHMgPC0gd2l0aF9yZXN1bHRzX3Byb2plY3RzDQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgdGNnYV9kYXRhW1twcm9qZWN0XV0gPC0gR0RDcHJlcGFyZShwcm9qZWN0X2RhdGFbW3Byb2plY3RdXSwgc3VtbWFyaXplZEV4cGVyaW1lbnQgPSBUUlVFKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogIGNvdW50X21hdHJpeCA8LSBhc3NheSh0Y2dhX2RhdGFbW3Byb2plY3RdXSwgInVuc3RyYW5kZWQiKQ0KDQogICMgUmVtb3ZlIGR1cGxpY2F0ZSBlbnRyaWVzDQogIGNvdW50X21hdHJpeF9kZiA8LSBkYXRhLmZyYW1lKGNvdW50X21hdHJpeCkNCiAgY291bnRfbWF0cml4X2RmIDwtIGNvdW50X21hdHJpeF9kZlshZHVwbGljYXRlZChjb3VudF9tYXRyaXhfZGYpLCBdDQogIGNvdW50X21hdHJpeCA8LSBkYXRhLm1hdHJpeChjb3VudF9tYXRyaXhfZGYpDQogIHJvd25hbWVzKGNvdW50X21hdHJpeCkgPC0gY2xlYW5pZChyb3duYW1lcyhjb3VudF9tYXRyaXgpKQ0KICBjb3VudF9tYXRyaXggPC0gY291bnRfbWF0cml4WyEoZHVwbGljYXRlZChyb3duYW1lcyhjb3VudF9tYXRyaXgpKSB8IGR1cGxpY2F0ZWQocm93bmFtZXMoY291bnRfbWF0cml4KSwgZnJvbUxhc3QgPSBUUlVFKSksIF0NCg0KICB0Y2dhX21hdHJpeFtbcHJvamVjdF1dIDwtIGNvdW50X21hdHJpeA0KfQ0KYGBgDQpGb3JtYXQgdGhlIGBzYW1wbGVzYCB0YWJsZSBzbyB0aGF0IGl0IGNhbiBiZSBmZWQgYXMgaW5wdXQgdG8gREVTZXEyLg0KDQpgYGB7cn0NCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pIDwtIHNhbXBsZXNbW3Byb2plY3RdXSRjYXNlcw0KICBzYW1wbGVzW1twcm9qZWN0XV0gPC0gc2FtcGxlc1tbcHJvamVjdF1dICU+JQ0KICAgIGRwbHlyOjpzZWxlY3QoY2FzZSA9ICJjYXNlcy5zdWJtaXR0ZXJfaWQiLCB0eXBlID0gInNhbXBsZV90eXBlIikNCiAgc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUgPC0gc3RyX3JlcGxhY2Uoc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUsICJTb2xpZCBUaXNzdWUgTm9ybWFsIiwgIm5vcm1hbCIpDQogIHNhbXBsZXNbW3Byb2plY3RdXSR0eXBlIDwtIHN0cl9yZXBsYWNlKHNhbXBsZXNbW3Byb2plY3RdXSR0eXBlLCAiUHJpbWFyeSBUdW1vciIsICJ0dW1vciIpDQp9DQpgYGANCg0KREVTZXEyIHJlcXVpcmVzIHRoZSByb3cgbmFtZXMgb2YgYHNhbXBsZXNgIHNob3VsZCBiZSBpZGVudGljYWwgdG8gdGhlIGNvbHVtbiBuYW1lcyBvZiBgY291bnRfbWF0cml4YC4NCg0KYGBge3IsIGVjaG8gPSBUUlVFLCByZXN1bHRzPSJoaWRlIn0NCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICBjb2xuYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSA8LSBnc3ViKHggPSBjb2xuYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSwgcGF0dGVybiA9ICJcXC4iLCByZXBsYWNlbWVudCA9ICItIikNCiAgdGNnYV9tYXRyaXhbW3Byb2plY3RdXSA8LSB0Y2dhX21hdHJpeFtbcHJvamVjdF1dWywgcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKV0NCg0KICAjIFNhbml0eSBjaGVjaw0KICBwcmludChhbGwoY29sbmFtZXModGNnYV9tYXRyaXhbW3Byb2plY3RdXSkgPT0gcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKSkpDQp9DQpgYGANCg0KIyMgSVYuIERpZmZlcmVudGlhbCBnZW5lIGV4cHJlc3Npb24gYW5hbHlzaXMNCg0KRm9yIG1vcmUgZGV0YWlsZWQgZG9jdW1lbnRhdGlvbiBvbiBvYnRhaW5pbmcgdGhlIGdlbmUgc2V0LCByZWZlciB0byBgNy4gRGlmZmVyZW50aWFsIEdlbmUgRXhwcmVzc2lvbiBBbmFseXNpcyAtIFRDR0EgLSBQYW4tY2FuY2VyIC0gVW5pcXVlIEdlbmVzLlJtZGAuDQoNCmBgYHtyfQ0KUkNEZGIgPC0gInRlbXAvdW5pcXVlX2dlbmVzL25lY3JvcHRvc2lzX2ZlcnJvcHRvc2lzX3B5cm9wdG9zaXMvIg0KYGBgDQoNCldyaXRlIHV0aWxpdHkgZnVuY3Rpb25zIGZvciBmaWx0ZXJpbmcgdGhlIGdlbmUgc2V0cywgcGVyZm9ybWluZyBkaWZmZXJlbnRpYWwgZ2VuZSBleHByZXNzaW9uIGFuYWx5c2lzLCBwbG90dGluZyB0aGUgcmVzdWx0cywgYW5kIHBlcmZvcm1pbmcgdmFyaWFuY2Utc3RhYmlsaXppbmcgdHJhbnNmb3JtYXRpb24uDQoNCmBgYHtyfQ0KZmlsdGVyX2dlbmVfc2V0X2FuZF9wZXJmb3JtX2RnZWEgPC0gZnVuY3Rpb24oZ2VuZXMpIHsNCiAgdGNnYV9yY2QgPC0gbGlzdCgpDQoNCiAgZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogICAgcm93bmFtZXMoZ2VuZXMpIDwtIGdlbmVzJGdlbmVfaWQNCiAgICB0Y2dhX3JjZFtbcHJvamVjdF1dIDwtIHRjZ2FfbWF0cml4W1twcm9qZWN0XV1bcm93bmFtZXModGNnYV9tYXRyaXhbW3Byb2plY3RdXSkgJWluJSBnZW5lcyRnZW5lX2lkLCBdDQogICAgdGNnYV9yY2RbW3Byb2plY3RdXSA8LSB0Y2dhX3JjZFtbcHJvamVjdF1dWywgcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKV0NCiAgfQ0KDQogIGRkc19yY2QgPC0gbGlzdCgpDQogIHJlc19yY2QgPC0gbGlzdCgpDQoNCiAgZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogICAgcHJpbnQocHJvamVjdCkNCiAgICBwcmludCgiPT09PT09PT09PT09PSIpDQogICAgZGRzIDwtIERFU2VxRGF0YVNldEZyb21NYXRyaXgoDQogICAgICBjb3VudERhdGEgPSB0Y2dhX3JjZFtbcHJvamVjdF1dLA0KICAgICAgY29sRGF0YSA9IHNhbXBsZXNbW3Byb2plY3RdXSwNCiAgICAgIGRlc2lnbiA9IH50eXBlDQogICAgKQ0KICAgIGRkcyA8LSBmaWx0ZXJfZ2VuZXMoZGRzLCBtaW5fY291bnQgPSAxMCkNCiAgICBkZHMkdHlwZSA8LSByZWxldmVsKGRkcyR0eXBlLCByZWYgPSAibm9ybWFsIikNCiAgICBkZHNfcmNkW1twcm9qZWN0XV0gPC0gREVTZXEoZGRzKQ0KICAgIHJlc19yY2RbW3Byb2plY3RdXSA8LSByZXN1bHRzKGRkc19yY2RbW3Byb2plY3RdXSkNCiAgfQ0KDQogIGRlc2VxLmJibC5kYXRhIDwtIGxpc3QoKQ0KDQogIGZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICAgIGRlc2VxLnJlc3VsdHMgPC0gcmVzX3JjZFtbcHJvamVjdF1dDQogICAgZGVzZXEuYmJsLmRhdGFbW3Byb2plY3RdXSA8LSBkYXRhLmZyYW1lKA0KICAgICAgcm93Lm5hbWVzID0gcm93bmFtZXMoZGVzZXEucmVzdWx0cyksDQogICAgICBiYXNlTWVhbiA9IGRlc2VxLnJlc3VsdHMkYmFzZU1lYW4sDQogICAgICBsb2cyRm9sZENoYW5nZSA9IGRlc2VxLnJlc3VsdHMkbG9nMkZvbGRDaGFuZ2UsDQogICAgICBsZmNTRSA9IGRlc2VxLnJlc3VsdHMkbGZjU0UsDQogICAgICBzdGF0ID0gZGVzZXEucmVzdWx0cyRzdGF0LA0KICAgICAgcHZhbHVlID0gZGVzZXEucmVzdWx0cyRwdmFsdWUsDQogICAgICBwYWRqID0gZGVzZXEucmVzdWx0cyRwYWRqLA0KICAgICAgY2FuY2VyX3R5cGUgPSBwcm9qZWN0LA0KICAgICAgZ2VuZV9zeW1ib2wgPSBnZW5lc1tyb3duYW1lcyhkZXNlcS5yZXN1bHRzKSwgImdlbmUiXQ0KICAgICkNCiAgfQ0KDQogIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkIDwtIGJpbmRfcm93cyhkZXNlcS5iYmwuZGF0YSkNCiAgZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gZHBseXI6OmZpbHRlcihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCwgYWJzKGxvZzJGb2xkQ2hhbmdlKSA+PSAxLjUgJiBwYWRqIDwgMC4wNSkNCg0KICByZXR1cm4oZGVzZXEuYmJsLmRhdGEuY29tYmluZWQpDQp9DQpgYGANCg0KYGBge3J9DQpwbG90X2RnZWEgPC0gZnVuY3Rpb24oZGVzZXEuYmJsLmRhdGEuY29tYmluZWQpIHsNCiAgc2l6ZXMgPC0gYygiPDEwXi0xNSIgPSA0LCAiMTBeLTEwIiA9IDMsICIxMF4tNSIgPSAyLCAiMC4wNSIgPSAxKQ0KDQogIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkIDwtIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkICU+JQ0KICAgIG11dGF0ZShmZHJfY2F0ZWdvcnkgPSBjdXQocGFkaiwNCiAgICAgIGJyZWFrcyA9IGMoLUluZiwgMWUtMTUsIDFlLTEwLCAxZS01LCAwLjA1KSwNCiAgICAgIGxhYmVscyA9IGMoIjwxMF4tMTUiLCAiMTBeLTEwIiwgIjEwXi01IiwgIjAuMDUiKSwNCiAgICAgIHJpZ2h0ID0gRkFMU0UNCiAgICApKQ0KDQogIHRvcF9nZW5lcyA8LSBkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCAlPiUNCiAgICBncm91cF9ieShjYW5jZXJfdHlwZSkgJT4lDQogICAgbXV0YXRlKHJhbmsgPSByYW5rKC1hYnMobG9nMkZvbGRDaGFuZ2UpKSkgJT4lDQogICAgZHBseXI6OmZpbHRlcihyYW5rIDw9IDEwKSAlPiUNCiAgICB1bmdyb3VwKCkNCg0KICBnZ3Bsb3QodG9wX2dlbmVzLCBhZXMoeSA9IGNhbmNlcl90eXBlLCB4ID0gZ2VuZV9zeW1ib2wsIHNpemUgPSBmZHJfY2F0ZWdvcnksIGZpbGwgPSBsb2cyRm9sZENoYW5nZSkpICsNCiAgICBnZW9tX3BvaW50KGFscGhhID0gMC41LCBzaGFwZSA9IDIxLCBjb2xvciA9ICJibGFjayIpICsNCiAgICBzY2FsZV9zaXplX21hbnVhbCh2YWx1ZXMgPSBzaXplcykgKw0KICAgIHNjYWxlX2ZpbGxfZ3JhZGllbnQyKGxvdyA9ICJibHVlIiwgbWlkID0gIndoaXRlIiwgaGlnaCA9ICJyZWQiLCBsaW1pdHMgPSBjKG1pbihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCRsb2cyRm9sZENoYW5nZSksIG1heChkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCRsb2cyRm9sZENoYW5nZSkpKSArDQogICAgdGhlbWVfbWluaW1hbCgpICsNCiAgICB0aGVtZSgNCiAgICAgIGF4aXMudGV4dC54ID0gZWxlbWVudF90ZXh0KHNpemUgPSA5LCBhbmdsZSA9IDkwLCBoanVzdCA9IDEpDQogICAgKSArDQogICAgdGhlbWUobGVnZW5kLnBvc2l0aW9uID0gImJvdHRvbSIpICsNCiAgICB0aGVtZShsZWdlbmQucG9zaXRpb24gPSAiYm90dG9tIikgKw0KICAgIGxhYnMoc2l6ZSA9ICJBZGp1c3RlZCBwLXZhbHVlIiwgZmlsbCA9ICJsb2cyIEZDIiwgeSA9ICJDYW5jZXIgdHlwZSIsIHggPSAiR2VuZSIpDQp9DQpgYGANCg0KYGBge3J9DQpwZXJmb3JtX3ZzZCA8LSBmdW5jdGlvbihnZW5lcykgew0KICB0Y2dhX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICByb3duYW1lcyhnZW5lcykgPC0gZ2VuZXMkZ2VuZV9pZA0KICAgIHRjZ2FfcmNkW1twcm9qZWN0XV0gPC0gdGNnYV9tYXRyaXhbW3Byb2plY3RdXVtyb3duYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSAlaW4lIGdlbmVzJGdlbmVfaWQsIF0NCiAgICB0Y2dhX3JjZFtbcHJvamVjdF1dIDwtIHRjZ2FfcmNkW1twcm9qZWN0XV1bLCByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pXQ0KICB9DQoNCiAgdnNkX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICBwcmludChwcm9qZWN0KQ0KICAgIHByaW50KCI9PT09PT09PT09PT09IikNCiAgICBkZHMgPC0gREVTZXFEYXRhU2V0RnJvbU1hdHJpeCgNCiAgICAgIGNvdW50RGF0YSA9IHRjZ2FfcmNkW1twcm9qZWN0XV0sDQogICAgICBjb2xEYXRhID0gc2FtcGxlc1tbcHJvamVjdF1dLA0KICAgICAgZGVzaWduID0gfnR5cGUNCiAgICApDQogICAgZGRzIDwtIGZpbHRlcl9nZW5lcyhkZHMsIG1pbl9jb3VudCA9IDEwKQ0KDQogICAgIyBQZXJmb3JtIHZhcmlhbmNlIHN0YWJpbGl6YXRpb24NCiAgICBkZHMgPC0gZXN0aW1hdGVTaXplRmFjdG9ycyhkZHMpDQogICAgbnN1YiA8LSBzdW0ocm93TWVhbnMoY291bnRzKGRkcywgbm9ybWFsaXplZCA9IFRSVUUpKSA+IDEwKQ0KICAgIHZzZCA8LSB2c3QoZGRzLCBuc3ViID0gbnN1YikNCiAgICB2c2RfcmNkW1twcm9qZWN0XV0gPC0gYXNzYXkodnNkKQ0KICB9DQoNCiAgcmV0dXJuKHZzZF9yY2QpDQp9DQpgYGANCg0KDQojIyMjIEZlcnJvcHRvc2lzDQoNCkZldGNoIHRoZSBnZW5lIHNldCBvZiBpbnRlcmVzdC4NCg0KYGBge3J9DQpnZW5lcyA8LSByZWFkLmNzdihwYXN0ZTAoUkNEZGIsICJGZXJyb3B0b3Npcy5jc3YiKSkNCnByaW50KGdlbmVzKQ0KZ2VuZXMkZ2VuZV9pZCA8LSBjbGVhbmlkKGdlbmVzJGdlbmVfaWQpDQpnZW5lcyA8LSBkaXN0aW5jdChnZW5lcywgZ2VuZV9pZCwgLmtlZXBfYWxsID0gVFJVRSkNCmdlbmVzIDwtIHN1YnNldChnZW5lcywgZ2VuZV9pZCAhPSAiIikNCmdlbmVzDQpgYGANCg0KRmlsdGVyIHRoZSBnZW5lcyB0byBpbmNsdWRlIG9ubHkgdGhvc2UgaW4gdGhlIGdlbmUgc2V0IG9mIGludGVyZXN0LCBhbmQgdGhlbiBwZXJmb3JtIGRpZmZlcmVudGlhbCBnZW5lIGV4cHJlc3Npb24gYW5hbHlzaXMuDQoNCmBgYHtyfQ0KZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gZmlsdGVyX2dlbmVfc2V0X2FuZF9wZXJmb3JtX2RnZWEoZ2VuZXMpDQpkZXNlcS5iYmwuZGF0YS5jb21iaW5lZA0KYGBgDQoNClBsb3QgdGhlIHJlc3VsdHMuDQoNCmBgYHtyfQ0KcGxvdF9kZ2VhKGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkKQ0KYGBgDQpQZXJmb3JtIHZhcmlhbmNlLXN0YWJpbGl6aW5nIHRyYW5zZm9ybWF0aW9uIGZvciBmdXJ0aGVyIGRvd25zdHJlYW0gYW5hbHlzaXMgKGkuZS4sIGZvciBzdXJ2aXZhbCBhbmFseXNpcykuDQoNCmBgYHtyLCB3YXJuaW5nPUZBTFNFfQ0KdnNkIDwtIHBlcmZvcm1fdnNkKGdlbmVzKQ0KYGBgDQoNCiMjIFYuIERvd25sb2FkaW5nIHRoZSBjbGluaWNhbCBkYXRhDQoNCkRvd25sb2FkIGNsaW5pY2FsIGRhdGEgZnJvbSBUQ0dBLCBhbmQgcGVyZm9ybSBzb21lIHByZXByb2Nlc3Npbmc6DQotIFRoZSBgZGVjZWFzZWRgIGNvbHVtbiBzaG91bGQgYmUgYEZBTFNFYCBpZiB0aGUgcGF0aWVudCBpcyBhbGl2ZSBhbmQgYFRSVUVgIG90aGVyd2lzZQ0KLSBUaGUgYG92ZXJhbGxfc3Vydml2YWxgIGNvbHVtbiBzaG91bGQgcmVmbGVjdCB0aGUgZm9sbG93LXVwIHRpbWUgaWYgdGhlIHBhdGllbnQgaXMgYWxpdmUgYW5kIHRoZSBkYXlzIHRvIGRlYXRoIG90aGVyd2lzZQ0KDQpgYGB7cn0NCmRvd25sb2FkX2NsaW5pY2FsX2RhdGEgPC0gZnVuY3Rpb24ocHJvamVjdCkgew0KICBjbGluaWNhbF9kYXRhIDwtIEdEQ3F1ZXJ5X2NsaW5pYyhwcm9qZWN0KQ0KICBjbGluaWNhbF9kYXRhJGRlY2Vhc2VkIDwtIGlmZWxzZShjbGluaWNhbF9kYXRhJHZpdGFsX3N0YXR1cyA9PSAiQWxpdmUiLCBGQUxTRSwgVFJVRSkNCiAgY2xpbmljYWxfZGF0YSRvdmVyYWxsX3N1cnZpdmFsIDwtIGlmZWxzZShjbGluaWNhbF9kYXRhJHZpdGFsX3N0YXR1cyA9PSAiQWxpdmUiLA0KICAgIGNsaW5pY2FsX2RhdGEkZGF5c190b19sYXN0X2ZvbGxvd191cCwNCiAgICBjbGluaWNhbF9kYXRhJGRheXNfdG9fZGVhdGgNCiAgKQ0KDQogIHJldHVybihjbGluaWNhbF9kYXRhKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KdGNnYV9jbGluaWNhbCA8LSBsaXN0KCkNCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICB0Y2dhX2NsaW5pY2FsW1twcm9qZWN0XV0gPC0gZG93bmxvYWRfY2xpbmljYWxfZGF0YShwcm9qZWN0KQ0KfQ0KYGBgDQoNCiMjIFZJLiBQZXJmb3JtaW5nIHN1cnZpdmFsIGFuYWx5c2lzDQoNCldyaXRlIHV0aWxpdHkgZnVuY3Rpb25zIGZvciBwZXJmb3JtaW5nIHN1cnZpdmFsIGFuYWx5c2lzLg0KDQoNCmBgYHtyfQ0KY29uc3RydWN0X2dlbmVfZGYgPC0gZnVuY3Rpb24oZ2VuZV9vZl9pbnRlcmVzdCwgcHJvamVjdCkgew0KICBub3JtYWxfZGYgPC0gdGNnYV9tYXRyaXhbW3Byb2plY3RdXSAlPiUNCiAgICBhcy5kYXRhLmZyYW1lKCkgJT4lDQogICAgcm93bmFtZXNfdG9fY29sdW1uKHZhciA9ICJnZW5lX2lkIikgJT4lDQogICAgZ2F0aGVyKGtleSA9ICJjYXNlX2lkIiwgdmFsdWUgPSAiY291bnRzIiwgLWdlbmVfaWQpICU+JQ0KICAgIGxlZnRfam9pbiguLCBnZW5lcywgYnkgPSAiZ2VuZV9pZCIpICU+JQ0KICAgIGRwbHlyOjpmaWx0ZXIoZ2VuZSA9PSBnZW5lX29mX2ludGVyZXN0KSAlPiUNCiAgICBkcGx5cjo6ZmlsdGVyKGNhc2VfaWQgJWluJSByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0gJT4lIGRwbHlyOjpmaWx0ZXIodHlwZSA9PSAibm9ybWFsIikpKQ0KICBub3JtYWxfZGYkY2FzZV9pZCA8LSBwYXN0ZTAoc2FwcGx5KHN0cnNwbGl0KGFzLmNoYXJhY3Rlcihub3JtYWxfZGYkY2FzZV9pZCksICItIiksIGBbYCwgMSksICctJywNCiAgICAgICAgICAgICAgICAgICAgICAgICAgICBzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKG5vcm1hbF9kZiRjYXNlX2lkKSwgIi0iKSwgYFtgLCAyKSwgJy0nLCANCiAgICAgICAgICAgICAgICAgICAgICAgICAgICBzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKG5vcm1hbF9kZiRjYXNlX2lkKSwgIi0iKSwgYFtgLCAzKSkNCiAgDQogIHR1bW9yX2RmIDwtIHRjZ2FfbWF0cml4W1twcm9qZWN0XV0gJT4lDQogICAgICBhcy5kYXRhLmZyYW1lKCkgJT4lDQogICAgICByb3duYW1lc190b19jb2x1bW4odmFyID0gImdlbmVfaWQiKSAlPiUNCiAgICAgIGdhdGhlcihrZXkgPSAiY2FzZV9pZCIsIHZhbHVlID0gImNvdW50cyIsIC1nZW5lX2lkKSAlPiUNCiAgICAgIGxlZnRfam9pbiguLCBnZW5lcywgYnkgPSAiZ2VuZV9pZCIpICU+JQ0KICAgICAgZHBseXI6OmZpbHRlcihnZW5lID09IGdlbmVfb2ZfaW50ZXJlc3QpICU+JQ0KICAgICAgZHBseXI6OmZpbHRlcihjYXNlX2lkICVpbiUgcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dICU+JSBkcGx5cjo6ZmlsdGVyKHR5cGUgPT0gInR1bW9yIikpKQ0KICB0dW1vcl9kZiRjYXNlX2lkIDwtIHBhc3RlMChzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKHR1bW9yX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDEpLCAnLScsDQogICAgICAgICAgICAgICAgICAgICAgICAgICAgc2FwcGx5KHN0cnNwbGl0KGFzLmNoYXJhY3Rlcih0dW1vcl9kZiRjYXNlX2lkKSwgIi0iKSwgYFtgLCAyKSwgJy0nLCANCiAgICAgICAgICAgICAgICAgICAgICAgICAgICBzYXBwbHkoc3Ryc3BsaXQoYXMuY2hhcmFjdGVyKHR1bW9yX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDMpKQ0KICANCiAgZ2VuZV9kZiA8LSBpbm5lcl9qb2luKG5vcm1hbF9kZiwgdHVtb3JfZGYsIGJ5ID0gYygiZ2VuZV9pZCIsICJjYXNlX2lkIiwgImRlYXRodHlwZSIsICJnZW5lIiwgImRlc2NyaXB0aW9uIiwgImdlbmVfYmlvdHlwZSIsICJwbWlkIiwgImNvbW1lbnQiKSkNCiAgZ2VuZV9kZiRsb2dfZm9sZCA9IGxvZzIoZ2VuZV9kZiRjb3VudHMueSAvIGdlbmVfZGYkY291bnRzLngpDQogIA0KICBnZW5lX2RmJHN0cmF0YSA8LSBpZmVsc2UoYWJzKGdlbmVfZGYkbG9nX2ZvbGQpID49IDEuNSwgIkhJR0giLCAiTE9XIikNCiAgZ2VuZV9kZiA8LSBtZXJnZShnZW5lX2RmLCB0Y2dhX2NsaW5pY2FsW1twcm9qZWN0XV0sIGJ5LnggPSAiY2FzZV9pZCIsIGJ5LnkgPSAic3VibWl0dGVyX2lkIikNCiAgDQogIHJldHVybihnZW5lX2RmKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KY29tcHV0ZV9zdXJpdmFsX2ZpdCA8LSBmdW5jdGlvbihnZW5lX2RmKSB7DQogIHJldHVybiAoc3VydmZpdChTdXJ2KG92ZXJhbGxfc3Vydml2YWwsIGRlY2Vhc2VkKSB+IHN0cmF0YSwgZGF0YSA9IGdlbmVfZGYpKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KY29tcHV0ZV9jb3ggPC0gZnVuY3Rpb24oZ2VuZV9kZikgew0KICByZXR1cm4gKGNveHBoKFN1cnYob3ZlcmFsbF9zdXJ2aXZhbCwgZGVjZWFzZWQpIH4gc3RyYXRhLCBkYXRhPWdlbmVfZGYpKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KcGxvdF9zdXJ2aXZhbCA8LSBmdW5jdGlvbihmaXQpIHsNCiAgcmV0dXJuKGdnc3VydnBsb3QoZml0LA0KICAgIGRhdGEgPSBnZW5lX2RmLA0KICAgIHB2YWwgPSBULA0KICAgIHJpc2sudGFibGUgPSBULA0KICAgIHJpc2sudGFibGUuaGVpZ2h0ID0gMC4zDQogICkpDQp9DQpgYGANCg0KYGBge3J9DQpjb21wdXRlX3N1cnZpdmFsX2RpZmYgPC0gZnVuY3Rpb24oZ2VuZV9kZikgew0KICByZXR1cm4oc3VydmRpZmYoU3VydihvdmVyYWxsX3N1cnZpdmFsLCBkZWNlYXNlZCkgfiBzdHJhdGEsIGRhdGEgPSBnZW5lX2RmKSkNCn0NCmBgYA0KDQpQZXJmb3JtIHN1cnZpdmFsIGFuYWx5c2lzIGJ5IHRlc3RpbmcgZm9yIHRoZSBkaWZmZXJlbmNlIGluIHRoZSBLYXBsYW4tTWVpZXIgY3VydmVzIHVzaW5nIHRoZSBHLXJobyBmYW1pbHkgb2YgSGFycmluZ3RvbiBhbmQgRmxlbWluZyB0ZXN0czogaHR0cHM6Ly9yZHJyLmlvL2NyYW4vc3Vydml2YWwvbWFuL3N1cnZkaWZmLmh0bWwNCg0KT3VyIGdlbmVzIG9mIGludGVyZXN0IGFyZSB0aGUgZGlmZmVyZW50aWFsbHkgZXhwcmVzc2VkIGdlbmVzLg0KDQpgYGB7cn0NCnNpZ25pZmljYW50X3Byb2plY3RzIDwtIGMoKQ0Kc2lnbmlmaWNhbnRfZ2VuZXMgPC0gYygpDQoNCmN0ciA8LSAxDQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgZm9yIChnZW5lIGluIGMoZ2VuZXMkZ2VuZSkpIHsNCiAgICBjYXQocHJvamVjdCwgZ2VuZSwgIlxuXG4iKQ0KICAgIGVycm9yIDwtIHRyeUNhdGNoICgNCiAgICAgIHsNCiAgICAgICAgZ2VuZV9kZiA8LSBjb25zdHJ1Y3RfZ2VuZV9kZihnZW5lLCBwcm9qZWN0KQ0KICAgICAgfSwNCiAgICAgIGVycm9yID0gZnVuY3Rpb24oZSkgew0KICAgICAgICBjYXQoIlxuXG49PT09PT09PT09PT09PT09PT09PT09PT09PT09XG5cbiIpDQogICAgICAgIGUNCiAgICAgIH0NCiAgICApDQogICAgDQogICAgaWYoaW5oZXJpdHMoZXJyb3IsICJlcnJvciIpKSBuZXh0DQoNCiAgICBpZiAobnJvdyhnZW5lX2RmKSA+IDApIHsNCiAgICAgIGZpdCA8LSBjb21wdXRlX3N1cml2YWxfZml0KGdlbmVfZGYpDQogICAgICB0cnlDYXRjaCAoDQogICAgICAgIHsNCiAgICAgICAgICBzdXJ2aXZhbCA8LSBjb21wdXRlX3N1cnZpdmFsX2RpZmYoZ2VuZV9kZikNCiAgICAgICAgICBjb3ggPC0gY29tcHV0ZV9jb3goZ2VuZV9kZikNCiAgICAgICAgICBwcmludChjdHIpDQogICAgICAgICAgY3RyIDwtIGN0ciArIDENCiAgICAgICAgICBwcmludChzdXJ2aXZhbCkNCiAgICAgICAgICBjYXQoIlxuIikNCiAgICAgICAgICBwcmludChjb3gpDQogICAgICAgICAgcHJpbnQocGxvdF9zdXJ2aXZhbChmaXQpKQ0KICAgICAgICAgIGlmIChwY2hpc3Eoc3Vydml2YWwkY2hpc3EsIGxlbmd0aChzdXJ2aXZhbCRuKS0xLCBsb3dlci50YWlsID0gRkFMU0UpIDwgMC4wNSkgew0KICAgICAgICAgICAgc2lnbmlmaWNhbnRfcHJvamVjdHMgPC0gYyhzaWduaWZpY2FudF9wcm9qZWN0cywgcHJvamVjdCkNCiAgICAgICAgICAgIHNpZ25pZmljYW50X2dlbmVzIDwtIGMoc2lnbmlmaWNhbnRfZ2VuZXMsIGdlbmUpDQogICAgICAgICAgfQ0KICAgICAgICB9LA0KICAgICAgICBlcnJvciA9IGZ1bmN0aW9uKGUpIHsNCiAgICAgICAgfQ0KICAgICAgKQ0KICAgICAgDQogICAgfQ0KICAgIA0KICAgIGNhdCgiXG5cbj09PT09PT09PT09PT09PT09PT09PT09PT09PT1cblxuIikNCiAgfQ0KfQ0KYGBgDQoNCkRpc3BsYXkgdGhlIHJlc3VsdHMgb25seSBmb3IgZ2VuZXMgd2hlcmUgYSBzaWduaWZpY2FudCBkaWZmZXJlbmNlIGluIHN1cnZpdmFsIGhhcyBiZWVuIHJlcG9ydGVkLg0KDQpgYGB7cn0NCnNpZ25pZmljYW50X2dlbmVzDQpgYGANCg0KYGBge3J9DQpudW1fc2lnbmlmaWNhbnRfZ2VuZXMgPC0gbGVuZ3RoKHNpZ25pZmljYW50X2dlbmVzKQ0KDQppZiAobnVtX3NpZ25pZmljYW50X2dlbmVzID4gMCkgew0KICBmb3IgKGkgaW4gMSA6IG51bV9zaWduaWZpY2FudF9nZW5lcykgew0KICAgIHByb2plY3QgPC0gc2lnbmlmaWNhbnRfcHJvamVjdHNbW2ldXQ0KICAgIGdlbmUgPC0gc2lnbmlmaWNhbnRfZ2VuZXNbW2ldXQ0KICAgIA0KICAgIGNhdChwcm9qZWN0LCBnZW5lLCAiXG5cbiIpDQogICAgZ2VuZV9kZiA8LSBjb25zdHJ1Y3RfZ2VuZV9kZihnZW5lLCBwcm9qZWN0KQ0KICAgIA0KICAgIHN1cnZpdmFsIDwtIGNvbXB1dGVfc3Vydml2YWxfZGlmZihnZW5lX2RmKQ0KICAgIGNveCA8LSBjb21wdXRlX2NveChnZW5lX2RmKQ0KICAgIHByaW50KHN1cnZpdmFsKQ0KICAgIGNhdCgiXG4iKQ0KICAgIHByaW50KGNveCkNCiAgICBwcmludChwbG90X3N1cnZpdmFsKGZpdCkpDQogICAgDQogICAgY2F0KCJcblxuPT09PT09PT09PT09PT09PT09PT09PT09PT09PVxuXG4iKQ0KICB9IA0KfQ0KYGBg