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) {
  gene_df <- vsd[[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")))

  q1 <- quantile(gene_df$counts, probs = 0.25)
  q3 <- quantile(gene_df$counts, probs = 0.75)
  gene_df$strata <- ifelse(gene_df$counts >= q3, "HIGH", ifelse(gene_df$counts <= q1, "LOW", "MIDDLE"))
  gene_df <- gene_df %>% dplyr::filter(strata %in% c("LOW", "HIGH"))
  gene_df$case_id <- paste0(sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 1), '-',
                          sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 2), '-', 
                          sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 3))
  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 11        3     4.32     0.404      1.07
strata=LOW  11        4     2.68     0.653      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.7770    2.1750   0.7691 1.01 0.312

Likelihood ratio test=1.03  on 1 df, p=0.3094
n= 22, number of events= 7 


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

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 11        4      4.3    0.0213     0.056
strata=LOW  11        4      3.7    0.0248     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.1865    1.2050   0.7892 0.236 0.813

Likelihood ratio test=0.06  on 1 df, p=0.8124
n= 22, number of events= 8 


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

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 11        5     3.56     0.587      1.72
strata=LOW  11        1     2.44     0.853      1.72

 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.3714    0.2538   1.1262 -1.218 0.223

Likelihood ratio test=1.84  on 1 df, p=0.1749
n= 22, number of events= 6 


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

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 11        4     3.92   0.00183   0.00363
strata=LOW  11        4     4.08   0.00175   0.00363

 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.04291   0.95799  0.71240 -0.06 0.952

Likelihood ratio test=0  on 1 df, p=0.952
n= 22, number of events= 8 


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

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 11        3     2.07     0.420     0.786
strata=LOW  11        2     2.93     0.296     0.786

 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.8337    0.4345   0.9603 -0.868 0.385

Likelihood ratio test=0.77  on 1 df, p=0.3788
n= 22, number of events= 5 


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

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 11        3     2.75    0.0228     0.051
strata=LOW  11        2     2.25    0.0279     0.051

 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.2065    0.8135   0.9157 -0.225 0.822

Likelihood ratio test=0.05  on 1 df, p=0.8206
n= 22, number of events= 5 


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

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 11        4     5.21     0.282     0.762
strata=LOW  11        5     3.79     0.388     0.762

 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.6400    1.8965   0.7447 0.859 0.39

Likelihood ratio test=0.77  on 1 df, p=0.3812
n= 22, number of events= 9 


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

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 11        6     4.81     0.295     0.957
strata=LOW  11        2     3.19     0.445     0.957

 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.8260    0.4378   0.8684 -0.951 0.341

Likelihood ratio test=0.97  on 1 df, p=0.3257
n= 22, number of events= 8 


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

TCGA-COAD MIR615 



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

TCGA-COAD MIR93 



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

TCGA-COAD ENO3 

[1] 9
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     4.41     0.453      1.38
strata=LOW  11        4     2.59     0.772      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.9863    2.6814   0.8726 1.13 0.258

Likelihood ratio test=1.37  on 1 df, p=0.2415
n= 22, number of events= 7 


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

TCGA-COAD MMD 

[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 11        3     2.02     0.472     0.808
strata=LOW  11        2     2.98     0.321     0.808

 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.8089    0.4453   0.9229 -0.877 0.381

Likelihood ratio test=0.79  on 1 df, p=0.3743
n= 22, number of events= 5 


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

TCGA-COAD NQO1 

[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 11        3     4.35     0.420     0.929
strata=LOW  11        5     3.65     0.501     0.929

 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.6935    2.0007   0.7335 0.945 0.344

Likelihood ratio test=0.93  on 1 df, p=0.3352
n= 22, number of events= 8 


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

TCGA-COAD MARCHF5 

[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 11        4     4.08   0.00152   0.00313
strata=LOW  11        5     4.92   0.00126   0.00313

 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.03985   1.04065  0.71181 0.056 0.955

Likelihood ratio test=0  on 1 df, p=0.9554
n= 22, number of events= 9 


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

TCGA-COAD JUN 

[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 11        3     3.88     0.201     0.586
strata=LOW  11        3     2.12     0.369     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.6247    1.8677   0.8282 0.754 0.451

Likelihood ratio test=0.56  on 1 df, p=0.4541
n= 22, number of events= 6 


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

TCGA-COAD ALDH3A2 

[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 11        1     1.76     0.329      0.81
strata=LOW  11        2     1.24     0.468      0.81

 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.061     2.890    1.233 0.861 0.389

Likelihood ratio test=0.8  on 1 df, p=0.3721
n= 22, number of events= 3 


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

TCGA-COAD ALOX5 

[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 11        4     2.37     1.121      1.81
strata=LOW  11        4     5.63     0.472      1.81

 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.0324    0.3561   0.7945 -1.299 0.194

Likelihood ratio test=1.7  on 1 df, p=0.1918
n= 22, number of events= 8 


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

TCGA-COAD PARP9 

[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 11        4     4.23    0.0128    0.0371
strata=LOW  11        3     2.77    0.0196    0.0371

 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.1585    1.1717   0.8240 0.192 0.847

Likelihood ratio test=0.04  on 1 df, p=0.8476
n= 22, number of events= 7 


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

TCGA-COAD GLRX5 

[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 11        5     5.03  0.000173  0.000475
strata=LOW  11        4     3.97  0.000219  0.000475

 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.01605   1.01618  0.73691 0.022 0.983

Likelihood ratio test=0  on 1 df, p=0.9826
n= 22, number of events= 9 


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

TCGA-COAD METTL14 

[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 11        5     3.29     0.894      1.57
strata=LOW  11        3     4.71     0.623      1.57

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.9048    0.4046   0.7455 -1.214 0.225

Likelihood ratio test=1.54  on 1 df, p=0.2146
n= 22, number of events= 8 


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

TCGA-COAD TOR2A 

[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 11        3      3.2    0.0120    0.0258
strata=LOW  11        4      3.8    0.0101    0.0258

 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.1315    1.1405   0.8189 0.161 0.872

Likelihood ratio test=0.03  on 1 df, p=0.8725
n= 22, number of events= 7 


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

TCGA-COAD PARP14 

[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        4      3.3     0.146     0.339
strata=LOW  11        2      2.7     0.180     0.339

 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.5071    0.6022   0.8797 -0.576 0.564

Likelihood ratio test=0.35  on 1 df, p=0.5559
n= 22, number of events= 6 


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

TCGA-COAD MIR130B 



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

TCGA-COAD CERS6-AS1 



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

TCGA-COAD NFS1 

[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 11        3     3.81     0.172     0.379
strata=LOW  11        5     4.19     0.156     0.379

 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.4668    1.5949   0.7656 0.61 0.542

Likelihood ratio test=0.38  on 1 df, p=0.5393
n= 22, number of events= 8 


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

TCGA-COAD SLC3A2 

[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 11        4     5.59     0.451      1.05
strata=LOW  11        6     4.41     0.570      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.6603    1.9353   0.6540 1.01 0.313

Likelihood ratio test=1.04  on 1 df, p=0.3069
n= 22, number of events= 10 


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

TCGA-COAD ZFAS1 

[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 11        2     2.96     0.312     0.623
strata=LOW  11        5     4.04     0.229     0.623

 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.6746    1.9633   0.8706 0.775 0.438

Likelihood ratio test=0.64  on 1 df, p=0.4252
n= 22, number of events= 7 


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

TCGA-COAD PANX1 

[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 11        6     3.32      2.16      5.79
strata=LOW  11        0     2.68      2.68      5.79

 Chisq= 5.8  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 -2.137e+01  5.262e-10  1.808e+04 -0.001 0.999

Likelihood ratio test=7.69  on 1 df, p=0.005547
n= 22, number of events= 6 


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

TCGA-COAD HSPB1 

[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 11        5     4.21     0.150     0.579
strata=LOW  11        1     1.79     0.351     0.579

 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.8424    0.4307   1.1375 -0.741 0.459

Likelihood ratio test=0.63  on 1 df, p=0.4271
n= 22, number of events= 6 


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

TCGA-COAD CREB1 

[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 11        4     4.06  0.000880   0.00209
strata=LOW  11        4     3.94  0.000907   0.00209

 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.03507   1.03569  0.76685 0.046 0.964

Likelihood ratio test=0  on 1 df, p=0.9635
n= 22, number of events= 8 


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

TCGA-COAD EZH2 

[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 11        2     3.06     0.366      1.16
strata=LOW  11        3     1.94     0.577      1.16

 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.197     3.310    1.172 1.021 0.307

Likelihood ratio test=1.21  on 1 df, p=0.2717
n= 22, number of events= 5 


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

TCGA-COAD SLC40A1 

[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 11        4     4.25    0.0146    0.0282
strata=LOW  11        6     5.75    0.0108    0.0282

 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.1134    1.1201   0.6760 0.168 0.867

Likelihood ratio test=0.03  on 1 df, p=0.8665
n= 22, number of events= 10 


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

TCGA-COAD PAQR3 

[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 11        2     1.84    0.0144    0.0268
strata=LOW  11        2     2.16    0.0122    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.1641    0.8487   1.0037 -0.163 0.87

Likelihood ratio test=0.03  on 1 df, p=0.8702
n= 22, number of events= 4 


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

TCGA-COAD MIR545 



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

TCGA-COAD MIR6077 



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

TCGA-COAD MIR424 



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

TCGA-COAD NOX5 

[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 11        2      1.4     0.262     0.492
strata=LOW  11        2      2.6     0.140     0.492

 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.8358    0.4335   1.2266 -0.681 0.496

Likelihood ratio test=0.5  on 1 df, p=0.4812
n= 22, number of events= 4 


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

TCGA-COAD DHODH 

[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        4      3.6    0.0454     0.219
strata=LOW  11        1      1.4    0.1163     0.219

 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.5666    0.5674   1.2262 -0.462 0.644

Likelihood ratio test=0.22  on 1 df, p=0.6355
n= 22, number of events= 5 


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

TCGA-COAD PTPN18 

[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 11        3     3.74     0.147     0.445
strata=LOW  11        3     2.26     0.244     0.445

 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.6005    1.8230   0.9134 0.657 0.511

Likelihood ratio test=0.44  on 1 df, p=0.5055
n= 22, number of events= 6 


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

TCGA-COAD IARS1 

[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 11        4     3.02     0.321     0.816
strata=LOW  11        2     2.98     0.324     0.816

 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.8096    0.4450   0.9196 -0.88 0.379

Likelihood ratio test=0.8  on 1 df, p=0.3723
n= 22, number of events= 6 


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

TCGA-COAD IL4R 

[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 11        4      3.6    0.0456    0.0992
strata=LOW  11        4      4.4    0.0372    0.0992

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.2474    0.7808   0.7872 -0.314 0.753

Likelihood ratio test=0.1  on 1 df, p=0.7521
n= 22, number of events= 8 


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

TCGA-COAD SENP1 

[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 11        3     3.08   0.00230   0.00428
strata=LOW  11        4     3.92   0.00181   0.00428

 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.0510    1.0523   0.7793 0.065 0.948

Likelihood ratio test=0  on 1 df, p=0.9478
n= 22, number of events= 7 


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

TCGA-COAD IFNA16 



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

TCGA-COAD SOX2 

[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 11        4     3.19     0.206     0.383
strata=LOW  11        3     3.81     0.172     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.4714    0.6242   0.7689 -0.613 0.54

Likelihood ratio test=0.38  on 1 df, p=0.5371
n= 22, number of events= 7 


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

TCGA-COAD LIFR 

[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 11        3     2.17     0.319     0.571
strata=LOW  11        2     2.83     0.244     0.571

 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.6816    0.5058   0.9189 -0.742 0.458

Likelihood ratio test=0.56  on 1 df, p=0.4523
n= 22, number of events= 5 


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

TCGA-COAD MIR199A2 



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

TCGA-COAD COX4I2 

[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 11        4     3.77    0.0134    0.0417
strata=LOW  11        2     2.23    0.0228    0.0417

 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.1877    0.8288   0.9201 -0.204 0.838

Likelihood ratio test=0.04  on 1 df, p=0.8375
n= 22, number of events= 6 


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

TCGA-COAD ATF2 

[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 11        3     3.03  0.000395  0.000705
strata=LOW  11        4     3.97  0.000302  0.000705

 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.02038   1.02059  0.76778 0.027 0.979

Likelihood ratio test=0  on 1 df, p=0.9788
n= 22, number of events= 7 


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

TCGA-COAD ABCC5 

[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 11        4     2.38     1.104      1.92
strata=LOW  11        2     3.62     0.725      1.92

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

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

             coef exp(coef) se(coef)     z     p
strataLOW -1.1701    0.3103   0.8863 -1.32 0.187

Likelihood ratio test=1.87  on 1 df, p=0.171
n= 22, number of events= 6 


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

TCGA-COAD CCDC6 

[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 11        5     2.93      1.46      4.31
strata=LOW  11        0     2.07      2.07      4.31

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

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

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.129e+01  5.675e-10  2.016e+04 -0.001 0.999

Likelihood ratio test=5.85  on 1 df, p=0.01555
n= 22, number of events= 5 


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

TCGA-COAD OTUB1 

[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 11        3     4.09     0.292      0.73
strata=LOW  11        5     3.91     0.306      0.73

 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.6567    1.9285   0.7813 0.841 0.401

Likelihood ratio test=0.72  on 1 df, p=0.3968
n= 22, number of events= 8 


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

TCGA-COAD ALOXE3 

[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 11        6     4.12     0.856      1.47
strata=LOW  15        5     6.88     0.513      1.47

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.7686    0.4636   0.6487 -1.185 0.236

Likelihood ratio test=1.44  on 1 df, p=0.2298
n= 26, number of events= 11 


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

TCGA-COAD SCP2 

[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 11        3      3.7     0.131     0.285
strata=LOW  11        5      4.3     0.113     0.285

 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.4097    1.5064   0.7729 0.53 0.596

Likelihood ratio test=0.28  on 1 df, p=0.5938
n= 22, number of events= 8 


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

TCGA-COAD PHKG2 

[1] 45
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.04     0.355     0.927
strata=LOW  11        4     2.96     0.365     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.8657    2.3767   0.9254 0.936 0.35

Likelihood ratio test=0.9  on 1 df, p=0.3427
n= 22, number of events= 6 


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

TCGA-COAD MTDH 

[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 11        6     3.42      1.95      3.46
strata=LOW  11        4     6.58      1.01      3.46

 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.4108    0.2439   0.8208 -1.719 0.0857

Likelihood ratio test=3.49  on 1 df, p=0.06183
n= 22, number of events= 10 


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

TCGA-COAD ACO1 

[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 11        7     5.42     0.459      1.11
strata=LOW  11        3     4.58     0.544      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.7294    0.4822   0.7078 -1.03 0.303

Likelihood ratio test=1.13  on 1 df, p=0.2881
n= 22, number of events= 10 


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

TCGA-COAD MIR137 



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

TCGA-COAD OIP5-AS1 

[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 11        4     5.56     0.435      1.26
strata=LOW  11        5     3.44     0.702      1.26

 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.8119    2.2522   0.7408 1.096 0.273

Likelihood ratio test=1.25  on 1 df, p=0.2631
n= 22, number of events= 9 


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

TCGA-COAD MIR494 



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

TCGA-COAD MLLT1 

[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        7     5.64     0.328     0.975
strata=LOW  11        2     3.36     0.550     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.7939    0.4521   0.8241 -0.963 0.335

Likelihood ratio test=1.03  on 1 df, p=0.3091
n= 22, number of events= 9 


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

TCGA-COAD MIR19B1 



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

TCGA-COAD RPTOR 

[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 11        6     4.43     0.558      1.41
strata=LOW  11        2     3.57     0.692      1.41

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.9583    0.3835   0.8370 -1.145 0.252

Likelihood ratio test=1.46  on 1 df, p=0.2276
n= 22, number of events= 8 


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

TCGA-COAD GCH1 

[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 11        2     1.41    0.2458     0.465
strata=LOW  11        4     4.59    0.0756     0.465

 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.8134    0.4433   1.2259 -0.664 0.507

Likelihood ratio test=0.47  on 1 df, p=0.493
n= 22, number of events= 6 


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

TCGA-COAD PARP16 

[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 11        2     3.45     0.609      1.23
strata=LOW  11        5     3.55     0.592      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.9036    2.4685   0.8428 1.072 0.284

Likelihood ratio test=1.27  on 1 df, p=0.2603
n= 22, number of events= 7 


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

TCGA-COAD MIR9-3 



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

TCGA-COAD CISD3 

[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 11        5     5.11   0.00224    0.0064
strata=LOW  11        4     3.89   0.00293    0.0064

 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.05949   1.06130  0.74349 0.08 0.936

Likelihood ratio test=0.01  on 1 df, p=0.9364
n= 22, number of events= 9 


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

TCGA-COAD USP35 

[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        6     6.06  0.000530   0.00163
strata=LOW  11        4     3.94  0.000814   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.02869   1.02911  0.71173 0.04 0.968

Likelihood ratio test=0  on 1 df, p=0.9678
n= 22, number of events= 10 


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

TCGA-COAD PRKAA1 

[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 11        3     3.17   0.00888    0.0152
strata=LOW  11        5     4.83   0.00582    0.0152

 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.09173   1.09606  0.74315 0.123 0.902

Likelihood ratio test=0.02  on 1 df, p=0.9014
n= 22, number of events= 8 


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

TCGA-COAD MAPK14 

[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 11        4     3.12     0.250     0.456
strata=LOW  11        6     6.88     0.113     0.456

 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.5133    0.5985   0.7685 -0.668 0.504

Likelihood ratio test=0.45  on 1 df, p=0.5013
n= 22, number of events= 10 


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

TCGA-COAD GRIA3 

[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 11        4      3.2     0.198     0.333
strata=LOW  11        5      5.8     0.109     0.333

 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.4079    0.6650   0.7113 -0.573 0.566

Likelihood ratio test=0.33  on 1 df, p=0.5676
n= 22, number of events= 9 


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

TCGA-COAD KDM5C 

[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 11        3     2.81    0.0135    0.0309
strata=LOW  11        3     3.19    0.0119    0.0309

 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.1607    0.8516   0.9149 -0.176 0.861

Likelihood ratio test=0.03  on 1 df, p=0.8599
n= 22, number of events= 6 


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

TCGA-COAD DECR1 

[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 11        3      3.1    0.0034   0.00718
strata=LOW  11        4      3.9    0.0027   0.00718

 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.06987   1.07237  0.82492 0.085 0.932

Likelihood ratio test=0.01  on 1 df, p=0.9325
n= 22, number of events= 7 


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

TCGA-COAD VCP 

[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 11        4     1.96      2.13      3.51
strata=LOW  11        1     3.04      1.37      3.51

 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.8347    0.1597   1.1199 -1.638 0.101

Likelihood ratio test=3.51  on 1 df, p=0.06118
n= 22, number of events= 5 


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

TCGA-COAD MIR129-1 



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

TCGA-COAD PARP10 

[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 11        4     3.22     0.188     0.411
strata=LOW  11        3     3.78     0.160     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.5517    0.5760   0.8710 -0.633 0.526

Likelihood ratio test=0.42  on 1 df, p=0.5163
n= 22, number of events= 7 


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

TCGA-COAD ULK2 

[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 11        4     2.66     0.679      1.88
strata=LOW  11        1     2.34     0.770      1.88

 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.4600    0.2322   1.1593 -1.259 0.208

Likelihood ratio test=1.88  on 1 df, p=0.1705
n= 22, number of events= 5 


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

TCGA-COAD CISD1 

[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 11        4     3.18     0.209      0.45
strata=LOW  11        2     2.82     0.236      0.45

 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.5766    0.5618   0.8710 -0.662 0.508

Likelihood ratio test=0.46  on 1 df, p=0.4971
n= 22, number of events= 6 


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

TCGA-COAD MIR147A 



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

TCGA-COAD BBOX1-AS1 

[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 11        1     2.15     0.614      1.35
strata=LOW  11        4     2.85     0.463      1.35

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

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

           coef exp(coef) se(coef)     z     p
strataLOW 1.264     3.538    1.160 1.089 0.276

Likelihood ratio test=1.39  on 1 df, p=0.2391
n= 22, number of events= 5 


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

TCGA-COAD RB1 

[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.92   0.00218   0.00375
strata=LOW  11        5     5.08   0.00125   0.00375

 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.04684   0.95424  0.76475 -0.061 0.951

Likelihood ratio test=0  on 1 df, p=0.9512
n= 22, number of events= 8 


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

TCGA-COAD TTPA 

[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 11        3     2.71    0.0315    0.0578
strata=LOW  11        3     3.29    0.0259    0.0578

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

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

             coef exp(coef) se(coef)     z    p
strataLOW -0.1966    0.8215   0.8194 -0.24 0.81

Likelihood ratio test=0.06  on 1 df, p=0.8105
n= 22, number of events= 6 


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

TCGA-COAD CDC25A 

[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        5     4.14     0.181     0.381
strata=LOW  11        3     3.86     0.194     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 -0.4504    0.6373   0.7358 -0.612 0.54

Likelihood ratio test=0.39  on 1 df, p=0.5346
n= 22, number of events= 8 


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

TCGA-COAD PCAT1 

[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 11        4     2.47     0.951      1.69
strata=LOW  11        2     3.53     0.665      1.69

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.1043    0.3314   0.8871 -1.245 0.213

Likelihood ratio test=1.67  on 1 df, p=0.1967
n= 22, number of events= 6 


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

TCGA-COAD DAZAP1 

[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 11        5     5.76     0.101     0.307
strata=LOW  11        4     3.24     0.180     0.307

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

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

            coef exp(coef) se(coef)    z     p
strataLOW 0.3919    1.4798   0.7121 0.55 0.582

Likelihood ratio test=0.3  on 1 df, p=0.5832
n= 22, number of events= 9 


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

TCGA-COAD PEX2 

[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 11        2     2.86     0.256      0.49
strata=LOW  11        5     4.14     0.177      0.49

 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.5982    1.8189   0.8670 0.69 0.49

Likelihood ratio test=0.5  on 1 df, p=0.4786
n= 22, number of events= 7 


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

TCGA-COAD MIR124-3 



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

TCGA-COAD TRIM21 

[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 11        3     2.47    0.1159     0.229
strata=LOW  11        3     3.53    0.0808     0.229

 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.4342    0.6478   0.9140 -0.475 0.635

Likelihood ratio test=0.23  on 1 df, p=0.6311
n= 22, number of events= 6 


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

TCGA-COAD MEG3 

[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        6     5.01     0.197     0.464
strata=LOW  11        4     4.99     0.198     0.464

 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.4628    0.6295   0.6846 -0.676 0.499

Likelihood ratio test=0.46  on 1 df, p=0.4976
n= 22, number of events= 10 


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

TCGA-COAD GCLC 

[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 11        1     2.48     0.887      1.58
strata=LOW  11        6     4.52     0.488      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 1.302     3.675    1.106 1.177 0.239

Likelihood ratio test=1.76  on 1 df, p=0.1841
n= 22, number of events= 7 


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

TCGA-COAD IDH2 

[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 11        6     5.53    0.0404      0.13
strata=LOW  11        3     3.47    0.0644      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.2760    0.7588   0.7691 -0.359 0.72

Likelihood ratio test=0.13  on 1 df, p=0.7184
n= 22, number of events= 9 


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

TCGA-COAD FNDC5 

[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        5     4.86   0.00422    0.0137
strata=LOW  11        3     3.14   0.00653    0.0137

 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.09583   0.90862  0.81767 -0.117 0.907

Likelihood ratio test=0.01  on 1 df, p=0.9067
n= 22, number of events= 8 


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

TCGA-COAD FANCD2 

[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 11        3     4.23     0.359      1.67
strata=LOW  11        3     1.77     0.859      1.67

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

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

           coef exp(coef) se(coef)     z     p
strataLOW 1.471     4.352    1.213 1.212 0.225

Likelihood ratio test=1.73  on 1 df, p=0.189
n= 22, number of events= 6 


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

TCGA-COAD LCN2 

[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 11        4     4.08   0.00147   0.00419
strata=LOW  11        3     2.92   0.00205   0.00419

 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.05414   1.05564  0.83669 0.065 0.948

Likelihood ratio test=0  on 1 df, p=0.9484
n= 22, number of events= 7 


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

TCGA-COAD TFR2 

[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 11        3     4.41     0.452       1.4
strata=LOW  11        4     2.59     0.771       1.4

 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 1.0053    2.7327   0.8822 1.14 0.254

Likelihood ratio test=1.4  on 1 df, p=0.2374
n= 22, number of events= 7 


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

TCGA-COAD PARP12 

[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 11        2     3.39     0.567      1.33
strata=LOW  11        5     3.61     0.532      1.33

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.9704    2.6389   0.8737 1.111 0.267

Likelihood ratio test=1.32  on 1 df, p=0.2501
n= 22, number of events= 7 


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

TCGA-COAD NR1D1 

[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 11        4     3.63    0.0378     0.111
strata=LOW  11        2     2.37    0.0579     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.3036    0.7381   0.9155 -0.332 0.74

Likelihood ratio test=0.11  on 1 df, p=0.7381
n= 22, number of events= 6 


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

TCGA-COAD ATG13 

[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 11        3     4.09     0.289     0.711
strata=LOW  11        5     3.91     0.302     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.6407    1.8978   0.7723 0.83 0.407

Likelihood ratio test=0.7  on 1 df, p=0.4036
n= 22, number of events= 8 


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

TCGA-COAD TMSB4X 

[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 11        2     3.04     0.357     0.726
strata=LOW  11        5     3.96     0.275     0.726

 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.7229    2.0603   0.8668 0.834 0.404

Likelihood ratio test=0.74  on 1 df, p=0.39
n= 22, number of events= 7 


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

TCGA-COAD CDK14 

[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 11        4     3.07     0.281     0.649
strata=LOW  11        3     3.93     0.220     0.649

 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.6542    0.5199   0.8256 -0.792 0.428

Likelihood ratio test=0.62  on 1 df, p=0.4319
n= 22, number of events= 7 


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

TCGA-COAD RP1-228H13.5 

[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 11        7     5.85     0.224      0.66
strata=LOW  11        3     4.15     0.317      0.66

 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.5859    0.5566   0.7314 -0.801 0.423

Likelihood ratio test=0.66  on 1 df, p=0.4149
n= 22, number of events= 10 


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

TCGA-COAD NOX3 



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

TCGA-COAD IFNA17 



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

TCGA-COAD ALOX12B 

[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 11        4     4.04  0.000374   0.00102
strata=LOW  11        3     2.96  0.000511   0.00102

 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.02621   1.02656  0.82100 0.032 0.975

Likelihood ratio test=0  on 1 df, p=0.9745
n= 22, number of events= 7 


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

TCGA-COAD PGRMC1 

[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 11        3     2.61     0.057     0.125
strata=LOW  11        4     4.39     0.034     0.125

 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.3287    0.7198   0.9338 -0.352 0.725

Likelihood ratio test=0.13  on 1 df, p=0.7225
n= 22, number of events= 7 


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

TCGA-COAD ULK1 

[1] 87
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.63     0.513     0.955
strata=LOW  11        3     4.37     0.427     0.955

 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.7047    0.4942   0.7357 -0.958 0.338

Likelihood ratio test=0.95  on 1 df, p=0.3288
n= 22, number of events= 8 


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

TCGA-COAD TRIM26 

[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 11        3     2.82    0.0121    0.0278
strata=LOW  11        2     2.18    0.0156    0.0278

 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.1526    0.8585   0.9156 -0.167 0.868

Likelihood ratio test=0.03  on 1 df, p=0.8671
n= 22, number of events= 5 


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

TCGA-COAD QSOX1 

[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 11        3     3.52    0.0759     0.297
strata=LOW  11        2     1.48    0.1800     0.297

 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.5493    1.7321   1.0198 0.539 0.59

Likelihood ratio test=0.29  on 1 df, p=0.5922
n= 22, number of events= 5 


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

TCGA-COAD ATM 

[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 11        3     3.24    0.0180    0.0423
strata=LOW  11        4     3.76    0.0156    0.0423

 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.1791    1.1962   0.8725 0.205 0.837

Likelihood ratio test=0.04  on 1 df, p=0.8358
n= 22, number of events= 7 


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

TCGA-COAD MIB2 

[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        5     4.74    0.0148    0.0369
strata=LOW  11        3     3.26    0.0214    0.0369

 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.1415    0.8680   0.7373 -0.192 0.848

Likelihood ratio test=0.04  on 1 df, p=0.847
n= 22, number of events= 8 


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

TCGA-COAD SLC1A5 

[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 11        4      3.7    0.0249    0.0743
strata=LOW  11        2      2.3    0.0399    0.0743

 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.2485    0.7800   0.9142 -0.272 0.786

Likelihood ratio test=0.07  on 1 df, p=0.7843
n= 22, number of events= 6 


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

TCGA-COAD MIR2115 



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

TCGA-COAD LINC00336 

[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 11        4     3.04     0.303     0.622
strata=LOW  11        3     3.96     0.232     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.6746    0.5094   0.8712 -0.774 0.439

Likelihood ratio test=0.63  on 1 df, p=0.4257
n= 22, number of events= 7 


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

TCGA-COAD NDRG1 

[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        3     3.44    0.0564     0.133
strata=LOW  11        4     3.56    0.0545     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.2973    1.3462   0.8185 0.363 0.716

Likelihood ratio test=0.13  on 1 df, p=0.7169
n= 22, number of events= 7 


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

TCGA-COAD TAFAZZIN 

[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 11        3     3.17   0.00937      0.03
strata=LOW  11        2     1.83   0.01626      0.03

 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.1734    1.1893   1.0015 0.173 0.863

Likelihood ratio test=0.03  on 1 df, p=0.8627
n= 22, number of events= 5 


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

TCGA-COAD MIR135B 



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

TCGA-COAD GLS2 

[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 11        5     4.33     0.104     0.258
strata=LOW  11        3     3.67     0.122     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.3872    0.6789   0.7663 -0.505 0.613

Likelihood ratio test=0.26  on 1 df, p=0.6112
n= 22, number of events= 8 


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

TCGA-COAD HELLS 

[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 11        6     5.33    0.0846     0.235
strata=LOW  11        3     3.67    0.1228     0.235

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

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

             coef exp(coef) se(coef)      z    p
strataLOW -0.3574    0.6995   0.7411 -0.482 0.63

Likelihood ratio test=0.24  on 1 df, p=0.6258
n= 22, number of events= 9 


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

TCGA-COAD KLF2 

[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 11        5     4.03     0.235     0.559
strata=LOW  11        2     2.97     0.318     0.559

 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.6180    0.5390   0.8398 -0.736 0.462

Likelihood ratio test=0.58  on 1 df, p=0.445
n= 22, number of events= 7 


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

TCGA-COAD TFAP2A 

[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 11        4     2.05      1.86      3.22
strata=LOW  11        1     2.95      1.29      3.22

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.7857    0.1677   1.1257 -1.586 0.113

Likelihood ratio test=3.26  on 1 df, p=0.07108
n= 22, number of events= 5 


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

TCGA-COAD FURIN 

[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 11        5     4.06     0.220     0.527
strata=LOW  11        3     3.94     0.226     0.527

 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.6007    0.5484   0.8398 -0.715 0.474

Likelihood ratio test=0.55  on 1 df, p=0.4581
n= 22, number of events= 8 


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

TCGA-COAD CDH1 

[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 11        4     3.84   0.00653    0.0149
strata=LOW  11        3     3.16   0.00795    0.0149

 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.09426   0.91004  0.77362 -0.122 0.903

Likelihood ratio test=0.01  on 1 df, p=0.9028
n= 22, number of events= 7 


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

TCGA-COAD MIR6852 



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

TCGA-COAD MIR670 



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

TCGA-COAD TYRO3 

[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 11        5     3.62     0.528      2.57
strata=LOW  11        0     1.38     1.382      2.57

 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 -2.106e+01  7.122e-10  2.334e+04 -0.001 0.999

Likelihood ratio test=3.71  on 1 df, p=0.054
n= 22, number of events= 5 


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

TCGA-COAD MIR4715 



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

TCGA-COAD ABHD12 

[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 11        3     4.88     0.725       1.9
strata=LOW  11        7     5.12     0.692       1.9

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.9773    2.6574   0.7368 1.326 0.185

Likelihood ratio test=1.83  on 1 df, p=0.1755
n= 22, number of events= 10 


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

TCGA-COAD ATG7 

[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 11        4     4.17   0.00657    0.0141
strata=LOW  11        5     4.83   0.00566    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.08487   1.08857  0.71592 0.119 0.906

Likelihood ratio test=0.01  on 1 df, p=0.9057
n= 22, number of events= 9 


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

TCGA-COAD MT1G 

[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 11        3      4.4     0.448      1.01
strata=LOW  11        6      4.6     0.429      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.7200    2.0545   0.7334 0.982 0.326

Likelihood ratio test=1  on 1 df, p=0.3168
n= 22, number of events= 9 


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

TCGA-COAD SAT1 

[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 11        1     2.69     1.059      2.32
strata=LOW  11        5     3.31     0.859      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.554     4.729    1.123 1.384 0.166

Likelihood ratio test=2.43  on 1 df, p=0.1187
n= 22, number of events= 6 


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

TCGA-COAD MIR182 



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

TCGA-COAD HOTAIR 

[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 11        4     2.34     1.173       1.6
strata=LOW  23        6     7.66     0.359       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.8323    0.4350   0.6759 -1.231 0.218

Likelihood ratio test=1.44  on 1 df, p=0.2309
n= 34, number of events= 10 


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

TCGA-COAD PIR 

[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 11        3     2.29     0.222     0.416
strata=LOW  11        2     2.71     0.187     0.416

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.5859    0.5566   0.9212 -0.636 0.525

Likelihood ratio test=0.41  on 1 df, p=0.5195
n= 22, number of events= 5 


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

TCGA-COAD ELAVL1 

[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 11        5     4.34     0.102     0.299
strata=LOW  11        2     2.66     0.166     0.299

 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.4699    0.6251   0.8670 -0.542 0.588

Likelihood ratio test=0.31  on 1 df, p=0.5795
n= 22, number of events= 7 


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

TCGA-COAD ACADSB 

[1] 110
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.11     0.582      1.26
strata=LOW  11        3     1.89     0.647      1.26

 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 1.240     3.454    1.169 1.06 0.289

Likelihood ratio test=1.31  on 1 df, p=0.2527
n= 22, number of events= 4 


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

TCGA-COAD NCOA4 

[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 11        2     2.84     0.247      0.48
strata=LOW  11        5     4.16     0.168      0.48

 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.5978    1.8181   0.8749 0.683 0.494

Likelihood ratio test=0.49  on 1 df, p=0.4834
n= 22, number of events= 7 


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

TCGA-COAD IFNA10 



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

TCGA-COAD IFNA13 



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

TCGA-COAD MIR9-2 



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

TCGA-COAD RRM2 

[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 11        4     3.87   0.00451     0.012
strata=LOW  11        3     3.13   0.00557     0.012

 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.09087   0.91313  0.82895 -0.11 0.913

Likelihood ratio test=0.01  on 1 df, p=0.9127
n= 22, number of events= 7 


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

TCGA-COAD EPSTI1 

[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 11        4     3.79    0.0115    0.0255
strata=LOW  11        4     4.21    0.0103    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.1232    0.8841   0.7717 -0.16 0.873

Likelihood ratio test=0.03  on 1 df, p=0.8728
n= 22, number of events= 8 


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

TCGA-COAD LINC00551 

[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 11        6     3.36      2.08      4.03
strata=LOW  11        1     3.64      1.92      4.03

 Chisq= 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.8886    0.1513   1.0832 -1.743 0.0812

Likelihood ratio test=4.42  on 1 df, p=0.03555
n= 22, number of events= 7 


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

TCGA-COAD SLC25A28 

[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 11        5     3.81     0.373     0.962
strata=LOW  11        2     3.19     0.445     0.962

 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.8301    0.4360   0.8700 -0.954 0.34

Likelihood ratio test=0.97  on 1 df, p=0.3243
n= 22, number of events= 7 


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

TCGA-COAD LINC00973 



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

TCGA-COAD MIR378A 



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

TCGA-COAD MGST1 

[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 11        5     3.55     0.591      1.21
strata=LOW  11        3     4.45     0.472      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.8958    0.4083   0.8405 -1.066 0.287

Likelihood ratio test=1.25  on 1 df, p=0.2627
n= 22, number of events= 8 


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

TCGA-COAD MIB1 

[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 11        5     2.73      1.88      5.25
strata=LOW  11        0     2.27      2.27      5.25

 Chisq= 5.2  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 -2.151e+01  4.555e-10  2.043e+04 -0.001 0.999

Likelihood ratio test=6.7  on 1 df, p=0.009615
n= 22, number of events= 5 


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

TCGA-COAD SRC 

[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 11        3     3.36    0.0380     0.088
strata=LOW  11        3     2.64    0.0483     0.088

 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.2439    1.2762   0.8242 0.296 0.767

Likelihood ratio test=0.09  on 1 df, p=0.7675
n= 22, number of events= 6 


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

TCGA-COAD ATG5 

[1] 119
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     4.47     0.485       1.1
strata=LOW  11        6     4.53     0.479       1.1

 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.7519    2.1211   0.7321 1.027 0.304

Likelihood ratio test=1.1  on 1 df, p=0.2947
n= 22, number of events= 9 


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

TCGA-COAD ACVR1B 

[1] 120
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     4.24     0.362     0.925
strata=LOW  11        4     2.76     0.556     0.925

 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.7223    2.0592   0.7669 0.942 0.346

Likelihood ratio test=0.9  on 1 df, p=0.3432
n= 22, number of events= 7 


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

TCGA-COAD NT5DC2 

[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 11        4      4.1   0.00225   0.00973
strata=LOW  11        2      1.9   0.00485   0.00973

 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.1012    1.1065   1.0263 0.099 0.921

Likelihood ratio test=0.01  on 1 df, p=0.9215
n= 22, number of events= 6 


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

TCGA-COAD PIK3CA 

[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 11        6     3.26      2.29      6.11
strata=LOW  11        0     2.74      2.74      6.11

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

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

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.144e+01  4.891e-10  1.818e+04 -0.001 0.999

Likelihood ratio test=7.99  on 1 df, p=0.004707
n= 22, number of events= 6 


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

TCGA-COAD NUPR1 

[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 11        4     4.55    0.0664     0.174
strata=LOW  11        4     3.45    0.0875     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.3188    1.3755   0.7671 0.416 0.678

Likelihood ratio test=0.17  on 1 df, p=0.676
n= 22, number of events= 8 


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

TCGA-COAD AKT1S1 

[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 11        6     5.71    0.0151    0.0496
strata=LOW  11        3     3.29    0.0262    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.1702    0.8435   0.7650 -0.223 0.824

Likelihood ratio test=0.05  on 1 df, p=0.8233
n= 22, number of events= 9 


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

TCGA-COAD MIR19A 



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

TCGA-COAD USP7 

[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 11        5     4.36    0.0925     0.275
strata=LOW  11        2     2.64    0.1532     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.4516    0.6366   0.8685 -0.52 0.603

Likelihood ratio test=0.28  on 1 df, p=0.5954
n= 22, number of events= 7 


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

TCGA-COAD TMSB4Y 

[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 11        2     2.82     0.236       0.4
strata=LOW  16        5     4.18     0.159       0.4

 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.5261    1.6923   0.8410 0.626 0.532

Likelihood ratio test=0.42  on 1 df, p=0.5181
n= 27, number of events= 7 


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

TCGA-COAD SIAH2 

[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 11        3     3.63    0.1094     0.201
strata=LOW  11        5     4.37    0.0909     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.327     1.387    0.732 0.447 0.655

Likelihood ratio test=0.2  on 1 df, p=0.6514
n= 22, number of events= 8 


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

TCGA-COAD MIR29A 



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

TCGA-COAD CHAC1 

[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 11        4     3.57    0.0520     0.111
strata=LOW  11        3     3.43    0.0541     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.2580    0.7726   0.7779 -0.332 0.74

Likelihood ratio test=0.11  on 1 df, p=0.7392
n= 22, number of events= 7 


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

TCGA-COAD LINC00616 



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

TCGA-COAD PRKAA2 

[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 11        4     2.73     0.592      1.66
strata=LOW  11        1     2.27     0.712      1.66

 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.3802    0.2515   1.1574 -1.192 0.233

Likelihood ratio test=1.68  on 1 df, p=0.1952
n= 22, number of events= 5 


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

TCGA-COAD LONP1 

[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 11        7     4.92     0.877      1.97
strata=LOW  11        2     4.08     1.059      1.97

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

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

             coef exp(coef) se(coef)     z    p
strataLOW -1.0796    0.3397   0.8060 -1.34 0.18

Likelihood ratio test=2.11  on 1 df, p=0.1461
n= 22, number of events= 9 


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

TCGA-COAD PPARG 

[1] 131
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.42     0.591      1.39
strata=LOW  11        6     4.58     0.442      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.9844    2.6761   0.8692 1.132 0.257

Likelihood ratio test=1.38  on 1 df, p=0.2405
n= 22, number of events= 8 


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

TCGA-COAD MAPK1 

[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 11        4     2.99     0.338     0.595
strata=LOW  11        4     5.01     0.202     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.5826    0.5584   0.7660 -0.761 0.447

Likelihood ratio test=0.59  on 1 df, p=0.4438
n= 22, number of events= 8 


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

TCGA-COAD PEX6 

[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 11        3      3.2     0.013    0.0283
strata=LOW  11        4      3.8     0.011    0.0283

 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.1383    1.1483   0.8222 0.168 0.866

Likelihood ratio test=0.03  on 1 df, p=0.8665
n= 22, number of events= 7 


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

TCGA-COAD PPARA 

[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 11        4     3.58    0.0492     0.102
strata=LOW  11        4     4.42    0.0399     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.2443    0.7833   0.7675 -0.318 0.75

Likelihood ratio test=0.1  on 1 df, p=0.7492
n= 22, number of events= 8 


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

TCGA-COAD ACSL4 

[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        5     2.84     1.650      2.62
strata=LOW  11        3     5.16     0.906      2.62

 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.1391    0.3201   0.7394 -1.541 0.123

Likelihood ratio test=2.47  on 1 df, p=0.1157
n= 22, number of events= 8 


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

TCGA-COAD ANO6 

[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 11        4      2.7     0.624      1.74
strata=LOW  11        1      2.3     0.733      1.74

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

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

            coef exp(coef) se(coef)     z     p
strataLOW -1.415     0.243    1.160 -1.22 0.223

Likelihood ratio test=1.76  on 1 df, p=0.1849
n= 22, number of events= 5 


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

TCGA-COAD YTHDC2 

[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 11        2      2.3    0.0390    0.0757
strata=LOW  11        3      2.7    0.0332    0.0757

 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.2561    1.2919   0.9328 0.275 0.784

Likelihood ratio test=0.08  on 1 df, p=0.7824
n= 22, number of events= 5 


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

TCGA-COAD MIR103A1 



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

TCGA-COAD INTS2 

[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        5     3.53     0.616      1.39
strata=LOW  11        3     4.47     0.485      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.8885    0.4113   0.7776 -1.143 0.253

Likelihood ratio test=1.32  on 1 df, p=0.2504
n= 22, number of events= 8 


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

TCGA-COAD PTPN6 

[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 11        1     2.73     1.100      2.44
strata=LOW  11        5     3.27     0.921      2.44

 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.581     4.861    1.120 1.412 0.158

Likelihood ratio test=2.55  on 1 df, p=0.1105
n= 22, number of events= 6 


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

TCGA-COAD SMAD7 

[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 11        2     3.53     0.662      1.72
strata=LOW  11        5     3.47     0.674      1.72

 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.1111    3.0377   0.8857 1.254 0.21

Likelihood ratio test=1.68  on 1 df, p=0.1948
n= 22, number of events= 7 


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

TCGA-COAD ATG16L1 

[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 11        3      3.4    0.0477    0.0945
strata=LOW  11        4      3.6    0.0451    0.0945

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.2364    1.2666   0.7704 0.307 0.759

Likelihood ratio test=0.09  on 1 df, p=0.758
n= 22, number of events= 7 


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

TCGA-COAD LINC00976 

[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 11        3     2.95  0.000793   0.00159
strata=LOW  11        3     3.05  0.000767   0.00159

 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.03296   0.96757  0.82555 -0.04 0.968

Likelihood ratio test=0  on 1 df, p=0.9681
n= 22, number of events= 6 


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

TCGA-COAD H19 

[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 11        5     4.57    0.0398     0.127
strata=LOW  11        2     2.43    0.0751     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.3096    0.7337   0.8705 -0.356 0.722

Likelihood ratio test=0.13  on 1 df, p=0.718
n= 22, number of events= 7 


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

TCGA-COAD FADS1 

[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 11        5     3.81     0.370     0.846
strata=LOW  11        3     4.19     0.337     0.846

 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.6926    0.5003   0.7676 -0.902 0.367

Likelihood ratio test=0.82  on 1 df, p=0.3638
n= 22, number of events= 8 


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

TCGA-COAD CHP1 

[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 11        3     3.36    0.0382    0.0881
strata=LOW  11        4     3.64    0.0352    0.0881

 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.2437    1.2760   0.8229 0.296 0.767

Likelihood ratio test=0.09  on 1 df, p=0.7674
n= 22, number of events= 7 


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

TCGA-COAD PRR5 

[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 11        5     5.96     0.156     0.697
strata=LOW  11        3     2.04     0.457     0.697

 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.6718    1.9578   0.8197 0.82 0.412

Likelihood ratio test=0.66  on 1 df, p=0.4167
n= 22, number of events= 8 


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

TCGA-COAD CFL1 

[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 11        3     4.24     0.365     0.935
strata=LOW  11        5     3.76     0.412     0.935

 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.7266    2.0680   0.7674 0.947 0.344

Likelihood ratio test=0.91  on 1 df, p=0.3407
n= 22, number of events= 8 


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

TCGA-COAD MIR382 



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

TCGA-COAD LAMP2 

[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 11        3     1.43     1.727      3.44
strata=LOW  11        2     3.57     0.691      3.44

 Chisq= 3.4  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 -2.143e+01  4.950e-10  2.352e+04 -0.001 0.999

Likelihood ratio test=4.61  on 1 df, p=0.03188
n= 22, number of events= 5 


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

TCGA-COAD PTPN14 

[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 11        6     4.93     0.233     0.703
strata=LOW  11        2     3.07     0.374     0.703

 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.7029    0.4952   0.8538 -0.823 0.41

Likelihood ratio test=0.73  on 1 df, p=0.3924
n= 22, number of events= 8 


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

TCGA-COAD AGPAT3 

[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 11        3     3.08   0.00228     0.005
strata=LOW  11        4     3.92   0.00180     0.005

 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.05952   1.06132  0.84171 0.071 0.944

Likelihood ratio test=0  on 1 df, p=0.9436
n= 22, number of events= 7 


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

TCGA-COAD STING1 

[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 11        4     4.66    0.0947     0.237
strata=LOW  11        5     4.34    0.1018     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.3657    1.4415   0.7552 0.484 0.628

Likelihood ratio test=0.24  on 1 df, p=0.6239
n= 22, number of events= 9 


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

TCGA-COAD ABCC1 

[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 11        5     3.53     0.610      1.11
strata=LOW  11        3     4.47     0.482      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.7587    0.4683   0.7363 -1.03 0.303

Likelihood ratio test=1.1  on 1 df, p=0.2933
n= 22, number of events= 8 


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

TCGA-COAD IFNA5 



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

TCGA-COAD MIR140 



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

TCGA-COAD MYB 

[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 11        2     3.67     0.760      1.62
strata=LOW  11        5     3.33     0.838      1.62

 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.0297    2.8002   0.8429 1.222 0.222

Likelihood ratio test=1.66  on 1 df, p=0.1972
n= 22, number of events= 7 


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

TCGA-COAD IFNA6 



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

TCGA-COAD IFNA14 



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

TCGA-COAD BDNF-AS 

[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 11        2     2.71     0.184     0.413
strata=LOW  11        4     3.29     0.151     0.413

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.5866    1.7979   0.9253 0.634 0.526

Likelihood ratio test=0.41  on 1 df, p=0.5212
n= 22, number of events= 6 


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

TCGA-COAD TRIB2 

[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 11        4     3.36     0.120     0.328
strata=LOW  11        2     2.64     0.154     0.328

 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.5191    0.5951   0.9168 -0.566 0.571

Likelihood ratio test=0.33  on 1 df, p=0.5667
n= 22, number of events= 6 


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

TCGA-COAD MALAT1 

[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        4     3.46    0.0859     0.249
strata=LOW  11        2     2.54    0.1167     0.249

 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.4622    0.6299   0.9339 -0.495 0.621

Likelihood ratio test=0.25  on 1 df, p=0.617
n= 22, number of events= 6 


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

TCGA-COAD FH 

[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 11        3     3.97     0.236     0.553
strata=LOW  11        4     3.03     0.308     0.553

 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.5661    1.7613   0.7711 0.734 0.463

Likelihood ratio test=0.55  on 1 df, p=0.4597
n= 22, number of events= 7 


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

TCGA-COAD PEX10 

[1] 158
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.17   0.00948    0.0264
strata=LOW  11        3     2.83   0.01064    0.0264

 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.1497    1.1614   0.9217 0.162 0.871

Likelihood ratio test=0.03  on 1 df, p=0.8717
n= 22, number of events= 6 


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

TCGA-COAD SCD 

[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 11        5     4.29     0.117     0.289
strata=LOW  11        3     3.71     0.135     0.289

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.4097    0.6639   0.7667 -0.534 0.593

Likelihood ratio test=0.29  on 1 df, p=0.5908
n= 22, number of events= 8 


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

TCGA-COAD FTL 

[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 11        4      3.3     0.148     0.285
strata=LOW  11        4      4.7     0.104     0.285

 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.4077    0.6651   0.7693 -0.53 0.596

Likelihood ratio test=0.28  on 1 df, p=0.5937
n= 22, number of events= 8 


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

TCGA-COAD TSC1 

[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 11        5     4.06     0.218     0.522
strata=LOW  11        3     3.94     0.225     0.522

 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.5498    0.5771   0.7698 -0.714 0.475

Likelihood ratio test=0.52  on 1 df, p=0.4721
n= 22, number of events= 8 


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

TCGA-COAD BRD3 

[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 11        5     3.86     0.336     0.902
strata=LOW  11        2     3.14     0.413     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.8150    0.4426   0.8799 -0.926 0.354

Likelihood ratio test=0.91  on 1 df, p=0.3397
n= 22, number of events= 7 


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

TCGA-COAD SLC16A1 

[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 11        3     2.33     0.196     0.372
strata=LOW  11        3     3.68     0.124     0.372

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.5536    0.5749   0.9193 -0.602 0.547

Likelihood ratio test=0.37  on 1 df, p=0.5422
n= 22, number of events= 6 


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

TCGA-COAD MIR132 



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

TCGA-COAD MIR375 



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

TCGA-COAD MIOX 

[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 11        2     2.12   0.00693    0.0151
strata=LOW  11        2     1.88   0.00782    0.0151

 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.1247    1.1328   1.0137 0.123 0.902

Likelihood ratio test=0.02  on 1 df, p=0.9021
n= 22, number of events= 4 


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

TCGA-COAD ATXN8OS 



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

TCGA-COAD KLHDC3 

[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 11        2     1.83   0.01526    0.0283
strata=LOW  11        3     3.17   0.00883    0.0283

 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.1682    0.8452   1.0016 -0.168 0.867

Likelihood ratio test=0.03  on 1 df, p=0.8667
n= 22, number of events= 5 


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

TCGA-COAD MICU1 

[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 11        4     2.56     0.805      1.45
strata=LOW  11        4     5.44     0.380      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 -1.0184    0.3612   0.8807 -1.156 0.248

Likelihood ratio test=1.44  on 1 df, p=0.2304
n= 22, number of events= 8 


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

TCGA-COAD CBS 

[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 11        4     2.95     0.370      1.12
strata=LOW  11        1     2.05     0.534      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 -1.1662    0.3115   1.1637 -1.002 0.316

Likelihood ratio test=1.16  on 1 df, p=0.2809
n= 22, number of events= 5 


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

TCGA-COAD HUWE1 

[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 11        5     3.27     0.918      2.45
strata=LOW  11        1     2.73     1.098      2.45

 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.5881    0.2043   1.1223 -1.415 0.157

Likelihood ratio test=2.56  on 1 df, p=0.1099
n= 22, number of events= 6 


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

TCGA-COAD LINC00472 

[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 11        5     4.05     0.221     0.613
strata=LOW  11        2     2.95     0.304     0.613

 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.6725    0.5104   0.8744 -0.769 0.442

Likelihood ratio test=0.63  on 1 df, p=0.4292
n= 22, number of events= 7 


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

TCGA-COAD FGF21 



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

TCGA-COAD MIR34A 



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

TCGA-COAD IDH1 

[1] 170
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.17   0.00952    0.0202
strata=LOW  11        5     4.83   0.00626    0.0202

 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.1163    1.1233   0.8175 0.142 0.887

Likelihood ratio test=0.02  on 1 df, p=0.8869
n= 22, number of events= 8 


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

TCGA-COAD GSK3B 

[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 11        4     3.17     0.216     0.459
strata=LOW  11        2     2.83     0.242     0.459

 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.5793    0.5603   0.8669 -0.668 0.504

Likelihood ratio test=0.47  on 1 df, p=0.4929
n= 22, number of events= 6 


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

TCGA-COAD KDM4A 

[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 11        3     3.46    0.0622     0.124
strata=LOW  11        4     3.54    0.0610     0.124

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.2693    1.3090   0.7666 0.351 0.725

Likelihood ratio test=0.12  on 1 df, p=0.7241
n= 22, number of events= 7 


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

TCGA-COAD PEX12 

[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 11        4     3.17     0.218     0.401
strata=LOW  11        3     3.83     0.180     0.401

 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.4805    0.6185   0.7664 -0.627 0.531

Likelihood ratio test=0.4  on 1 df, p=0.5279
n= 22, number of events= 7 


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

TCGA-COAD IDO1 

[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 11        4     4.12   0.00372   0.00773
strata=LOW  11        5     4.88   0.00315   0.00773

 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.06234   1.06433  0.70920 0.088 0.93

Likelihood ratio test=0.01  on 1 df, p=0.93
n= 22, number of events= 9 


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

TCGA-COAD BCAT2 

[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 11        4     4.96     0.185     0.728
strata=LOW  11        3     2.04     0.448     0.728

 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.7168    2.0479   0.8545 0.839 0.402

Likelihood ratio test=0.7  on 1 df, p=0.4042
n= 22, number of events= 7 


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

TCGA-COAD ADAM23 

[1] 176
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.06     0.287       0.6
strata=LOW  11        2     2.94     0.300       0.6

 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.6653    0.5141   0.8737 -0.761 0.446

Likelihood ratio test=0.61  on 1 df, p=0.4339
n= 22, number of events= 6 


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

TCGA-COAD PEX3 

[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 11        2      2.6     0.140     0.294
strata=LOW  11        3      2.4     0.152     0.294

 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.4917    1.6352   0.9163 0.537 0.592

Likelihood ratio test=0.29  on 1 df, p=0.5873
n= 22, number of events= 5 


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

TCGA-COAD ATP5MC3 

[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 11        2     2.95     0.305     0.762
strata=LOW  11        4     3.05     0.295     0.762

 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.7867    2.1961   0.9229 0.852 0.394

Likelihood ratio test=0.75  on 1 df, p=0.3878
n= 22, number of events= 6 


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

TCGA-COAD AQP5 

[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 11        5     3.12     1.139       1.8
strata=LOW  11        4     5.88     0.603       1.8

 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.8866    0.4121   0.6814 -1.301 0.193

Likelihood ratio test=1.69  on 1 df, p=0.1931
n= 22, number of events= 9 


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

TCGA-COAD ADAMTS9-AS1 

[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        5     4.16     0.169     0.492
strata=LOW  11        2     2.84     0.247     0.492

 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.6097    0.5435   0.8816 -0.692 0.489

Likelihood ratio test=0.5  on 1 df, p=0.4787
n= 22, number of events= 7 


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

TCGA-COAD ACSL3 

[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 11        5     4.17     0.164     0.396
strata=LOW  11        3     3.83     0.179     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.4770    0.6207   0.7648 -0.624 0.533

Likelihood ratio test=0.39  on 1 df, p=0.5301
n= 22, number of events= 8 


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

TCGA-COAD DDR2 

[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 11        6     4.15     0.829      2.37
strata=LOW  11        1     2.85     1.205      2.37

 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.5468    0.2129   1.1034 -1.402 0.161

Likelihood ratio test=2.6  on 1 df, p=0.1067
n= 22, number of events= 7 


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

TCGA-COAD TERT 

[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 11        2      3.9     0.926      2.98
strata=LOW  11        4      2.1     1.721      2.98

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

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

           coef exp(coef) se(coef)     z     p
strataLOW 1.718     5.571    1.120 1.534 0.125

Likelihood ratio test=3.04  on 1 df, p=0.0811
n= 22, number of events= 6 


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

TCGA-COAD IFNA7 



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

TCGA-COAD ECH1 

[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 11        2      2.6     0.139     0.295
strata=LOW  11        4      3.4     0.106     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.4947    1.6399   0.9201 0.538 0.591

Likelihood ratio test=0.3  on 1 df, p=0.5867
n= 22, number of events= 6 


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

TCGA-COAD CS 

[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 11        3     3.21    0.0136    0.0295
strata=LOW  11        3     2.79    0.0156    0.0295

 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.1406    1.1510   0.8198 0.172 0.864

Likelihood ratio test=0.03  on 1 df, p=0.8638
n= 22, number of events= 6 


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

TCGA-COAD AMN 

[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 11        2     3.18     0.437     0.965
strata=LOW  11        4     2.82     0.493     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 0.8391    2.3142   0.8776 0.956 0.339

Likelihood ratio test=0.97  on 1 df, p=0.3241
n= 22, number of events= 6 


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

TCGA-COAD DUOX2 

[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 11        4     3.04     0.300     0.625
strata=LOW  11        2     2.96     0.309     0.625

 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.6792    0.5070   0.8747 -0.777 0.437

Likelihood ratio test=0.64  on 1 df, p=0.4247
n= 22, number of events= 6 


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

TCGA-COAD MBOAT1 

[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 11        2     3.01     0.341     0.876
strata=LOW  11        3     1.99     0.517     0.876

 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.8408    2.3182   0.9232 0.911 0.362

Likelihood ratio test=0.85  on 1 df, p=0.356
n= 22, number of events= 5 


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

TCGA-COAD RNF113A 

[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 11        1     2.63      1.01       2.2
strata=LOW  11        4     2.37      1.13       2.2

 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.530     4.619    1.129 1.355 0.175

Likelihood ratio test=2.32  on 1 df, p=0.1276
n= 22, number of events= 5 


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

TCGA-COAD MIR138-1 



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

TCGA-COAD MIR144 



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

TCGA-COAD P4HB 

[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 11        2     2.46    0.0849     0.168
strata=LOW  11        3     2.54    0.0820     0.168

 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.3724    1.4513   0.9150 0.407 0.684

Likelihood ratio test=0.17  on 1 df, p=0.6811
n= 22, number of events= 5 


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

TCGA-COAD MIR338 



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

TCGA-COAD PTGS2 

[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 11        4     2.15      1.60      3.52
strata=LOW  11        0     1.85      1.85      3.52

 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 -2.111e+01  6.785e-10  2.028e+04 -0.001 0.999

Likelihood ratio test=5.05  on 1 df, p=0.02466
n= 22, number of events= 4 


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

TCGA-COAD ASAH2 

[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 11        1     1.99     0.491     0.827
strata=LOW  11        5     4.01     0.243     0.827

 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.9822    2.6704   1.1231 0.875 0.382

Likelihood ratio test=0.91  on 1 df, p=0.3411
n= 22, number of events= 6 


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

TCGA-COAD MIR522 



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

TCGA-COAD GALNT14 

[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 11        5     2.07      4.17      6.76
strata=LOW  11        1     3.93      2.19      6.76

 Chisq= 6.8  on 1 degrees of freedom, p= 0.009 

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

              coef exp(coef) se(coef)      z      p
strataLOW -2.45008   0.08629  1.13638 -2.156 0.0311

Likelihood ratio test=6.61  on 1 df, p=0.01013
n= 22, number of events= 6 


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

TCGA-COAD KDM4C 

[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 11        1     2.38     0.798      1.61
strata=LOW  11        5     3.62     0.523      1.61

 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.341     3.822    1.132 1.184 0.236

Likelihood ratio test=1.72  on 1 df, p=0.1895
n= 22, number of events= 6 


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

TCGA-COAD FXN 

[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 11        6     4.99     0.204     0.693
strata=LOW  11        2     3.01     0.339     0.693

 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.7129    0.4902   0.8734 -0.816 0.414

Likelihood ratio test=0.71  on 1 df, p=0.4007
n= 22, number of events= 8 


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

TCGA-COAD MEF2C 

[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 11        3     1.28     2.294      4.03
strata=LOW  11        2     3.72     0.793      4.03

 Chisq= 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 -2.155e+01  4.392e-10  2.368e+04 -0.001 0.999

Likelihood ratio test=5.11  on 1 df, p=0.02375
n= 22, number of events= 5 


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

TCGA-COAD MDM2 

[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 11        3     4.89     0.733      3.04
strata=LOW  11        4     2.11     1.701      3.04

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

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

           coef exp(coef) se(coef)     z    p
strataLOW 1.767     5.852    1.136 1.555 0.12

Likelihood ratio test=3.12  on 1 df, p=0.07751
n= 22, number of events= 7 


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

TCGA-COAD MAP3K14 

[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 11        4     2.83     0.488      0.85
strata=LOW  11        4     5.17     0.267      0.85

 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.7069    0.4931   0.7814 -0.905 0.366

Likelihood ratio test=0.83  on 1 df, p=0.3618
n= 22, number of events= 8 


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

TCGA-COAD MDM4 

[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 11        4     4.71     0.106     0.296
strata=LOW  11        4     3.29     0.151     0.296

 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.4196    1.5214   0.7765 0.54 0.589

Likelihood ratio test=0.3  on 1 df, p=0.5868
n= 22, number of events= 8 


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

TCGA-COAD ASMTL-AS1 

[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 11        4     3.26     0.169     0.451
strata=LOW  11        2     2.74     0.201     0.451

 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.6091    0.5438   0.9204 -0.662 0.508

Likelihood ratio test=0.45  on 1 df, p=0.5027
n= 22, number of events= 6 


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

TCGA-COAD NEAT1 

[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 11        2      3.1     0.392     0.842
strata=LOW  11        4      2.9     0.420     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.7865    2.1957   0.8778 0.896 0.37

Likelihood ratio test=0.85  on 1 df, p=0.3559
n= 22, number of events= 6 


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

TCGA-COAD COPZ1 

[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 11        2     3.37     0.556      1.08
strata=LOW  11        6     4.63     0.405      1.08

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.8507    2.3413   0.8409 1.012 0.312

Likelihood ratio test=1.13  on 1 df, p=0.2886
n= 22, number of events= 8 


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

TCGA-COAD PLIN2 

[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 11        2     2.47    0.0906     0.183
strata=LOW  11        5     4.53    0.0495     0.183

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

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

            coef exp(coef) se(coef)     z    p
strataLOW 0.3929    1.4812   0.9228 0.426 0.67

Likelihood ratio test=0.18  on 1 df, p=0.6673
n= 22, number of events= 7 


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

TCGA-COAD FADS2 

[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 11        6     4.83     0.285     0.817
strata=LOW  11        2     3.17     0.433     0.817

 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.7475    0.4735   0.8454 -0.884 0.377

Likelihood ratio test=0.85  on 1 df, p=0.3567
n= 22, number of events= 8 


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

TCGA-COAD MIR7-1 



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

TCGA-COAD TXN 

[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        1     2.33     0.759      1.84
strata=LOW  11        4     2.67     0.661      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.452     4.271    1.162 1.25 0.211

Likelihood ratio test=1.85  on 1 df, p=0.174
n= 22, number of events= 5 


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

TCGA-COAD MIR302A 



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

TCGA-COAD EGLN2 

[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 11        4     4.46    0.0476     0.122
strata=LOW  11        4     3.54    0.0600     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.2674    1.3066   0.7667 0.349 0.727

Likelihood ratio test=0.12  on 1 df, p=0.726
n= 22, number of events= 8 


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

TCGA-COAD NCOA3 

[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 11        3     2.35     0.178     0.481
strata=LOW  11        2     2.65     0.158     0.481

 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.6947    0.4992   1.0198 -0.681 0.496

Likelihood ratio test=0.46  on 1 df, p=0.4992
n= 22, number of events= 5 


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

TCGA-COAD SREBF1 

[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 11        4     3.75    0.0170    0.0518
strata=LOW  11        2     2.25    0.0283    0.0518

 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.2078    0.8124   0.9149 -0.227 0.82

Likelihood ratio test=0.05  on 1 df, p=0.8193
n= 22, number of events= 6 


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

TCGA-COAD LINC01134 

[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 11        3     4.41     0.453      1.25
strata=LOW  11        5     3.59     0.557      1.25

 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.8388    2.3136   0.7712 1.088 0.277

Likelihood ratio test=1.2  on 1 df, p=0.2742
n= 22, number of events= 8 


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

TCGA-COAD MYCN 

[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 11        3     2.83   0.01003    0.0175
strata=LOW  11        4     4.17   0.00681    0.0175

 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.1031    0.9020   0.7796 -0.132 0.895

Likelihood ratio test=0.02  on 1 df, p=0.895
n= 22, number of events= 7 


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

TCGA-COAD IFNA4 



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

TCGA-COAD DPEP1 

[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 11        4     2.74     0.577      1.31
strata=LOW  11        2     3.26     0.486      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 -1.2157    0.2965   1.1266 -1.079 0.281

Likelihood ratio test=1.42  on 1 df, p=0.2332
n= 22, number of events= 6 


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

TCGA-COAD VDAC2 

[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 11        3     3.91     0.212     0.518
strata=LOW  11        5     4.09     0.203     0.518

 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.5589    1.7487   0.7856 0.711 0.477

Likelihood ratio test=0.51  on 1 df, p=0.475
n= 22, number of events= 8 


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

TCGA-COAD PCBP2-OT1 

[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 11        2     4.06      1.04      2.73
strata=LOW  21        6     3.94      1.07      2.73

 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.702     5.485    1.124 1.514 0.13

Likelihood ratio test=3.12  on 1 df, p=0.07753
n= 32, number of events= 8 


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

TCGA-COAD KEAP1 

[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 11        3     2.53    0.0864     0.247
strata=LOW  11        2     2.47    0.0887     0.247

 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.5764    0.5619   1.1748 -0.491 0.624

Likelihood ratio test=0.26  on 1 df, p=0.6097
n= 22, number of events= 5 


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

TCGA-COAD RPL8 

[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 11        3     2.54    0.0844     0.173
strata=LOW  11        3     3.46    0.0618     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.3791    0.6845   0.9168 -0.413 0.679

Likelihood ratio test=0.17  on 1 df, p=0.6764
n= 22, number of events= 6 


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

TCGA-COAD ALOX12 

[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 11        5     3.99     0.258      0.52
strata=LOW  11        4     5.01     0.205      0.52

 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.5240    0.5922   0.7344 -0.713 0.476

Likelihood ratio test=0.53  on 1 df, p=0.4685
n= 22, number of events= 9 


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

TCGA-COAD ACSF2 

[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 11        2     2.86     0.260     0.619
strata=LOW  11        4     3.14     0.238     0.619

 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.7101    2.0342   0.9205 0.771 0.44

Likelihood ratio test=0.61  on 1 df, p=0.4344
n= 22, number of events= 6 


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

TCGA-COAD KDM5A 

[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 11        4     3.29     0.155     0.397
strata=LOW  11        3     3.71     0.137     0.397

 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.5421    0.5815   0.8684 -0.624 0.532

Likelihood ratio test=0.39  on 1 df, p=0.533
n= 22, number of events= 7 


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

TCGA-COAD NRAS 

[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 11        3     2.99  5.74e-05  0.000119
strata=LOW  11        4     4.01  4.27e-05  0.000119

 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.009084  0.990957  0.832902 -0.011 0.991

Likelihood ratio test=0  on 1 df, p=0.9913
n= 22, number of events= 7 


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

TCGA-COAD MIR30E 



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

TCGA-COAD OGFRP1 

[1] 220
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     4.09   0.00204   0.00421
strata=LOW  11        4     3.91   0.00213   0.00421

 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.04604   1.04711  0.70996 0.065 0.948

Likelihood ratio test=0  on 1 df, p=0.9483
n= 22, number of events= 8 


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

TCGA-COAD TF 

[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 11        5     4.58    0.0390    0.0913
strata=LOW  11        4     4.42    0.0404    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.2147    0.8068   0.7115 -0.302 0.763

Likelihood ratio test=0.09  on 1 df, p=0.7631
n= 22, number of events= 9 


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

TCGA-COAD ETV4 

[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 11        5     3.51     0.634       1.8
strata=LOW  11        1     2.49     0.893       1.8

 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.3924    0.2485   1.1219 -1.241 0.215

Likelihood ratio test=1.93  on 1 df, p=0.1651
n= 22, number of events= 6 


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

TCGA-COAD PLA2G6 

[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 11        3     2.84   0.00934     0.018
strata=LOW  11        4     4.16   0.00636     0.018

 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.1105    0.8954   0.8237 -0.134 0.893

Likelihood ratio test=0.02  on 1 df, p=0.8933
n= 22, number of events= 7 


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

TCGA-COAD POR 

[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 11        4     4.16   0.00627    0.0156
strata=LOW  11        3     2.84   0.00919    0.0156

 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.09604   1.10080  0.76827 0.125 0.901

Likelihood ratio test=0.02  on 1 df, p=0.9008
n= 22, number of events= 7 


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

TCGA-COAD BRPF1 

[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 11        3     3.25    0.0187     0.035
strata=LOW  11        4     3.75    0.0162     0.035

 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.1431    1.1538   0.7653 0.187 0.852

Likelihood ratio test=0.04  on 1 df, p=0.8513
n= 22, number of events= 7 


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

TCGA-COAD TMBIM4 

[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 11        2     3.23     0.471      1.03
strata=LOW  11        4     2.77     0.551      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.8524    2.3452   0.8673 0.983 0.326

Likelihood ratio test=1.03  on 1 df, p=0.3096
n= 22, number of events= 6 


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

TCGA-COAD KRAS 

[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 11        1      2.4     0.819      1.58
strata=LOW  11        4      2.6     0.758      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 1.313     3.719    1.120 1.173 0.241

Likelihood ratio test=1.71  on 1 df, p=0.1912
n= 22, number of events= 5 


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

TCGA-COAD AHCY 

[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 11        2      2.2    0.0179    0.0319
strata=LOW  11        4      3.8    0.0103    0.0319

 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.1630    1.1771   0.9133 0.179 0.858

Likelihood ratio test=0.03  on 1 df, p=0.8576
n= 22, number of events= 6 


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

TCGA-COAD MIR34C 



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

TCGA-COAD ATG3 

[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 11        2     3.09     0.382     0.795
strata=LOW  11        5     3.91     0.302     0.795

 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.7577    2.1333   0.8698 0.871 0.384

Likelihood ratio test=0.81  on 1 df, p=0.3689
n= 22, number of events= 7 


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

TCGA-COAD MIR30B 



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

TCGA-COAD LYRM1 

[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 11        2     1.36     0.297      0.55
strata=LOW  11        2     2.64     0.154      0.55

 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.8848    0.4128   1.2307 -0.719 0.472

Likelihood ratio test=0.55  on 1 df, p=0.4572
n= 22, number of events= 4 


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

TCGA-COAD SIRT6 

[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 11        2      3.7     0.784       2.1
strata=LOW  11        5      3.3     0.880       2.1

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

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

            coef exp(coef) se(coef)     z    p
strataLOW 1.2038    3.3329   0.8776 1.372 0.17

Likelihood ratio test=2.03  on 1 df, p=0.1542
n= 22, number of events= 7 


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

TCGA-COAD KMT2D 

[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 11        5      3.3      0.88      2.38
strata=LOW  11        1      2.7      1.07      2.38

 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.5770    0.2066   1.1261 -1.4 0.161

Likelihood ratio test=2.49  on 1 df, p=0.1142
n= 22, number of events= 6 


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

TCGA-COAD LPIN1 

[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 11        5     3.39     0.764      1.66
strata=LOW  11        3     4.61     0.562      1.66

 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.9555    0.3846   0.7682 -1.244 0.214

Likelihood ratio test=1.56  on 1 df, p=0.2118
n= 22, number of events= 8 


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

TCGA-COAD MBOAT2 

[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 11        2     2.24    0.0255    0.0461
strata=LOW  11        3     2.76    0.0206    0.0461

 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.1958    1.2163   0.9132 0.214 0.83

Likelihood ratio test=0.05  on 1 df, p=0.8292
n= 22, number of events= 5 


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

TCGA-COAD KDM3B 

[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 11        4     3.07     0.279     0.707
strata=LOW  11        2     2.93     0.293     0.707

 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.7512    0.4718   0.9141 -0.822 0.411

Likelihood ratio test=0.69  on 1 df, p=0.4049
n= 22, number of events= 6 


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

TCGA-COAD ARHGEF26-AS1 

[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 11        3     3.18    0.0107    0.0229
strata=LOW  11        3     2.82    0.0121    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.1236    1.1316   0.8175 0.151 0.88

Likelihood ratio test=0.02  on 1 df, p=0.8798
n= 22, number of events= 6 


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

TCGA-COAD MIR9-1 



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

TCGA-COAD AIFM2 

[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        2     3.05     0.364     0.746
strata=LOW  11        4     2.95     0.378     0.746

 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.7336    2.0825   0.8682 0.845 0.398

Likelihood ratio test=0.76  on 1 df, p=0.3837
n= 22, number of events= 6 


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

TCGA-COAD PRDX1 

[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 11        3     2.88   0.00538    0.0107
strata=LOW  11        4     4.12   0.00375    0.0107

 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.08592   0.91766  0.83091 -0.103 0.918

Likelihood ratio test=0.01  on 1 df, p=0.9176
n= 22, number of events= 7 


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

TCGA-COAD FOXO4 

[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 11        3     2.94  0.001194   0.00248
strata=LOW  11        4     4.06  0.000865   0.00248

 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.04183   0.95904  0.84017 -0.05 0.96

Likelihood ratio test=0  on 1 df, p=0.9603
n= 22, number of events= 7 


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

TCGA-COAD BMAL1 

[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 11        4     4.08   0.00163   0.00336
strata=LOW  11        4     3.92   0.00169   0.00336

 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.0412    1.0421   0.7110 0.058 0.954

Likelihood ratio test=0  on 1 df, p=0.9538
n= 22, number of events= 8 


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

TCGA-COAD MIR127 



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

TCGA-COAD TGFBR1 

[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 11        6     3.75      1.34      3.42
strata=LOW  11        1     3.25      1.55      3.42

 Chisq= 3.4  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.7877    0.1673   1.0982 -1.628 0.104

Likelihood ratio test=3.64  on 1 df, p=0.05639
n= 22, number of events= 7 


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

TCGA-COAD NR1D2 

[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 11        3      3.2    0.0130     0.028
strata=LOW  11        4      3.8    0.0109     0.028

 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.1372    1.1470   0.8198 0.167 0.867

Likelihood ratio test=0.03  on 1 df, p=0.8672
n= 22, number of events= 7 


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

TCGA-COAD FZD7 

[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 11        5     3.87     0.330     0.643
strata=LOW  11        3     4.13     0.309     0.643

 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.5798    0.5600   0.7328 -0.791 0.429

Likelihood ratio test=0.65  on 1 df, p=0.4208
n= 22, number of events= 8 


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

TCGA-COAD G6PD 

[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        3     2.37     0.165     0.314
strata=LOW  11        2     2.63     0.149     0.314

 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.5069    0.6024   0.9138 -0.555 0.579

Likelihood ratio test=0.31  on 1 df, p=0.5747
n= 22, number of events= 5 


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

TCGA-COAD HRAS 

[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 11        5     4.73    0.0155    0.0567
strata=LOW  11        2     2.27    0.0323    0.0567

 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.2141    0.8073   0.9005 -0.238 0.812

Likelihood ratio test=0.06  on 1 df, p=0.8105
n= 22, number of events= 7 


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

TCGA-COAD SLC38A1 

[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 11        4     2.86     0.457      1.32
strata=LOW  11        1     2.14     0.610      1.32

 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 -1.2451    0.2879   1.1558 -1.077 0.281

Likelihood ratio test=1.36  on 1 df, p=0.244
n= 22, number of events= 5 


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

TCGA-COAD SLC39A14 

[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 11        3     3.07   0.00154   0.00345
strata=LOW  11        4     3.93   0.00120   0.00345

 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.05002   1.05129  0.85223 0.059 0.953

Likelihood ratio test=0  on 1 df, p=0.9532
n= 22, number of events= 7 


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

TCGA-COAD MIR21 



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

TCGA-COAD MIR1-1 



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

TCGA-COAD PROM2 

[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 11        5      5.4    0.0298    0.0844
strata=LOW  11        4      3.6    0.0447    0.0844

 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.2094    1.2330   0.7220 0.29 0.772

Likelihood ratio test=0.08  on 1 df, p=0.7718
n= 22, number of events= 9 


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

TCGA-COAD NFE2L2 

[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 11        4     4.19   0.00851    0.0185
strata=LOW  11        5     4.81   0.00741    0.0185

 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.09764   1.10256  0.71886 0.136 0.892

Likelihood ratio test=0.02  on 1 df, p=0.892
n= 22, number of events= 9 


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

TCGA-COAD GABARAPL1 

[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 11        4     2.42     1.029         2
strata=LOW  11        2     3.58     0.696         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.4550    0.2334   1.1197 -1.299 0.194

Likelihood ratio test=2.13  on 1 df, p=0.1444
n= 22, number of events= 6 


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

TCGA-COAD MIR335 



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

TCGA-COAD PTEN 

[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 11        4     3.76    0.0156    0.0337
strata=LOW  11        4     4.24    0.0138    0.0337

 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.1404    0.8690   0.7650 -0.184 0.854

Likelihood ratio test=0.03  on 1 df, p=0.854
n= 22, number of events= 8 


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

TCGA-COAD PARP4 

[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 11        3     3.32    0.0311    0.0595
strata=LOW  11        6     5.68    0.0182    0.0595

 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.1864    1.2050   0.7656 0.244 0.808

Likelihood ratio test=0.06  on 1 df, p=0.8069
n= 22, number of events= 9 


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

TCGA-COAD MS4A15 

[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 11        5     2.89      1.53      3.02
strata=LOW  11        2     4.11      1.08      3.02

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.7121    0.1805   1.1034 -1.552 0.121

Likelihood ratio test=3.27  on 1 df, p=0.07071
n= 22, number of events= 7 


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

TCGA-COAD TIMM9 

[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 11        4      2.8     0.513     0.965
strata=LOW  11        3      4.2     0.342     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 -0.8281    0.4369   0.8671 -0.955 0.34

Likelihood ratio test=0.97  on 1 df, p=0.3237
n= 22, number of events= 7 


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

TCGA-COAD PARP3 

[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 11        5     4.71    0.0178    0.0469
strata=LOW  11        3     3.29    0.0254    0.0469

 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.1644    0.8484   0.7596 -0.216 0.829

Likelihood ratio test=0.05  on 1 df, p=0.8278
n= 22, number of events= 8 


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

TCGA-COAD WIPI1 

[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 11        1      1.9     0.423     0.828
strata=LOW  11        4      3.1     0.259     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 1.018     2.766    1.165 0.874 0.382

Likelihood ratio test=0.87  on 1 df, p=0.3508
n= 22, number of events= 5 


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

TCGA-COAD SNX5 

[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 11        1     3.03      1.36      2.74
strata=LOW  11        6     3.97      1.03      2.74

 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.631     5.107    1.096 1.487 0.137

Likelihood ratio test=2.99  on 1 df, p=0.08389
n= 22, number of events= 7 


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

TCGA-COAD LINC00239 

[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 11        3      4.6     0.559      1.67
strata=LOW  11        5      3.4     0.757      1.67

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.9643    2.6229   0.7733 1.247 0.212

Likelihood ratio test=1.57  on 1 df, p=0.2106
n= 22, number of events= 8 


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

TCGA-COAD PIEZO1 

[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 11        4     3.24     0.176     0.465
strata=LOW  11        2     2.76     0.208     0.465

 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.6142    0.5411   0.9150 -0.671 0.502

Likelihood ratio test=0.46  on 1 df, p=0.4966
n= 22, number of events= 6 


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

TCGA-COAD AKR1C2 

[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 11        2     4.13      1.10      3.68
strata=LOW  11        4     1.87      2.44      3.68

 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.5553    4.7363   0.8838 1.76 0.0785

Likelihood ratio test=3.34  on 1 df, p=0.06776
n= 22, number of events= 6 


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

TCGA-COAD MIR4443 



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

TCGA-COAD SLC16A1-AS1 

[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 11        5     4.11     0.194     0.467
strata=LOW  11        3     3.89     0.204     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.5201    0.5945   0.7694 -0.676 0.499

Likelihood ratio test=0.46  on 1 df, p=0.4962
n= 22, number of events= 8 


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

TCGA-COAD FAR1 

[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 11        2     3.68     0.765      2.28
strata=LOW  11        4     2.32     1.210      2.28

 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.540     4.665    1.121 1.374 0.17

Likelihood ratio test=2.4  on 1 df, p=0.1215
n= 22, number of events= 6 


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

TCGA-COAD CISD2 

[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 11        2     2.66     0.164     0.369
strata=LOW  11        3     2.34     0.187     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.5648    1.7592   0.9399 0.601 0.548

Likelihood ratio test=0.37  on 1 df, p=0.5426
n= 22, number of events= 5 


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

TCGA-COAD MAPK3 

[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 11        3     4.59     0.548      1.64
strata=LOW  11        5     3.41     0.737      1.64

 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.9593    2.6098   0.7753 1.237 0.216

Likelihood ratio test=1.54  on 1 df, p=0.2144
n= 22, number of events= 8 


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

TCGA-COAD CYGB 

[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 11        3     2.04     0.455     0.938
strata=LOW  11        2     2.96     0.313     0.938

 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 -1.0721    0.3423   1.1593 -0.925 0.355

Likelihood ratio test=0.98  on 1 df, p=0.3212
n= 22, number of events= 5 


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

TCGA-COAD MLST8 

[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 11        4     3.71    0.0222    0.0644
strata=LOW  11        3     3.29    0.0251    0.0644

 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.2292    0.7952   0.9050 -0.253 0.8

Likelihood ratio test=0.07  on 1 df, p=0.7983
n= 22, number of events= 7 


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

TCGA-COAD PANX2 

[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 11        3     2.79    0.0153    0.0352
strata=LOW  11        2     2.21    0.0194    0.0352

 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.1724    0.8416   0.9200 -0.187 0.851

Likelihood ratio test=0.04  on 1 df, p=0.8506
n= 22, number of events= 5 


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

TCGA-COAD PEBP1 

[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 11        4     3.94  0.000784    0.0018
strata=LOW  11        4     4.06  0.000762    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.03251   0.96801  0.76547 -0.042 0.966

Likelihood ratio test=0  on 1 df, p=0.9661
n= 22, number of events= 8 


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

TCGA-COAD PARP8 

[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 11        2     4.14      1.11      2.38
strata=LOW  11        6     3.86      1.19      2.38

 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.218     3.380    0.833 1.462 0.144

Likelihood ratio test=2.49  on 1 df, p=0.1149
n= 22, number of events= 8 


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

TCGA-COAD GJA1 

[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 11        2    1.096     0.746      1.65
strata=LOW  11        0    0.904     0.904      1.65

 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 -2.103e+01  7.382e-10  2.863e+04 -0.001 0.999

Likelihood ratio test=2.41  on 1 df, p=0.1207
n= 22, number of events= 2 


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

TCGA-COAD BAP1 

[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 11        1     2.47     0.877      2.31
strata=LOW  11        3     1.53     1.418      2.31

 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.590     4.905    1.158 1.374 0.17

Likelihood ratio test=2.25  on 1 df, p=0.1333
n= 22, number of events= 4 


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

TCGA-COAD MAP3K11 

[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 11        5     5.28    0.0145    0.0438
strata=LOW  11        4     3.72    0.0205    0.0438

 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.1551    1.1678   0.7421 0.209 0.834

Likelihood ratio test=0.04  on 1 df, p=0.8355
n= 22, number of events= 9 


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

TCGA-COAD TTBK2 

[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 11        5     3.46     0.681      1.89
strata=LOW  11        1     2.54     0.930      1.89

 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.4197    0.2418   1.1194 -1.268 0.205

Likelihood ratio test=2.02  on 1 df, p=0.155
n= 22, number of events= 6 


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

TCGA-COAD MIR214 



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

TCGA-COAD PARP15 

[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 11        2      4.3      1.23      5.49
strata=LOW  11        4      1.7      3.11      5.49

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

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

               coef exp(coef)  se(coef)     z     p
strataLOW 2.159e+01 2.385e+09 2.060e+04 0.001 0.999

Likelihood ratio test=6.93  on 1 df, p=0.008469
n= 22, number of events= 6 


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

TCGA-COAD HDDC3 

[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 11        3     4.12     0.303     0.753
strata=LOW  11        5     3.88     0.322     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.6600    1.9348   0.7735 0.853 0.394

Likelihood ratio test=0.74  on 1 df, p=0.3901
n= 22, number of events= 8 


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

TCGA-COAD MIR10A 



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

TCGA-COAD CGAS 

[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 11        2     3.68     0.764      2.04
strata=LOW  11        4     2.32     1.209      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.2005    3.3217   0.8856 1.355 0.175

Likelihood ratio test=1.99  on 1 df, p=0.1587
n= 22, number of events= 6 


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

TCGA-COAD SIRT2 

[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     3.22    0.0154    0.0336
strata=LOW  11        4     3.78    0.0132    0.0336

 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.1501    1.1619   0.8195 0.183 0.855

Likelihood ratio test=0.03  on 1 df, p=0.8547
n= 22, number of events= 7 


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

TCGA-COAD PPARD 

[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 11        2     3.51     0.652      1.59
strata=LOW  11        5     3.49     0.657      1.59

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 1.0480    2.8521   0.8694 1.206 0.228

Likelihood ratio test=1.56  on 1 df, p=0.2111
n= 22, number of events= 7 


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

TCGA-COAD EGR1 

[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 11        3     2.92   0.00211   0.00896
strata=LOW  11        1     1.08   0.00570   0.00896

 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.1162    0.8903   1.2283 -0.095 0.925

Likelihood ratio test=0.01  on 1 df, p=0.9242
n= 22, number of events= 4 


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

TCGA-COAD AQP3 

[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 11        2     3.36     0.551      1.27
strata=LOW  11        4     2.64     0.701      1.27

 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.9484    2.5815   0.8720 1.088 0.277

Likelihood ratio test=1.27  on 1 df, p=0.2601
n= 22, number of events= 6 


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

TCGA-COAD HSF1 

[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 11        2     1.72    0.0448     0.107
strata=LOW  11        1     1.28    0.0604     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.4021    0.6689   1.2356 -0.325 0.745

Likelihood ratio test=0.11  on 1 df, p=0.7402
n= 22, number of events= 3 


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

TCGA-COAD MIR18A 



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

TCGA-COAD OSBPL9 

[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 11        2     2.25    0.0271    0.0463
strata=LOW  11        5     4.75    0.0128    0.0463

 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.1918    1.2114   0.8927 0.215 0.83

Likelihood ratio test=0.05  on 1 df, p=0.8284
n= 22, number of events= 7 


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

TCGA-COAD SESN2 

[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 11        3     3.85     0.186     0.416
strata=LOW  11        5     4.15     0.172     0.416

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.4901    1.6325   0.7671 0.639 0.523

Likelihood ratio test=0.41  on 1 df, p=0.5201
n= 22, number of events= 8 


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

TCGA-COAD BECN1 

[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 11        4      5.7     0.505      1.23
strata=LOW  11        7      5.3     0.543      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.7160    2.0462   0.6584 1.088 0.277

Likelihood ratio test=1.21  on 1 df, p=0.271
n= 22, number of events= 11 


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

TCGA-COAD FTMT 



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

TCGA-COAD HCAR1 

[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 11        4     4.65     0.092     0.305
strata=LOW  11        3     2.35     0.182     0.305

 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.4525    1.5723   0.8253 0.548 0.583

Likelihood ratio test=0.3  on 1 df, p=0.5849
n= 22, number of events= 7 


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

TCGA-COAD HILPDA 

[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 11        5     4.59    0.0371     0.102
strata=LOW  11        3     3.41    0.0499     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.2494    0.7793   0.7815 -0.319 0.75

Likelihood ratio test=0.1  on 1 df, p=0.7487
n= 22, number of events= 8 


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

TCGA-COAD GSTM1 

[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 11        4     3.02     0.316     0.644
strata=LOW  11        3     3.98     0.240     0.644

 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.6855    0.5038   0.8704 -0.788 0.431

Likelihood ratio test=0.66  on 1 df, p=0.4175
n= 22, number of events= 7 


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

TCGA-COAD MIR222 



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

TCGA-COAD RARRES2 

[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 11        3     3.21    0.0136    0.0314
strata=LOW  11        3     2.79    0.0157    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.1501    1.1619   0.8470 0.177 0.859

Likelihood ratio test=0.03  on 1 df, p=0.8594
n= 22, number of events= 6 


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

TCGA-COAD BRD4 

[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 11        6     4.22     0.748      2.15
strata=LOW  11        1     2.78     1.138      2.15

 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.4834    0.2269   1.1019 -1.346 0.178

Likelihood ratio test=2.39  on 1 df, p=0.1222
n= 22, number of events= 7 


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

TCGA-COAD SOCS1 

[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 11        4     3.56    0.0539     0.112
strata=LOW  11        3     3.44    0.0558     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.2571    0.7733   0.7707 -0.334 0.739

Likelihood ratio test=0.11  on 1 df, p=0.7376
n= 22, number of events= 7 


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

TCGA-COAD MIR17 



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

TCGA-COAD GDF15 

[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 11        2     3.46     0.616      2.37
strata=LOW  11        3     1.54     1.385      2.37

 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.667     5.295    1.190 1.401 0.161

Likelihood ratio test=2.34  on 1 df, p=0.1264
n= 22, number of events= 5 


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

TCGA-COAD ARF6 

[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 11        3     5.15      0.90      2.78
strata=LOW  11        5     2.85      1.63      2.78

 Chisq= 2.8  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.3104    3.7076   0.8409 1.558 0.119

Likelihood ratio test=2.75  on 1 df, p=0.09746
n= 22, number of events= 8 


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

TCGA-COAD CDO1 

[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 11        5     3.94     0.283     0.752
strata=LOW  11        2     3.06     0.365     0.752

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.7382    0.4780   0.8702 -0.848 0.396

Likelihood ratio test=0.76  on 1 df, p=0.3819
n= 22, number of events= 7 


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

TCGA-COAD CAMKK2 

[1] 294
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.49    0.0757     0.152
strata=LOW  11        3     3.51    0.0751     0.152

 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.2987    0.7418   0.7677 -0.389 0.697

Likelihood ratio test=0.15  on 1 df, p=0.6957
n= 22, number of events= 7 


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

TCGA-COAD LINC01606 

[1] 295
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.62    0.0557    0.0761
strata=LOW  27        8     8.38    0.0174    0.0761

 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.1911    0.8260   0.6937 -0.276 0.783

Likelihood ratio test=0.07  on 1 df, p=0.7857
n= 38, number of events= 11 


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

TCGA-COAD BACH1 

[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 11        4     2.47     0.955      1.89
strata=LOW  11        3     4.53     0.519      1.89

 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.4171    0.2424   1.1189 -1.266 0.205

Likelihood ratio test=2.02  on 1 df, p=0.1556
n= 22, number of events= 7 


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

TCGA-COAD DPP4 

[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 11        3     4.01     0.254     0.525
strata=LOW  11        5     3.99     0.255     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.5305    1.6999   0.7402 0.717 0.474

Likelihood ratio test=0.53  on 1 df, p=0.4666
n= 22, number of events= 8 


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

TCGA-COAD PPP1R13L 

[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 11        5     4.45    0.0688      0.16
strata=LOW  11        4     4.55    0.0672      0.16

 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.2957    0.7440   0.7422 -0.398 0.69

Likelihood ratio test=0.16  on 1 df, p=0.6873
n= 22, number of events= 9 


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

TCGA-COAD MIR150 



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

TCGA-COAD FLT3 

[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 11        1     2.66     1.037      1.88
strata=LOW  11        6     4.34     0.636      1.88

 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.395     4.033    1.098 1.27 0.204

Likelihood ratio test=2.1  on 1 df, p=0.1472
n= 22, number of events= 7 


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

TCGA-COAD MAP1LC3A 

[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 11        4     2.62     0.725      1.53
strata=LOW  11        2     3.38     0.562      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 -1.2940    0.2742   1.1196 -1.156 0.248

Likelihood ratio test=1.65  on 1 df, p=0.1984
n= 22, number of events= 6 


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

TCGA-COAD A2M-AS1 

[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 11        4     3.14     0.234     0.611
strata=LOW  11        2     2.86     0.258     0.611

 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.7044    0.4944   0.9194 -0.766 0.444

Likelihood ratio test=0.6  on 1 df, p=0.4376
n= 22, number of events= 6 


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

TCGA-COAD PDSS2 

[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        3      3.1   0.00335   0.00608
strata=LOW  11        4      3.9   0.00266   0.00608

 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.0599    1.0617   0.7683 0.078 0.938

Likelihood ratio test=0.01  on 1 df, p=0.9378
n= 22, number of events= 7 


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

TCGA-COAD DNAJB6 

[1] 303
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     2.09      1.75      3.03
strata=LOW  11        1     2.91      1.25      3.03

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.7343    0.1765   1.1220 -1.546 0.122

Likelihood ratio test=3.09  on 1 df, p=0.07876
n= 22, number of events= 5 


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

TCGA-COAD SUV39H1 

[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 11        4     3.48    0.0781     0.218
strata=LOW  11        2     2.52    0.1077     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.4235    0.6548   0.9140 -0.463 0.643

Likelihood ratio test=0.22  on 1 df, p=0.6396
n= 22, number of events= 6 


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

TCGA-COAD LPCAT3 

[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 11        3     2.57    0.0729      0.13
strata=LOW  11        5     5.43    0.0344      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.2967    0.7433   0.8255 -0.359 0.719

Likelihood ratio test=0.13  on 1 df, p=0.7197
n= 22, number of events= 8 


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

TCGA-COAD MIR761 



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

TCGA-COAD CDCA3 

[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 11        2     3.59     0.701      2.05
strata=LOW  11        4     2.41     1.042      2.05

 Chisq= 2.1  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.480     4.395    1.126 1.315 0.188

Likelihood ratio test=2.18  on 1 df, p=0.1399
n= 22, number of events= 6 


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

TCGA-COAD EPAS1 

[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 11        5     4.09     0.203     0.502
strata=LOW  11        3     3.91     0.212     0.502

 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.5930    0.5526   0.8480 -0.699 0.484

Likelihood ratio test=0.52  on 1 df, p=0.4688
n= 22, number of events= 8 


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

TCGA-COAD SLC11A2 

[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 11        4     2.76     0.556      1.26
strata=LOW  11        3     4.24     0.362      1.26

 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 -1.1959    0.3024   1.1254 -1.063 0.288

Likelihood ratio test=1.38  on 1 df, p=0.2407
n= 22, number of events= 7 


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

TCGA-COAD CREB3 

[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 11        3     3.29    0.0260     0.061
strata=LOW  11        3     2.71    0.0317     0.061

 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.2076    1.2308   0.8419 0.247 0.805

Likelihood ratio test=0.06  on 1 df, p=0.8052
n= 22, number of events= 6 


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

TCGA-COAD ATF3 

[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 11        2     3.13     0.408      1.11
strata=LOW  11        3     1.87     0.684      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.9408    2.5619   0.9231 1.019 0.308

Likelihood ratio test=1.07  on 1 df, p=0.3016
n= 22, number of events= 5 


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

TCGA-COAD TGFB1 

[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 11        5     3.12     1.134       2.1
strata=LOW  11        3     4.88     0.725       2.1

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.1630    0.3125   0.8452 -1.376 0.169

Likelihood ratio test=2.12  on 1 df, p=0.1453
n= 22, number of events= 8 


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

TCGA-COAD SMG9 

[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        6     5.77   0.00953    0.0289
strata=LOW  11        4     4.23   0.01298    0.0289

 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.1229    0.8843   0.7232 -0.17 0.865

Likelihood ratio test=0.03  on 1 df, p=0.8651
n= 22, number of events= 10 


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

TCGA-COAD NOX4 

[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 11        5     3.75     0.417      1.06
strata=LOW  11        2     3.25     0.481      1.06

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.8693    0.4192   0.8701 -0.999 0.318

Likelihood ratio test=1.07  on 1 df, p=0.3017
n= 22, number of events= 7 


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

TCGA-COAD MIR27A 



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

TCGA-COAD FOXP1 

[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 11        6     4.32     0.654      1.92
strata=LOW  11        1     2.68     1.054      1.92

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

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

             coef exp(coef) se(coef)     z     p
strataLOW -1.4046    0.2455   1.0978 -1.28 0.201

Likelihood ratio test=2.14  on 1 df, p=0.1435
n= 22, number of events= 7 


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

TCGA-COAD SNCA 

[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 11        4     3.43    0.0954     0.264
strata=LOW  11        2     2.57    0.1271     0.264

 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.4672    0.6268   0.9169 -0.51 0.61

Likelihood ratio test=0.27  on 1 df, p=0.6064
n= 22, number of events= 6 


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

TCGA-COAD ENPP2 

[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        3     2.49    0.1028     0.181
strata=LOW  11        3     3.51    0.0731     0.181

 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.3507    0.7042   0.8288 -0.423 0.672

Likelihood ratio test=0.18  on 1 df, p=0.6728
n= 22, number of events= 6 


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

TCGA-COAD BRD2 

[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        4     1.98     2.069      3.25
strata=LOW  11        3     5.02     0.814      3.25

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

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

             coef exp(coef) se(coef)     z      p
strataLOW -1.4911    0.2251   0.8929 -1.67 0.0949

Likelihood ratio test=3.01  on 1 df, p=0.08259
n= 22, number of events= 7 


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

TCGA-COAD ISCU 

[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 11        3     2.71    0.0302    0.0665
strata=LOW  11        3     3.29    0.0249    0.0665

 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.2359    0.7898   0.9166 -0.257 0.797

Likelihood ratio test=0.07  on 1 df, p=0.7956
n= 22, number of events= 6 


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

TCGA-COAD PHF21A 

[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 11        5     3.68     0.476      1.25
strata=LOW  11        2     3.32     0.527      1.25

 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.9541    0.3851   0.8835 -1.08 0.28

Likelihood ratio test=1.24  on 1 df, p=0.2648
n= 22, number of events= 7 


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

TCGA-COAD PARP6 

[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 11        3     2.87   0.00617    0.0121
strata=LOW  11        3     3.13   0.00565    0.0121

 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.09079   0.91321  0.82603 -0.11 0.912

Likelihood ratio test=0.01  on 1 df, p=0.9125
n= 22, number of events= 6 


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

TCGA-COAD ZEB1 

[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 11        5     4.44    0.0702     0.252
strata=LOW  11        2     2.56    0.1218     0.252

 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.4560    0.6338   0.9167 -0.497 0.619

Likelihood ratio test=0.25  on 1 df, p=0.6151
n= 22, number of events= 7 


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

TCGA-COAD LIG3 

[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 11        3     1.44     1.700      2.72
strata=LOW  11        2     3.56     0.686      2.72

 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.7154    0.1799   1.1646 -1.473 0.141

Likelihood ratio test=2.59  on 1 df, p=0.1072
n= 22, number of events= 5 


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

TCGA-COAD PEDS1 

[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 11        5     4.32     0.109     0.317
strata=LOW  11        2     2.68     0.175     0.317

 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.4838    0.6164   0.8675 -0.558 0.577

Likelihood ratio test=0.33  on 1 df, p=0.5684
n= 22, number of events= 7 


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

TCGA-COAD RPPH1 



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

TCGA-COAD GFRA1 

[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 11        4     2.09      1.74      3.04
strata=LOW  11        1     2.91      1.25      3.04

 Chisq= 3  on 1 degrees of freedom, p= 0.08 

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

            coef exp(coef) se(coef)      z     p
strataLOW -1.737     0.176    1.123 -1.547 0.122

Likelihood ratio test=3.09  on 1 df, p=0.0786
n= 22, number of events= 5 


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

TCGA-COAD AQP8 

[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 11        2     3.98     0.983      2.29
strata=LOW  11        6     4.02     0.973      2.29

 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.1992    3.3175   0.8392 1.429 0.153

Likelihood ratio test=2.3  on 1 df, p=0.1293
n= 22, number of events= 8 


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

TCGA-COAD SIRT1 

[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        2     1.53    0.1448     0.296
strata=LOW  11        2     2.47    0.0896     0.296

 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.6544    0.5198   1.2252 -0.534 0.593

Likelihood ratio test=0.3  on 1 df, p=0.5827
n= 22, number of events= 4 


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

TCGA-COAD MIR15A 



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

TCGA-COAD AKR1C3 

[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 11        3     3.29    0.0256    0.0594
strata=LOW  11        4     3.71    0.0227    0.0594

 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.2253   0.8351 0.243 0.808

Likelihood ratio test=0.06  on 1 df, p=0.808
n= 22, number of events= 7 


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

TCGA-COAD DLD 

[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 11        2     2.86     0.257     0.492
strata=LOW  11        5     4.14     0.177     0.492

 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.5992    1.8207   0.8671 0.691 0.49

Likelihood ratio test=0.5  on 1 df, p=0.4779
n= 22, number of events= 7 


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

TCGA-COAD USP11 

[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 11        4     2.05      1.85       3.2
strata=LOW  11        1     2.95      1.29       3.2

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.7775    0.1691   1.1240 -1.581 0.114

Likelihood ratio test=3.24  on 1 df, p=0.07199
n= 22, number of events= 5 


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

TCGA-COAD SREBF2 

[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 11        5     3.83     0.355     0.791
strata=LOW  11        2     3.17     0.429     0.791

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

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

             coef exp(coef) se(coef)     z     p
strataLOW -0.7311    0.4814   0.8400 -0.87 0.384

Likelihood ratio test=0.83  on 1 df, p=0.3637
n= 22, number of events= 7 


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

TCGA-COAD MIR190A 



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

TCGA-COAD IFNA8 



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

TCGA-COAD KDM6B 

[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 11        4      2.8     0.510     0.997
strata=LOW  11        2      3.2     0.447     0.997

 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.8627    0.4220   0.8874 -0.972 0.331

Likelihood ratio test=1.01  on 1 df, p=0.3147
n= 22, number of events= 6 


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

TCGA-COAD ACOT1 

[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 11        4     3.57    0.0513     0.147
strata=LOW  11        2     2.43    0.0755     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.3484    0.7058   0.9134 -0.381 0.703

Likelihood ratio test=0.15  on 1 df, p=0.7002
n= 22, number of events= 6 


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

TCGA-COAD RELA 

[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 11        4      3.2     0.202     0.378
strata=LOW  11        4      4.8     0.134     0.378

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

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

             coef exp(coef) se(coef)     z     p
strataLOW -0.4702    0.6249   0.7711 -0.61 0.542

Likelihood ratio test=0.38  on 1 df, p=0.5393
n= 22, number of events= 8 


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

TCGA-COAD SLC39A7 

[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 11        3     3.44    0.0570     0.135
strata=LOW  11        3     2.56    0.0767     0.135

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.3008    1.3510   0.8213 0.366 0.714

Likelihood ratio test=0.13  on 1 df, p=0.7146
n= 22, number of events= 6 


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

TCGA-COAD POM121L12 



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

TCGA-COAD MIR101-1 



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

TCGA-COAD GABPB1-AS1 

[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 11        3     3.41    0.0486     0.116
strata=LOW  11        4     3.59    0.0461     0.116

 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.2951    1.3433   0.8699 0.339 0.734

Likelihood ratio test=0.12  on 1 df, p=0.7307
n= 22, number of events= 7 


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

TCGA-COAD EGFR 

[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 11        4     3.19     0.203     0.438
strata=LOW  11        2     2.81     0.231     0.438

 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.5678    0.5668   0.8691 -0.653 0.514

Likelihood ratio test=0.45  on 1 df, p=0.5028
n= 22, number of events= 6 


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

TCGA-COAD BRD7 

[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 11        3     2.45     0.126     0.249
strata=LOW  11        2     2.55     0.120     0.249

 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.4542    0.6349   0.9181 -0.495 0.621

Likelihood ratio test=0.25  on 1 df, p=0.617
n= 22, number of events= 5 


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

TCGA-COAD MIR1287 



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

TCGA-COAD MIR23A 



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

TCGA-COAD LCE2C 



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

TCGA-COAD ADAMTS13 

[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 11        2     1.62    0.0909     0.159
strata=LOW  11        2     2.38    0.0617     0.159

 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.4045    0.6673   1.0219 -0.396 0.692

Likelihood ratio test=0.16  on 1 df, p=0.6929
n= 22, number of events= 4 


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

TCGA-COAD SIRT3 

[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 11        3     2.47    0.1153     0.228
strata=LOW  11        3     3.53    0.0805     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.4324    0.6489   0.9132 -0.474 0.636

Likelihood ratio test=0.23  on 1 df, p=0.6322
n= 22, number of events= 6 


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

TCGA-COAD CIRBP 

[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 11        3     2.31     0.208      0.39
strata=LOW  11        3     3.69     0.130      0.39

 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.5650    0.5684   0.9169 -0.616 0.538

Likelihood ratio test=0.39  on 1 df, p=0.5327
n= 22, number of events= 6 


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

TCGA-COAD BRDT 



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

TCGA-COAD KIF4A 

[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 11        3     3.01  2.25e-05  4.52e-05
strata=LOW  11        3     2.99  2.26e-05  4.52e-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.005498  1.005513 0.817625 0.007 0.995

Likelihood ratio test=0  on 1 df, p=0.9946
n= 22, number of events= 6 


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

TCGA-COAD CPEB1 

[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 11        6     4.93     0.231     0.767
strata=LOW  11        2     3.07     0.371     0.767

 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.7449    0.4748   0.8700 -0.856 0.392

Likelihood ratio test=0.78  on 1 df, p=0.3774
n= 22, number of events= 8 


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

TCGA-COAD LINC01833 

[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 11        2     1.88   0.00793    0.0131
strata=LOW  14        3     3.12   0.00477    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.1058    0.8996   0.9261 -0.114 0.909

Likelihood ratio test=0.01  on 1 df, p=0.9094
n= 25, number of events= 5 


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

TCGA-COAD MAPKAP1 

[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 11        3     1.97     0.541      1.07
strata=LOW  11        1     2.03     0.524      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.1385    0.3203   1.1581 -0.983 0.326

Likelihood ratio test=1.12  on 1 df, p=0.2901
n= 22, number of events= 4 


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

TCGA-COAD ATF4 

[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 11        3     2.83   0.01051      0.02
strata=LOW  11        3     3.17   0.00937      0.02

 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.1155    0.8909   0.8180 -0.141 0.888

Likelihood ratio test=0.02  on 1 df, p=0.8878
n= 22, number of events= 6 


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

TCGA-COAD SLC7A11 

[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 11        5     4.33     0.104     0.259
strata=LOW  11        3     3.67     0.122     0.259

 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.3871    0.6790   0.7657 -0.506 0.613

Likelihood ratio test=0.26  on 1 df, p=0.611
n= 22, number of events= 8 


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

TCGA-COAD EMC2 

[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 11        2     2.46    0.0852     0.168
strata=LOW  11        4     3.54    0.0591     0.168

 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.3725    1.4513   0.9140 0.408 0.684

Likelihood ratio test=0.17  on 1 df, p=0.6807
n= 22, number of events= 6 


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

TCGA-COAD WWTR1 

[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 11        5     4.39    0.0859     0.303
strata=LOW  11        2     2.61    0.1441     0.303

 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.4989    0.6072   0.9150 -0.545 0.586

Likelihood ratio test=0.3  on 1 df, p=0.5812
n= 22, number of events= 7 


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

TCGA-COAD HSPA5 

[1] 349
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.14     0.236     0.606
strata=LOW  11        2     2.86     0.259     0.606

 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.6977    0.4978   0.9141 -0.763 0.445

Likelihood ratio test=0.6  on 1 df, p=0.4393
n= 22, number of events= 6 


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

TCGA-COAD BEX1 

[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 11        5     4.47    0.0634     0.163
strata=LOW  11        3     3.53    0.0802     0.163

 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.3084    0.7346   0.7667 -0.402 0.687

Likelihood ratio test=0.16  on 1 df, p=0.6859
n= 22, number of events= 8 


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

TCGA-COAD PML 

[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 11        6     2.69      4.07      6.75
strata=LOW  11        1     4.31      2.54      6.75

 Chisq= 6.8  on 1 degrees of freedom, p= 0.009 

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

              coef exp(coef) se(coef)      z      p
strataLOW -2.30627   0.09963  1.08628 -2.123 0.0337

Likelihood ratio test=6.85  on 1 df, p=0.008882
n= 22, number of events= 7 


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

TCGA-COAD MIR142 



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

TCGA-COAD AEBP2 

[1] 352
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     1.31      2.17      3.89
strata=LOW  11        1     2.69      1.06      3.89

 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 -2.151e+01  4.565e-10  2.360e+04 -0.001 0.999

Likelihood ratio test=4.99  on 1 df, p=0.02547
n= 22, number of events= 4 


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

TCGA-COAD GPAT4 

[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 11        5     4.01     0.245      0.82
strata=LOW  11        1     1.99     0.493      0.82

 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.9743    0.3775   1.1187 -0.871 0.384

Likelihood ratio test=0.9  on 1 df, p=0.3426
n= 22, number of events= 6 


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

TCGA-COAD CA9 

[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 11        5     2.76      1.83      3.39
strata=LOW  11        1     3.24      1.55      3.39

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.7801    0.1686   1.0971 -1.622 0.105

Likelihood ratio test=3.62  on 1 df, p=0.05713
n= 22, number of events= 6 


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

TCGA-COAD STK11 

[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 11        6     5.72    0.0133    0.0373
strata=LOW  11        3     3.28    0.0232    0.0373

 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.7155 -0.193 0.847

Likelihood ratio test=0.04  on 1 df, p=0.8459
n= 22, number of events= 9 


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

TCGA-COAD TBK1 

[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 11        2        2  8.70e-06  1.76e-05
strata=LOW  11        3        3  5.78e-06  1.76e-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.00423   0.99578  1.00760 -0.004 0.997

Likelihood ratio test=0  on 1 df, p=0.9967
n= 22, number of events= 5 


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

TCGA-COAD CDKN2A 

[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 11        1     1.34    0.0861     0.156
strata=LOW  11        2     1.66    0.0695     0.156

 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.479     1.615    1.225 0.391 0.696

Likelihood ratio test=0.16  on 1 df, p=0.6893
n= 22, number of events= 3 


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

TCGA-COAD DCAF7 

[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        3      2.5       0.1     0.281
strata=LOW  11        2      2.5       0.1     0.281

 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.5394    0.5831   1.0291 -0.524 0.6

Likelihood ratio test=0.27  on 1 df, p=0.6016
n= 22, number of events= 5 


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

TCGA-COAD MTF1 

[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 11        3      3.1   0.00353    0.0111
strata=LOW  11        2      1.9   0.00579    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.1061    1.1119   1.0059 0.105 0.916

Likelihood ratio test=0.01  on 1 df, p=0.916
n= 22, number of events= 5 


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

TCGA-COAD MEG8 

[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 11        5     3.93     0.291     0.635
strata=LOW  11        4     5.07     0.225     0.635

 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.5667    0.5674   0.7197 -0.787 0.431

Likelihood ratio test=0.61  on 1 df, p=0.4337
n= 22, number of events= 9 


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

TCGA-COAD CLTRN 

[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 11        2     1.83   0.01563    0.0249
strata=LOW  11        4     4.17   0.00687    0.0249

 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.1448    0.8652   0.9178 -0.158 0.875

Likelihood ratio test=0.02  on 1 df, p=0.8753
n= 22, number of events= 6 


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

TCGA-COAD PARP11 

[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 11        6     3.94     1.082         2
strata=LOW  11        3     5.06     0.841         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 -0.9798    0.3754   0.7178 -1.365 0.172

Likelihood ratio test=1.99  on 1 df, p=0.1582
n= 22, number of events= 9 


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

TCGA-COAD GABARAPL2 

[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 11        2     3.04     0.354     0.717
strata=LOW  11        5     3.96     0.271     0.717

 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.7186    2.0515   0.8667 0.829 0.407

Likelihood ratio test=0.73  on 1 df, p=0.3928
n= 22, number of events= 7 


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

TCGA-COAD CDKN1A 

[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 11        2     3.89     0.922      2.19
strata=LOW  11        6     4.11     0.874      2.19

 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.1985    3.3151   0.8526 1.406 0.16

Likelihood ratio test=2.21  on 1 df, p=0.1375
n= 22, number of events= 8 


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

TCGA-COAD NEDD4L 

[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 11        2     2.68     0.174     0.327
strata=LOW  11        4     3.32     0.141     0.327

 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.4985    1.6463   0.8797 0.567 0.571

Likelihood ratio test=0.34  on 1 df, p=0.5627
n= 22, number of events= 6 


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

TCGA-COAD AR 

[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 11        5     3.24      0.96      2.53
strata=LOW  11        1     2.76      1.12      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.6061    0.2007   1.1203 -1.434 0.152

Likelihood ratio test=2.63  on 1 df, p=0.1048
n= 22, number of events= 6 


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

TCGA-COAD MIR20A 



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

TCGA-COAD HMOX1 

[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 11        3     4.43     0.460       1.3
strata=LOW  11        6     4.57     0.445       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.8621    2.3682   0.7781 1.108 0.268

Likelihood ratio test=1.24  on 1 df, p=0.2654
n= 22, number of events= 9 


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

TCGA-COAD ZFP36 

[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 11        3     2.13     0.356     0.806
strata=LOW  11        1     1.87     0.405     0.806

 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.0266    0.3582   1.1856 -0.866 0.387

Likelihood ratio test=0.85  on 1 df, p=0.3558
n= 22, number of events= 4 


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

TCGA-COAD MIR744 



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

TCGA-COAD CTSB 

[1] 369
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.3     0.147     0.279
strata=LOW  11        4      4.7     0.103     0.279

 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.4011    0.6696   0.7644 -0.525 0.6

Likelihood ratio test=0.28  on 1 df, p=0.5975
n= 22, number of events= 8 


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

TCGA-COAD AGPS 

[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 11        4     2.78     0.540     0.902
strata=LOW  11        3     4.22     0.355     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.7135    0.4899   0.7670 -0.93 0.352

Likelihood ratio test=0.88  on 1 df, p=0.3491
n= 22, number of events= 7 


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

TCGA-COAD MT1DP 

[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 11        5     6.12     0.205     0.537
strata=LOW  11        6     4.88     0.257     0.537

 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.4635    1.5896   0.6380 0.727 0.468

Likelihood ratio test=0.52  on 1 df, p=0.4694
n= 22, number of events= 11 


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

TCGA-COAD SNX4 

[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 11        2     3.51     0.651      1.31
strata=LOW  11        6     4.49     0.509      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.9248    2.5214   0.8373 1.105 0.269

Likelihood ratio test=1.35  on 1 df, p=0.245
n= 22, number of events= 8 


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

TCGA-COAD NR4A1 

[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 11        3     3.17   0.00890    0.0189
strata=LOW  11        3     2.83   0.00995    0.0189

 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.1126    1.1192   0.8186 0.138 0.891

Likelihood ratio test=0.02  on 1 df, p=0.8906
n= 22, number of events= 6 


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

TCGA-COAD MFN2 

[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 11        7     5.64     0.326     0.828
strata=LOW  11        3     4.36     0.423     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.6365    0.5291   0.7108 -0.895 0.371

Likelihood ratio test=0.85  on 1 df, p=0.3574
n= 22, number of events= 10 


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

TCGA-COAD SELENOI 

[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 11        3     2.67    0.0404     0.147
strata=LOW  11        1     1.33    0.0813     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.4668    0.6270   1.2288 -0.38 0.704

Likelihood ratio test=0.15  on 1 df, p=0.6978
n= 22, number of events= 4 


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

TCGA-COAD AGAP2-AS1 

[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 11        5     3.72     0.439      1.41
strata=LOW  11        1     2.28     0.718      1.41

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -1.2689    0.2811   1.1348 -1.118 0.263

Likelihood ratio test=1.52  on 1 df, p=0.2181
n= 22, number of events= 6 


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

TCGA-COAD TRIM46 

[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 11        5     4.53    0.0489      0.12
strata=LOW  11        4     4.47    0.0496      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.2529    0.7765   0.7303 -0.346 0.729

Likelihood ratio test=0.12  on 1 df, p=0.7297
n= 22, number of events= 9 


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

TCGA-COAD CYB5R1 

[1] 378
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.41     0.143     0.279
strata=LOW  11        2     2.59     0.133     0.279

 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.4791    0.6193   0.9161 -0.523 0.601

Likelihood ratio test=0.28  on 1 df, p=0.5969
n= 22, number of events= 5 


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

TCGA-COAD PARK7 

[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 11        3      2.3     0.211     0.392
strata=LOW  11        2      2.7     0.180     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 -0.5646    0.5686   0.9140 -0.618 0.537

Likelihood ratio test=0.39  on 1 df, p=0.5317
n= 22, number of events= 5 


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

TCGA-COAD CARS1 

[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 11        4     2.64     0.698      1.93
strata=LOW  11        1     2.36     0.782      1.93

 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.4772    0.2283   1.1596 -1.274 0.203

Likelihood ratio test=1.92  on 1 df, p=0.1654
n= 22, number of events= 5 


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

TCGA-COAD NOX1 

[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 11        4     4.55    0.0669     0.221
strata=LOW  11        3     2.45    0.1243     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.3926    1.4809   0.8402 0.467 0.64

Likelihood ratio test=0.22  on 1 df, p=0.6409
n= 22, number of events= 7 


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

TCGA-COAD VDR 

[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 11        4     4.62    0.0831     0.199
strata=LOW  11        4     3.38    0.1135     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.3165    1.3722   0.7119 0.445 0.657

Likelihood ratio test=0.2  on 1 df, p=0.6573
n= 22, number of events= 8 


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

TCGA-COAD PROK2 

[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 11        4     3.15     0.232     0.515
strata=LOW  11        3     3.85     0.190     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.6294    0.5329   0.8891 -0.708 0.479

Likelihood ratio test=0.53  on 1 df, p=0.4675
n= 22, number of events= 7 


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

TCGA-COAD FABP4 

[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 11        4      3.3     0.148       0.4
strata=LOW  11        2      2.7     0.181       0.4

 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.5750    0.5627   0.9206 -0.625 0.532

Likelihood ratio test=0.4  on 1 df, p=0.5273
n= 22, number of events= 6 


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

TCGA-COAD ABCB10 

[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 11        2     1.81   0.02054     0.038
strata=LOW  11        4     4.19   0.00885     0.038

 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.1958    0.8222   1.0065 -0.195 0.846

Likelihood ratio test=0.04  on 1 df, p=0.8459
n= 22, number of events= 6 


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

TCGA-COAD CP 

[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 11        5     3.48     0.669      1.62
strata=LOW  11        2     3.52     0.660      1.62

 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.0579    0.3472   0.8702 -1.216 0.224

Likelihood ratio test=1.59  on 1 df, p=0.2073
n= 22, number of events= 7 


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

TCGA-COAD MIR4735 



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

TCGA-COAD MIR130A 



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

TCGA-COAD TUG1 

[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 11        5      3.2      1.01      2.65
strata=LOW  11        1      2.8      1.16      2.65

 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.6373    0.1945   1.1203 -1.462 0.144

Likelihood ratio test=2.74  on 1 df, p=0.09771
n= 22, number of events= 6 


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

TCGA-COAD MIR9-3HG 

[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 11        3     3.04  0.000433  0.000768
strata=LOW  11        5     4.96  0.000265  0.000768

 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.02121   1.02144  0.76564 0.028 0.978

Likelihood ratio test=0  on 1 df, p=0.9779
n= 22, number of events= 8 


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

TCGA-COAD MIR196C 



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

TCGA-COAD IFNA21 



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

TCGA-COAD RP11-274B21.9 

[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 11        4     3.32    0.1401     0.245
strata=LOW  11        4     4.68    0.0993     0.245

 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.3520    0.7033   0.7152 -0.492 0.623

Likelihood ratio test=0.24  on 1 df, p=0.6234
n= 22, number of events= 8 


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

TCGA-COAD PVT1 

[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 11        4     4.97     0.190     0.808
strata=LOW  11        3     2.03     0.465     0.808

 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.8147    2.2584   0.9293 0.877 0.381

Likelihood ratio test=0.79  on 1 df, p=0.374
n= 22, number of events= 7 


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

TCGA-COAD MIR539 



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

TCGA-COAD IFNA2 



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

TCGA-COAD TFRC 

[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 11        3     2.37     0.166     0.326
strata=LOW  11        3     3.63     0.108     0.326

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

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

             coef exp(coef) se(coef)      z     p
strataLOW -0.5240    0.5922   0.9277 -0.565 0.572

Likelihood ratio test=0.33  on 1 df, p=0.5678
n= 22, number of events= 6 


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

TCGA-COAD ALOX15B 

[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 11        1     2.67     1.043      1.98
strata=LOW  11        6     4.33     0.642      1.98

 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.454     4.280    1.116 1.303 0.193

Likelihood ratio test=2.2  on 1 df, p=0.1378
n= 22, number of events= 7 


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

TCGA-COAD MPC1 

[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 11        2      3.8     0.855       2.4
strata=LOW  11        4      2.2     1.480       2.4

 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.2752    3.5793   0.8759 1.456 0.145

Likelihood ratio test=2.28  on 1 df, p=0.1307
n= 22, number of events= 6 


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

TCGA-COAD MTCH1 

[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 11        4     3.17     0.218     0.465
strata=LOW  11        3     3.83     0.180     0.465

 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.5840    0.5576   0.8684 -0.673 0.501

Likelihood ratio test=0.48  on 1 df, p=0.4901
n= 22, number of events= 7 


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

TCGA-COAD MIR324 



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

TCGA-COAD SNHG14 

[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 11        6     4.09     0.890      2.22
strata=LOW  11        2     3.91     0.932      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.1995    0.3013   0.8501 -1.411 0.158

Likelihood ratio test=2.22  on 1 df, p=0.1358
n= 22, number of events= 8 


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

TCGA-COAD PDK4 

[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 11        2     1.28     0.402     0.612
strata=LOW  11        3     3.72     0.139     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 -0.7804    0.4582   1.0202 -0.765 0.444

Likelihood ratio test=0.57  on 1 df, p=0.4493
n= 22, number of events= 5 


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

TCGA-COAD DUOX1 

[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 11        5     4.64    0.0283    0.0678
strata=LOW  11        4     4.36    0.0301    0.0678

 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.1862    0.8301   0.7161 -0.26 0.795

Likelihood ratio test=0.07  on 1 df, p=0.795
n= 22, number of events= 9 


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

TCGA-COAD LINC00886 

[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 11        1     2.82      1.18      2.23
strata=LOW  11        5     3.18      1.05      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 1.494     4.454    1.096 1.363 0.173

Likelihood ratio test=2.46  on 1 df, p=0.1166
n= 22, number of events= 6 


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

TCGA-COAD NF2 

[1] 399
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        8     5.91     0.742      2.35
strata=LOW  11        1     3.09     1.417      2.35

 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.5039    0.2223   1.0733 -1.401 0.161

Likelihood ratio test=2.76  on 1 df, p=0.09684
n= 22, number of events= 9 


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

TCGA-COAD MIR149 



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

TCGA-COAD CYP4F8 

[1] 400
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        5  1.88e-06  4.26e-06
strata=LOW  11        4        4  2.35e-06  4.26e-06

 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.001389  0.998612  0.673190 -0.002 0.998

Likelihood ratio test=0  on 1 df, p=0.9984
n= 22, number of events= 9 


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

TCGA-COAD AKR1C1 

[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 11        4      3.2     0.200     0.529
strata=LOW  11        2      2.8     0.229     0.529

 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.6587    0.5175   0.9209 -0.715 0.474

Likelihood ratio test=0.53  on 1 df, p=0.4687
n= 22, number of events= 6 


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

TCGA-COAD PRKCA 

[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 11        4     1.94      2.18      3.72
strata=LOW  11        1     3.06      1.38      3.72

 Chisq= 3.7  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.9272    0.1455   1.1391 -1.692 0.0907

Likelihood ratio test=3.72  on 1 df, p=0.05392
n= 22, number of events= 5 


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

TCGA-COAD CD44 

[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 11        4     3.72    0.0215     0.054
strata=LOW  11        3     3.28    0.0243     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.1900    0.8270   0.8186 -0.232 0.816

Likelihood ratio test=0.05  on 1 df, p=0.8166
n= 22, number of events= 7 


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

TCGA-COAD FBXW7 

[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 11        3     2.93   0.00160   0.00279
strata=LOW  11        4     4.07   0.00115   0.00279

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

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

              coef exp(coef) se(coef)      z     p
strataLOW -0.04058   0.96023  0.76876 -0.053 0.958

Likelihood ratio test=0  on 1 df, p=0.9579
n= 22, number of events= 7 


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

TCGA-COAD YAP1 

[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 11        4     3.32     0.139     0.375
strata=LOW  11        2     2.68     0.172     0.375

 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.5553    0.5739   0.9183 -0.605 0.545

Likelihood ratio test=0.37  on 1 df, p=0.5406
n= 22, number of events= 6 


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

TCGA-COAD MTOR 

[1] 406
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.27     0.235     0.732
strata=LOW  11        1     1.73     0.308     0.732

 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 -1.008     0.365    1.228 -0.821 0.412

Likelihood ratio test=0.72  on 1 df, p=0.3945
n= 22, number of events= 4 


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

TCGA-COAD RICTOR 

[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 11        4     3.62    0.0408     0.103
strata=LOW  11        3     3.38    0.0436     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.2664    0.7661   0.8313 -0.321 0.749

Likelihood ratio test=0.1  on 1 df, p=0.7488
n= 22, number of events= 7 


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

TCGA-COAD WIPI2 

[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 11        4     2.57     0.799      1.64
strata=LOW  11        2     3.43     0.598      1.64

 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.3333    0.2636   1.1184 -1.192 0.233

Likelihood ratio test=1.77  on 1 df, p=0.1834
n= 22, number of events= 6 


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

TCGA-COAD IREB2 

[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 11        3     2.97  0.000234  0.000408
strata=LOW  11        5     5.03  0.000138  0.000408

 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.01545   0.98467  0.76516 -0.02 0.984

Likelihood ratio test=0  on 1 df, p=0.9839
n= 22, number of events= 8 


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

TCGA-COAD GOT1 

[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 11        3     4.08     0.284     0.691
strata=LOW  11        4     2.92     0.396     0.691

 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.6303    1.8782   0.7704 0.818 0.413

Likelihood ratio test=0.68  on 1 df, p=0.41
n= 22, number of events= 7 


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

TCGA-COAD CD82 

[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 11        2    0.967      1.10      2.14
strata=LOW  11        0    1.033      1.03      2.14

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

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

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.127e+01  5.763e-10  2.846e+04 -0.001 0.999

Likelihood ratio test=2.91  on 1 df, p=0.088
n= 22, number of events= 2 


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

TCGA-COAD MAPK9 

[1] 412
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.25    0.2476     0.369
strata=LOW  11        5     5.75    0.0971     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.4621    0.6300   0.7678 -0.602 0.547

Likelihood ratio test=0.35  on 1 df, p=0.5532
n= 22, number of events= 8 


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

TCGA-COAD LGMN 

[1] 413
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     1.75     0.324     0.588
strata=LOW  11        4     3.25     0.175     0.588

 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.8639    2.3724   1.1612 0.744 0.457

Likelihood ratio test=0.62  on 1 df, p=0.4299
n= 22, number of events= 5 


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

TCGA-COAD PARP2 

[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 11        3     2.28     0.228     0.371
strata=LOW  11        3     3.72     0.140     0.371

 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.4951    0.6095   0.8205 -0.603 0.546

Likelihood ratio test=0.36  on 1 df, p=0.5482
n= 22, number of events= 6 


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

TCGA-COAD MIR16-1 



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

TCGA-COAD ATG4D 

[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 11        3     5.05     0.835      3.39
strata=LOW  11        4     1.95     2.171      3.39

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

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

            coef exp(coef) se(coef)     z      p
strataLOW 1.5103    4.5283   0.8871 1.702 0.0887

Likelihood ratio test=3.11  on 1 df, p=0.07759
n= 22, number of events= 7 


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

TCGA-COAD RBMS1 

[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 11        6     3.84     1.217       2.6
strata=LOW  11        3     5.16     0.905       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.1306    0.3228   0.7369 -1.534 0.125

Likelihood ratio test=2.45  on 1 df, p=0.1173
n= 22, number of events= 9 


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

TCGA-COAD GSTZ1 

[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 11        3     2.94  0.001172   0.00234
strata=LOW  11        4     4.06  0.000849   0.00234

 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.03989   0.96089  0.82424 -0.048 0.961

Likelihood ratio test=0  on 1 df, p=0.9614
n= 22, number of events= 7 


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

TCGA-COAD SRSF9 

[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 11        4     3.53    0.0635     0.131
strata=LOW  11        4     4.47    0.0500     0.131

 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.2786    0.7569   0.7727 -0.361 0.718

Likelihood ratio test=0.13  on 1 df, p=0.7171
n= 22, number of events= 8 


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

TCGA-COAD HIF1A 

[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 11        4     2.68     0.648      1.07
strata=LOW  11        3     4.32     0.402      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.7796    0.4586   0.7719 -1.01 0.312

Likelihood ratio test=1.03  on 1 df, p=0.3094
n= 22, number of events= 7 


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

TCGA-COAD FNDC3B 

[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 11        4     4.26    0.0162     0.041
strata=LOW  11        4     3.74    0.0185     0.041

 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.1570    1.1700   0.7762 0.202 0.84

Likelihood ratio test=0.04  on 1 df, p=0.8392
n= 22, number of events= 8 


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

TCGA-COAD RHEBP1 



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

TCGA-COAD PSEN1 

[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 11        4     4.63    0.0858     0.211
strata=LOW  11        5     4.37    0.0909     0.211

 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.3293    1.3901   0.7199 0.458 0.647

Likelihood ratio test=0.21  on 1 df, p=0.648
n= 22, number of events= 9 


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

TCGA-COAD ADIPOQ 

[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 11        4     5.46     0.393      1.37
strata=LOW  11        4     2.54     0.846      1.37

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

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

            coef exp(coef) se(coef)     z     p
strataLOW 0.8804    2.4118   0.7759 1.135 0.257

Likelihood ratio test=1.3  on 1 df, p=0.254
n= 22, number of events= 8 


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

TCGA-COAD MUC1 

[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 11        5     5.43    0.0335     0.097
strata=LOW  11        4     3.57    0.0509     0.097

 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.226     1.254    0.727 0.311 0.756

Likelihood ratio test=0.1  on 1 df, p=0.756
n= 22, number of events= 9 


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

TCGA-COAD CAV1 

[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     4.62    0.0320      0.12
strata=LOW  11        2     2.38    0.0619      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.3164    0.7288   0.9181 -0.345 0.73

Likelihood ratio test=0.12  on 1 df, p=0.7282
n= 22, number of events= 7 


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

TCGA-COAD SEC24B 

[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 11        5     4.29     0.119     0.272
strata=LOW  11        4     4.71     0.108     0.272

 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.3727    0.6889   0.7191 -0.518 0.604

Likelihood ratio test=0.27  on 1 df, p=0.6049
n= 22, number of events= 9 


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

TCGA-COAD PRDX6 

[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 11        3     3.96     0.232     0.472
strata=LOW  11        5     4.04     0.228     0.472

 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.5027    1.6532   0.7388 0.68 0.496

Likelihood ratio test=0.48  on 1 df, p=0.4897
n= 22, number of events= 8 


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

TCGA-COAD TMEM161B-DT 

[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 11        3     3.37    0.0398     0.112
strata=LOW  11        3     2.63    0.0508     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.3108    1.3645   0.9326 0.333 0.739

Likelihood ratio test=0.11  on 1 df, p=0.7368
n= 22, number of events= 6 


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

TCGA-COAD PGD 

[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 11        4     4.42    0.0392     0.119
strata=LOW  11        3     2.58    0.0669     0.119

 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.2815    1.3252   0.8203 0.343 0.731

Likelihood ratio test=0.12  on 1 df, p=0.7318
n= 22, number of events= 7 


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

TCGA-COAD RHOT1 

[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 11        2     1.74    0.0389    0.0691
strata=LOW  11        2     2.26    0.0300    0.0691

 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.2625    0.7691   1.0014 -0.262 0.793

Likelihood ratio test=0.07  on 1 df, p=0.7935
n= 22, number of events= 4 


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

TCGA-COAD ACSL1 

[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 11        5     4.55    0.0451     0.121
strata=LOW  11        3     3.45    0.0594     0.121

 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.2691    0.7641   0.7751 -0.347 0.729

Likelihood ratio test=0.12  on 1 df, p=0.7274
n= 22, number of events= 8 


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

TCGA-COAD NEDD4 

[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 11        3     2.47    0.1137     0.195
strata=LOW  11        3     3.53    0.0795     0.195

 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.3613    0.6968   0.8214 -0.44 0.66

Likelihood ratio test=0.19  on 1 df, p=0.6609
n= 22, number of events= 6 


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

TCGA-COAD ELOVL5 

[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 11        5     4.06     0.219     0.523
strata=LOW  11        3     3.94     0.226     0.523

 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.5487    0.5777   0.7682 -0.714 0.475

Likelihood ratio test=0.52  on 1 df, p=0.4721
n= 22, number of events= 8 


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

TCGA-COAD YY1AP1 

[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 11        3     2.79    0.0153    0.0288
strata=LOW  11        3     3.21    0.0134    0.0288

 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.8706   0.8176 -0.169 0.865

Likelihood ratio test=0.03  on 1 df, p=0.8655
n= 22, number of events= 6 


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

Display the results only for genes where a significant difference in survival has been reported.

significant_genes
 [1] "PANX1"     "CCDC6"     "LINC00551" "MIB1"      "PIK3CA"    "GALNT14"   "MEF2C"     "PARP15"    "PML"       "AEBP2"    
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)
    
    fit <- compute_surival_fit(gene_df)
    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 PANX1 
Warning: Loglik converged before variable  1 ; coefficient may be infinite. 
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        6     3.32      2.16      5.79
strata=LOW  11        0     2.68      2.68      5.79

 Chisq= 5.8  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 -2.137e+01  5.262e-10  1.808e+04 -0.001 0.999

Likelihood ratio test=7.69  on 1 df, p=0.005547
n= 22, number of events= 6 


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

TCGA-COAD CCDC6 

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     2.93      1.46      4.31
strata=LOW  11        0     2.07      2.07      4.31

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

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

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.129e+01  5.675e-10  2.016e+04 -0.001 0.999

Likelihood ratio test=5.85  on 1 df, p=0.01555
n= 22, number of events= 5 


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

TCGA-COAD LINC00551 

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        6     3.36      2.08      4.03
strata=LOW  11        1     3.64      1.92      4.03

 Chisq= 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.8886    0.1513   1.0832 -1.743 0.0812

Likelihood ratio test=4.42  on 1 df, p=0.03555
n= 22, number of events= 7 


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

TCGA-COAD MIB1 

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     2.73      1.88      5.25
strata=LOW  11        0     2.27      2.27      5.25

 Chisq= 5.2  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 -2.151e+01  4.555e-10  2.043e+04 -0.001 0.999

Likelihood ratio test=6.7  on 1 df, p=0.009615
n= 22, number of events= 5 


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

TCGA-COAD PIK3CA 

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        6     3.26      2.29      6.11
strata=LOW  11        0     2.74      2.74      6.11

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

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

                coef  exp(coef)   se(coef)      z     p
strataLOW -2.144e+01  4.891e-10  1.818e+04 -0.001 0.999

Likelihood ratio test=7.99  on 1 df, p=0.004707
n= 22, number of events= 6 


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

TCGA-COAD GALNT14 

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     2.07      4.17      6.76
strata=LOW  11        1     3.93      2.19      6.76

 Chisq= 6.8  on 1 degrees of freedom, p= 0.009 

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

              coef exp(coef) se(coef)      z      p
strataLOW -2.45008   0.08629  1.13638 -2.156 0.0311

Likelihood ratio test=6.61  on 1 df, p=0.01013
n= 22, number of events= 6 


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

TCGA-COAD MEF2C 

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     1.28     2.294      4.03
strata=LOW  11        2     3.72     0.793      4.03

 Chisq= 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 -2.155e+01  4.392e-10  2.368e+04 -0.001 0.999

Likelihood ratio test=5.11  on 1 df, p=0.02375
n= 22, number of events= 5 


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

TCGA-COAD PARP15 

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      4.3      1.23      5.49
strata=LOW  11        4      1.7      3.11      5.49

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

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

               coef exp(coef)  se(coef)     z     p
strataLOW 2.159e+01 2.385e+09 2.060e+04 0.001 0.999

Likelihood ratio test=6.93  on 1 df, p=0.008469
n= 22, number of events= 6 


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

TCGA-COAD PML 

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        6     2.69      4.07      6.75
strata=LOW  11        1     4.31      2.54      6.75

 Chisq= 6.8  on 1 degrees of freedom, p= 0.009 

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

              coef exp(coef) se(coef)      z      p
strataLOW -2.30627   0.09963  1.08628 -2.123 0.0337

Likelihood ratio test=6.85  on 1 df, p=0.008882
n= 22, number of events= 7 


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

TCGA-COAD AEBP2 

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     1.31      2.17      3.89
strata=LOW  11        1     2.69      1.06      3.89

 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 -2.151e+01  4.565e-10  2.360e+04 -0.001 0.999

Likelihood ratio test=4.99  on 1 df, p=0.02547
n= 22, number of events= 4 


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


  1. De La Salle University, Manila, Philippines, ↩︎

  2. De La Salle University, Manila, Philippines, ↩︎

LS0tDQp0aXRsZTogIlN1cnZpdmFsIEFuYWx5c2lzIg0Kc3VidGl0bGU6ICJDb2xvcmVjdGFsIENhbmNlciB8IEZlcnJvcHRvc2lzIHwgVW5pcXVlIEdlbmVzIHBlciBSQ0QgVHlwZSB8IEdlbmUgRXhwcmVzc2lvbiBvZiBOb3JtYWwgU2FtcGxlcyINCmF1dGhvcjogDQogIC0gTWFyayBFZHdhcmQgTS4gR29uemFsZXNeW0RlIExhIFNhbGxlIFVuaXZlcnNpdHksIE1hbmlsYSwgUGhpbGlwcGluZXMsIGdvbnphbGVzLm1hcmtlZHdhcmRAZ21haWwuY29tXQ0KICAtIERyLiBBbmlzaCBNLlMuIFNocmVzdGhhXltEZSBMYSBTYWxsZSBVbml2ZXJzaXR5LCBNYW5pbGEsIFBoaWxpcHBpbmVzLCBhbmlzaC5zaHJlc3RoYUBkbHN1LmVkdS5waF0NCm91dHB1dDogaHRtbF9ub3RlYm9vaw0KLS0tDQoNCiMjIEkuIFByZWxpbWluYXJpZXMNCg0KIyMjIExvYWRpbmcgbGlicmFyaWVzDQoNCmBgYHtyLCB3YXJuaW5nPUZBTFNFLCBtZXNzYWdlPUZBTFNFfQ0KbGlicmFyeSgidGlkeXZlcnNlIikNCmxpYnJhcnkoInRpYmJsZSIpDQpsaWJyYXJ5KCJtc2lnZGJyIikNCmxpYnJhcnkoImdncGxvdDIiKQ0KbGlicmFyeSgiVENHQWJpb2xpbmtzIikNCmxpYnJhcnkoIlJOQXNlcVFDIikNCmxpYnJhcnkoIkRFU2VxMiIpDQpsaWJyYXJ5KCJlbnNlbWJsZGIiKQ0KbGlicmFyeSgicHVycnIiKQ0KbGlicmFyeSgibWFncml0dHIiKQ0KbGlicmFyeSgidnNuIikNCmxpYnJhcnkoIm1hdHJpeFN0YXRzIikNCmxpYnJhcnkoImRwbHlyIikNCmxpYnJhcnkoImdyZXgiKQ0KbGlicmFyeSgic3Vydm1pbmVyIikNCmxpYnJhcnkoInN1cnZpdmFsIikNCmBgYA0KDQojIyBJSS4gRG93bmxvYWRpbmcgdGhlIFRDR0EgZ2VuZSBleHByZXNzaW9uIGRhdGEgDQoNCkNyZWF0ZSBhIGZ1bmN0aW9uIGZvciBkb3dubG9hZGluZyBUQ0dBIGdlbmUgZXhwcmVzc2lvbiBkYXRhLiANCg0KRm9yIG1vcmUgZGV0YWlsZWQgZG9jdW1lbnRhdGlvbiwgcmVmZXIgdG8gYDIuIERpZmZlcmVudGlhbCBHZW5lIEV4cHJlc3Npb24gQW5hbHlzaXMgLSBUQ0dBLlJtZGAuDQoNCmBgYHtyfQ0KcXVlcnlfYW5kX2ZpbHRlcl9zYW1wbGVzIDwtIGZ1bmN0aW9uKHByb2plY3QpIHsNCiAgcXVlcnlfdHVtb3IgPC0gR0RDcXVlcnkoDQogICAgcHJvamVjdCA9IHByb2plY3QsDQogICAgZGF0YS5jYXRlZ29yeSA9ICJUcmFuc2NyaXB0b21lIFByb2ZpbGluZyIsDQogICAgZGF0YS50eXBlID0gIkdlbmUgRXhwcmVzc2lvbiBRdWFudGlmaWNhdGlvbiIsDQogICAgZXhwZXJpbWVudGFsLnN0cmF0ZWd5ID0gIlJOQS1TZXEiLA0KICAgIHdvcmtmbG93LnR5cGUgPSAiU1RBUiAtIENvdW50cyIsDQogICAgYWNjZXNzID0gIm9wZW4iLA0KICAgIHNhbXBsZS50eXBlID0gIlByaW1hcnkgVHVtb3IiDQogICkNCiAgdHVtb3IgPC0gZ2V0UmVzdWx0cyhxdWVyeV90dW1vcikNCg0KICBxdWVyeV9ub3JtYWwgPC0gR0RDcXVlcnkoDQogICAgcHJvamVjdCA9IHByb2plY3QsDQogICAgZGF0YS5jYXRlZ29yeSA9ICJUcmFuc2NyaXB0b21lIFByb2ZpbGluZyIsDQogICAgZGF0YS50eXBlID0gIkdlbmUgRXhwcmVzc2lvbiBRdWFudGlmaWNhdGlvbiIsDQogICAgZXhwZXJpbWVudGFsLnN0cmF0ZWd5ID0gIlJOQS1TZXEiLA0KICAgIHdvcmtmbG93LnR5cGUgPSAiU1RBUiAtIENvdW50cyIsDQogICAgYWNjZXNzID0gIm9wZW4iLA0KICAgIHNhbXBsZS50eXBlID0gIlNvbGlkIFRpc3N1ZSBOb3JtYWwiDQogICkNCiAgbm9ybWFsIDwtIGdldFJlc3VsdHMocXVlcnlfbm9ybWFsKQ0KDQogIHN1Ym1pdHRlcl9pZHMgPC0gaW5uZXJfam9pbih0dW1vciwgbm9ybWFsLCBieSA9ICJjYXNlcy5zdWJtaXR0ZXJfaWQiKSAlPiUNCiAgICBkcGx5cjo6c2VsZWN0KGNhc2VzLnN1Ym1pdHRlcl9pZCkNCiAgdHVtb3IgPC0gdHVtb3IgJT4lDQogICAgZHBseXI6OmZpbHRlcihjYXNlcy5zdWJtaXR0ZXJfaWQgJWluJSBzdWJtaXR0ZXJfaWRzJGNhc2VzLnN1Ym1pdHRlcl9pZCkNCiAgbm9ybWFsIDwtIG5vcm1hbCAlPiUNCiAgICBkcGx5cjo6ZmlsdGVyKGNhc2VzLnN1Ym1pdHRlcl9pZCAlaW4lIHN1Ym1pdHRlcl9pZHMkY2FzZXMuc3VibWl0dGVyX2lkKQ0KDQogIHNhbXBsZXMgPC0gcmJpbmQodHVtb3IsIG5vcm1hbCkNCiAgdW5pcXVlKHNhbXBsZXMkc2FtcGxlX3R5cGUpDQoNCiAgcXVlcnlfcHJvamVjdCA8LSBHRENxdWVyeSgNCiAgICBwcm9qZWN0ID0gcHJvamVjdCwNCiAgICBkYXRhLmNhdGVnb3J5ID0gIlRyYW5zY3JpcHRvbWUgUHJvZmlsaW5nIiwNCiAgICBkYXRhLnR5cGUgPSAiR2VuZSBFeHByZXNzaW9uIFF1YW50aWZpY2F0aW9uIiwNCiAgICBleHBlcmltZW50YWwuc3RyYXRlZ3kgPSAiUk5BLVNlcSIsDQogICAgd29ya2Zsb3cudHlwZSA9ICJTVEFSIC0gQ291bnRzIiwNCiAgICBhY2Nlc3MgPSAib3BlbiIsDQogICAgc2FtcGxlLnR5cGUgPSBjKCJTb2xpZCBUaXNzdWUgTm9ybWFsIiwgIlByaW1hcnkgVHVtb3IiKSwNCiAgICBiYXJjb2RlID0gYXMubGlzdChzYW1wbGVzJHNhbXBsZS5zdWJtaXR0ZXJfaWQpDQogICkNCg0KICAjIElmIHRoaXMgaXMgeW91ciBmaXJzdCB0aW1lIHJ1bm5pbmcgdGhpcyBub3RlYm9vayAoaS5lLiwgeW91IGhhdmUgbm90IHlldCBkb3dubG9hZGVkIHRoZSByZXN1bHRzIG9mIHRoZSBxdWVyeSBpbiB0aGUgcHJldmlvdXMgYmxvY2spLA0KICAjIHVuY29tbWVudCB0aGUgbGluZSBiZWxvdw0KDQogICMgR0RDZG93bmxvYWQocXVlcnlfcHJvamVjdCkNCg0KICByZXR1cm4obGlzdChzYW1wbGVzID0gc2FtcGxlcywgcXVlcnlfcHJvamVjdCA9IHF1ZXJ5X3Byb2plY3QpKQ0KfQ0KYGBgDQoNCkRvd25sb2FkIHRoZSBUQ0dBIGdlbmUgZXhwcmVzc2lvbiBkYXRhIGZvciBjb2xvcmVjdGFsIGNhbmNlciAoVENHQS1DT0FEKS4NCg0KYGBge3IsIGVjaG8gPSBUUlVFLCBtZXNzYWdlID0gRkFMU0UsIHJlc3VsdHM9ImhpZGUifQ0KcHJvamVjdHMgPC0gYygiVENHQS1DT0FEIikNCg0Kd2l0aF9yZXN1bHRzX3Byb2plY3RzIDwtIGMoKQ0KDQpzYW1wbGVzIDwtIGxpc3QoKQ0KcHJvamVjdF9kYXRhIDwtIGxpc3QoKQ0KDQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgcmVzdWx0IDwtIHRyeUNhdGNoKA0KICAgIHsNCiAgICAgIHJlc3VsdCA8LSBxdWVyeV9hbmRfZmlsdGVyX3NhbXBsZXMocHJvamVjdCkNCiAgICAgIHNhbXBsZXNbW3Byb2plY3RdXSA8LSByZXN1bHQkc2FtcGxlcw0KICAgICAgcHJvamVjdF9kYXRhW1twcm9qZWN0XV0gPC0gcmVzdWx0JHF1ZXJ5X3Byb2plY3QNCg0KICAgICAgd2l0aF9yZXN1bHRzX3Byb2plY3RzIDwtIGMod2l0aF9yZXN1bHRzX3Byb2plY3RzLCBwcm9qZWN0KQ0KICAgIH0sDQogICAgZXJyb3IgPSBmdW5jdGlvbihlKSB7DQoNCiAgICB9DQogICkNCn0NCmBgYA0KDQpSdW5uaW5nIHRoZSBjb2RlIGJsb2NrIGFib3ZlIHNob3VsZCBnZW5lcmF0ZSBhbmQgcG9wdWxhdGUgYSBkaXJlY3RvcnkgbmFtZWQgYEdEQ2RhdGFgLg0KDQojIyBJSUkuIERhdGEgcHJlcHJvY2Vzc2luZw0KDQpDb25zdHJ1Y3QgdGhlIFJOQS1zZXEgY291bnQgbWF0cml4IGZvciBlYWNoIGNhbmNlciB0eXBlLg0KDQpgYGB7ciwgZWNobyA9IFRSVUUsIG1lc3NhZ2UgPSBGQUxTRSwgcmVzdWx0cz0iaGlkZSJ9DQp0Y2dhX2RhdGEgPC0gbGlzdCgpDQp0Y2dhX21hdHJpeCA8LSBsaXN0KCkNCg0KcHJvamVjdHMgPC0gd2l0aF9yZXN1bHRzX3Byb2plY3RzDQpmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgdGNnYV9kYXRhW1twcm9qZWN0XV0gPC0gR0RDcHJlcGFyZShwcm9qZWN0X2RhdGFbW3Byb2plY3RdXSwgc3VtbWFyaXplZEV4cGVyaW1lbnQgPSBUUlVFKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogIGNvdW50X21hdHJpeCA8LSBhc3NheSh0Y2dhX2RhdGFbW3Byb2plY3RdXSwgInVuc3RyYW5kZWQiKQ0KDQogICMgUmVtb3ZlIGR1cGxpY2F0ZSBlbnRyaWVzDQogIGNvdW50X21hdHJpeF9kZiA8LSBkYXRhLmZyYW1lKGNvdW50X21hdHJpeCkNCiAgY291bnRfbWF0cml4X2RmIDwtIGNvdW50X21hdHJpeF9kZlshZHVwbGljYXRlZChjb3VudF9tYXRyaXhfZGYpLCBdDQogIGNvdW50X21hdHJpeCA8LSBkYXRhLm1hdHJpeChjb3VudF9tYXRyaXhfZGYpDQogIHJvd25hbWVzKGNvdW50X21hdHJpeCkgPC0gY2xlYW5pZChyb3duYW1lcyhjb3VudF9tYXRyaXgpKQ0KICBjb3VudF9tYXRyaXggPC0gY291bnRfbWF0cml4WyEoZHVwbGljYXRlZChyb3duYW1lcyhjb3VudF9tYXRyaXgpKSB8IGR1cGxpY2F0ZWQocm93bmFtZXMoY291bnRfbWF0cml4KSwgZnJvbUxhc3QgPSBUUlVFKSksIF0NCg0KICB0Y2dhX21hdHJpeFtbcHJvamVjdF1dIDwtIGNvdW50X21hdHJpeA0KfQ0KYGBgDQpGb3JtYXQgdGhlIGBzYW1wbGVzYCB0YWJsZSBzbyB0aGF0IGl0IGNhbiBiZSBmZWQgYXMgaW5wdXQgdG8gREVTZXEyLg0KDQpgYGB7cn0NCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pIDwtIHNhbXBsZXNbW3Byb2plY3RdXSRjYXNlcw0KICBzYW1wbGVzW1twcm9qZWN0XV0gPC0gc2FtcGxlc1tbcHJvamVjdF1dICU+JQ0KICAgIGRwbHlyOjpzZWxlY3QoY2FzZSA9ICJjYXNlcy5zdWJtaXR0ZXJfaWQiLCB0eXBlID0gInNhbXBsZV90eXBlIikNCiAgc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUgPC0gc3RyX3JlcGxhY2Uoc2FtcGxlc1tbcHJvamVjdF1dJHR5cGUsICJTb2xpZCBUaXNzdWUgTm9ybWFsIiwgIm5vcm1hbCIpDQogIHNhbXBsZXNbW3Byb2plY3RdXSR0eXBlIDwtIHN0cl9yZXBsYWNlKHNhbXBsZXNbW3Byb2plY3RdXSR0eXBlLCAiUHJpbWFyeSBUdW1vciIsICJ0dW1vciIpDQp9DQpgYGANCg0KREVTZXEyIHJlcXVpcmVzIHRoZSByb3cgbmFtZXMgb2YgYHNhbXBsZXNgIHNob3VsZCBiZSBpZGVudGljYWwgdG8gdGhlIGNvbHVtbiBuYW1lcyBvZiBgY291bnRfbWF0cml4YC4NCg0KYGBge3IsIGVjaG8gPSBUUlVFLCByZXN1bHRzPSJoaWRlIn0NCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICBjb2xuYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSA8LSBnc3ViKHggPSBjb2xuYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSwgcGF0dGVybiA9ICJcXC4iLCByZXBsYWNlbWVudCA9ICItIikNCiAgdGNnYV9tYXRyaXhbW3Byb2plY3RdXSA8LSB0Y2dhX21hdHJpeFtbcHJvamVjdF1dWywgcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKV0NCg0KICAjIFNhbml0eSBjaGVjaw0KICBwcmludChhbGwoY29sbmFtZXModGNnYV9tYXRyaXhbW3Byb2plY3RdXSkgPT0gcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKSkpDQp9DQpgYGANCg0KIyMgSVYuIERpZmZlcmVudGlhbCBnZW5lIGV4cHJlc3Npb24gYW5hbHlzaXMNCg0KRm9yIG1vcmUgZGV0YWlsZWQgZG9jdW1lbnRhdGlvbiBvbiBvYnRhaW5pbmcgdGhlIGdlbmUgc2V0LCByZWZlciB0byBgNy4gRGlmZmVyZW50aWFsIEdlbmUgRXhwcmVzc2lvbiBBbmFseXNpcyAtIFRDR0EgLSBQYW4tY2FuY2VyIC0gVW5pcXVlIEdlbmVzLlJtZGAuDQoNCmBgYHtyfQ0KUkNEZGIgPC0gInRlbXAvdW5pcXVlX2dlbmVzL25lY3JvcHRvc2lzX2ZlcnJvcHRvc2lzX3B5cm9wdG9zaXMvIg0KYGBgDQoNCldyaXRlIHV0aWxpdHkgZnVuY3Rpb25zIGZvciBmaWx0ZXJpbmcgdGhlIGdlbmUgc2V0cywgcGVyZm9ybWluZyBkaWZmZXJlbnRpYWwgZ2VuZSBleHByZXNzaW9uIGFuYWx5c2lzLCBwbG90dGluZyB0aGUgcmVzdWx0cywgYW5kIHBlcmZvcm1pbmcgdmFyaWFuY2Utc3RhYmlsaXppbmcgdHJhbnNmb3JtYXRpb24uDQoNCmBgYHtyfQ0KZmlsdGVyX2dlbmVfc2V0X2FuZF9wZXJmb3JtX2RnZWEgPC0gZnVuY3Rpb24oZ2VuZXMpIHsNCiAgdGNnYV9yY2QgPC0gbGlzdCgpDQoNCiAgZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogICAgcm93bmFtZXMoZ2VuZXMpIDwtIGdlbmVzJGdlbmVfaWQNCiAgICB0Y2dhX3JjZFtbcHJvamVjdF1dIDwtIHRjZ2FfbWF0cml4W1twcm9qZWN0XV1bcm93bmFtZXModGNnYV9tYXRyaXhbW3Byb2plY3RdXSkgJWluJSBnZW5lcyRnZW5lX2lkLCBdDQogICAgdGNnYV9yY2RbW3Byb2plY3RdXSA8LSB0Y2dhX3JjZFtbcHJvamVjdF1dWywgcm93bmFtZXMoc2FtcGxlc1tbcHJvamVjdF1dKV0NCiAgfQ0KDQogIGRkc19yY2QgPC0gbGlzdCgpDQogIHJlc19yY2QgPC0gbGlzdCgpDQoNCiAgZm9yIChwcm9qZWN0IGluIHByb2plY3RzKSB7DQogICAgcHJpbnQocHJvamVjdCkNCiAgICBwcmludCgiPT09PT09PT09PT09PSIpDQogICAgZGRzIDwtIERFU2VxRGF0YVNldEZyb21NYXRyaXgoDQogICAgICBjb3VudERhdGEgPSB0Y2dhX3JjZFtbcHJvamVjdF1dLA0KICAgICAgY29sRGF0YSA9IHNhbXBsZXNbW3Byb2plY3RdXSwNCiAgICAgIGRlc2lnbiA9IH50eXBlDQogICAgKQ0KICAgIGRkcyA8LSBmaWx0ZXJfZ2VuZXMoZGRzLCBtaW5fY291bnQgPSAxMCkNCiAgICBkZHMkdHlwZSA8LSByZWxldmVsKGRkcyR0eXBlLCByZWYgPSAibm9ybWFsIikNCiAgICBkZHNfcmNkW1twcm9qZWN0XV0gPC0gREVTZXEoZGRzKQ0KICAgIHJlc19yY2RbW3Byb2plY3RdXSA8LSByZXN1bHRzKGRkc19yY2RbW3Byb2plY3RdXSkNCiAgfQ0KDQogIGRlc2VxLmJibC5kYXRhIDwtIGxpc3QoKQ0KDQogIGZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICAgIGRlc2VxLnJlc3VsdHMgPC0gcmVzX3JjZFtbcHJvamVjdF1dDQogICAgZGVzZXEuYmJsLmRhdGFbW3Byb2plY3RdXSA8LSBkYXRhLmZyYW1lKA0KICAgICAgcm93Lm5hbWVzID0gcm93bmFtZXMoZGVzZXEucmVzdWx0cyksDQogICAgICBiYXNlTWVhbiA9IGRlc2VxLnJlc3VsdHMkYmFzZU1lYW4sDQogICAgICBsb2cyRm9sZENoYW5nZSA9IGRlc2VxLnJlc3VsdHMkbG9nMkZvbGRDaGFuZ2UsDQogICAgICBsZmNTRSA9IGRlc2VxLnJlc3VsdHMkbGZjU0UsDQogICAgICBzdGF0ID0gZGVzZXEucmVzdWx0cyRzdGF0LA0KICAgICAgcHZhbHVlID0gZGVzZXEucmVzdWx0cyRwdmFsdWUsDQogICAgICBwYWRqID0gZGVzZXEucmVzdWx0cyRwYWRqLA0KICAgICAgY2FuY2VyX3R5cGUgPSBwcm9qZWN0LA0KICAgICAgZ2VuZV9zeW1ib2wgPSBnZW5lc1tyb3duYW1lcyhkZXNlcS5yZXN1bHRzKSwgImdlbmUiXQ0KICAgICkNCiAgfQ0KDQogIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkIDwtIGJpbmRfcm93cyhkZXNlcS5iYmwuZGF0YSkNCiAgZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gZHBseXI6OmZpbHRlcihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCwgYWJzKGxvZzJGb2xkQ2hhbmdlKSA+PSAxLjUgJiBwYWRqIDwgMC4wNSkNCg0KICByZXR1cm4oZGVzZXEuYmJsLmRhdGEuY29tYmluZWQpDQp9DQpgYGANCg0KYGBge3J9DQpwbG90X2RnZWEgPC0gZnVuY3Rpb24oZGVzZXEuYmJsLmRhdGEuY29tYmluZWQpIHsNCiAgc2l6ZXMgPC0gYygiPDEwXi0xNSIgPSA0LCAiMTBeLTEwIiA9IDMsICIxMF4tNSIgPSAyLCAiMC4wNSIgPSAxKQ0KDQogIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkIDwtIGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkICU+JQ0KICAgIG11dGF0ZShmZHJfY2F0ZWdvcnkgPSBjdXQocGFkaiwNCiAgICAgIGJyZWFrcyA9IGMoLUluZiwgMWUtMTUsIDFlLTEwLCAxZS01LCAwLjA1KSwNCiAgICAgIGxhYmVscyA9IGMoIjwxMF4tMTUiLCAiMTBeLTEwIiwgIjEwXi01IiwgIjAuMDUiKSwNCiAgICAgIHJpZ2h0ID0gRkFMU0UNCiAgICApKQ0KDQogIHRvcF9nZW5lcyA8LSBkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCAlPiUNCiAgICBncm91cF9ieShjYW5jZXJfdHlwZSkgJT4lDQogICAgbXV0YXRlKHJhbmsgPSByYW5rKC1hYnMobG9nMkZvbGRDaGFuZ2UpKSkgJT4lDQogICAgZHBseXI6OmZpbHRlcihyYW5rIDw9IDEwKSAlPiUNCiAgICB1bmdyb3VwKCkNCg0KICBnZ3Bsb3QodG9wX2dlbmVzLCBhZXMoeSA9IGNhbmNlcl90eXBlLCB4ID0gZ2VuZV9zeW1ib2wsIHNpemUgPSBmZHJfY2F0ZWdvcnksIGZpbGwgPSBsb2cyRm9sZENoYW5nZSkpICsNCiAgICBnZW9tX3BvaW50KGFscGhhID0gMC41LCBzaGFwZSA9IDIxLCBjb2xvciA9ICJibGFjayIpICsNCiAgICBzY2FsZV9zaXplX21hbnVhbCh2YWx1ZXMgPSBzaXplcykgKw0KICAgIHNjYWxlX2ZpbGxfZ3JhZGllbnQyKGxvdyA9ICJibHVlIiwgbWlkID0gIndoaXRlIiwgaGlnaCA9ICJyZWQiLCBsaW1pdHMgPSBjKG1pbihkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCRsb2cyRm9sZENoYW5nZSksIG1heChkZXNlcS5iYmwuZGF0YS5jb21iaW5lZCRsb2cyRm9sZENoYW5nZSkpKSArDQogICAgdGhlbWVfbWluaW1hbCgpICsNCiAgICB0aGVtZSgNCiAgICAgIGF4aXMudGV4dC54ID0gZWxlbWVudF90ZXh0KHNpemUgPSA5LCBhbmdsZSA9IDkwLCBoanVzdCA9IDEpDQogICAgKSArDQogICAgdGhlbWUobGVnZW5kLnBvc2l0aW9uID0gImJvdHRvbSIpICsNCiAgICB0aGVtZShsZWdlbmQucG9zaXRpb24gPSAiYm90dG9tIikgKw0KICAgIGxhYnMoc2l6ZSA9ICJBZGp1c3RlZCBwLXZhbHVlIiwgZmlsbCA9ICJsb2cyIEZDIiwgeSA9ICJDYW5jZXIgdHlwZSIsIHggPSAiR2VuZSIpDQp9DQpgYGANCg0KYGBge3J9DQpwZXJmb3JtX3ZzZCA8LSBmdW5jdGlvbihnZW5lcykgew0KICB0Y2dhX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICByb3duYW1lcyhnZW5lcykgPC0gZ2VuZXMkZ2VuZV9pZA0KICAgIHRjZ2FfcmNkW1twcm9qZWN0XV0gPC0gdGNnYV9tYXRyaXhbW3Byb2plY3RdXVtyb3duYW1lcyh0Y2dhX21hdHJpeFtbcHJvamVjdF1dKSAlaW4lIGdlbmVzJGdlbmVfaWQsIF0NCiAgICB0Y2dhX3JjZFtbcHJvamVjdF1dIDwtIHRjZ2FfcmNkW1twcm9qZWN0XV1bLCByb3duYW1lcyhzYW1wbGVzW1twcm9qZWN0XV0pXQ0KICB9DQoNCiAgdnNkX3JjZCA8LSBsaXN0KCkNCg0KICBmb3IgKHByb2plY3QgaW4gcHJvamVjdHMpIHsNCiAgICBwcmludChwcm9qZWN0KQ0KICAgIHByaW50KCI9PT09PT09PT09PT09IikNCiAgICBkZHMgPC0gREVTZXFEYXRhU2V0RnJvbU1hdHJpeCgNCiAgICAgIGNvdW50RGF0YSA9IHRjZ2FfcmNkW1twcm9qZWN0XV0sDQogICAgICBjb2xEYXRhID0gc2FtcGxlc1tbcHJvamVjdF1dLA0KICAgICAgZGVzaWduID0gfnR5cGUNCiAgICApDQogICAgZGRzIDwtIGZpbHRlcl9nZW5lcyhkZHMsIG1pbl9jb3VudCA9IDEwKQ0KDQogICAgIyBQZXJmb3JtIHZhcmlhbmNlIHN0YWJpbGl6YXRpb24NCiAgICBkZHMgPC0gZXN0aW1hdGVTaXplRmFjdG9ycyhkZHMpDQogICAgbnN1YiA8LSBzdW0ocm93TWVhbnMoY291bnRzKGRkcywgbm9ybWFsaXplZCA9IFRSVUUpKSA+IDEwKQ0KICAgIHZzZCA8LSB2c3QoZGRzLCBuc3ViID0gbnN1YikNCiAgICB2c2RfcmNkW1twcm9qZWN0XV0gPC0gYXNzYXkodnNkKQ0KICB9DQoNCiAgcmV0dXJuKHZzZF9yY2QpDQp9DQpgYGANCg0KDQojIyMjIEZlcnJvcHRvc2lzDQoNCkZldGNoIHRoZSBnZW5lIHNldCBvZiBpbnRlcmVzdC4NCg0KYGBge3J9DQpnZW5lcyA8LSByZWFkLmNzdihwYXN0ZTAoUkNEZGIsICJGZXJyb3B0b3Npcy5jc3YiKSkNCnByaW50KGdlbmVzKQ0KZ2VuZXMkZ2VuZV9pZCA8LSBjbGVhbmlkKGdlbmVzJGdlbmVfaWQpDQpnZW5lcyA8LSBkaXN0aW5jdChnZW5lcywgZ2VuZV9pZCwgLmtlZXBfYWxsID0gVFJVRSkNCmdlbmVzIDwtIHN1YnNldChnZW5lcywgZ2VuZV9pZCAhPSAiIikNCmdlbmVzDQpgYGANCg0KRmlsdGVyIHRoZSBnZW5lcyB0byBpbmNsdWRlIG9ubHkgdGhvc2UgaW4gdGhlIGdlbmUgc2V0IG9mIGludGVyZXN0LCBhbmQgdGhlbiBwZXJmb3JtIGRpZmZlcmVudGlhbCBnZW5lIGV4cHJlc3Npb24gYW5hbHlzaXMuDQoNCmBgYHtyfQ0KZGVzZXEuYmJsLmRhdGEuY29tYmluZWQgPC0gZmlsdGVyX2dlbmVfc2V0X2FuZF9wZXJmb3JtX2RnZWEoZ2VuZXMpDQpkZXNlcS5iYmwuZGF0YS5jb21iaW5lZA0KYGBgDQoNClBsb3QgdGhlIHJlc3VsdHMuDQoNCmBgYHtyfQ0KcGxvdF9kZ2VhKGRlc2VxLmJibC5kYXRhLmNvbWJpbmVkKQ0KYGBgDQpQZXJmb3JtIHZhcmlhbmNlLXN0YWJpbGl6aW5nIHRyYW5zZm9ybWF0aW9uIGZvciBmdXJ0aGVyIGRvd25zdHJlYW0gYW5hbHlzaXMgKGkuZS4sIGZvciBzdXJ2aXZhbCBhbmFseXNpcykuDQoNCmBgYHtyLCB3YXJuaW5nPUZBTFNFfQ0KdnNkIDwtIHBlcmZvcm1fdnNkKGdlbmVzKQ0KYGBgDQoNCiMjIFYuIERvd25sb2FkaW5nIHRoZSBjbGluaWNhbCBkYXRhDQoNCkRvd25sb2FkIGNsaW5pY2FsIGRhdGEgZnJvbSBUQ0dBLCBhbmQgcGVyZm9ybSBzb21lIHByZXByb2Nlc3Npbmc6DQotIFRoZSBgZGVjZWFzZWRgIGNvbHVtbiBzaG91bGQgYmUgYEZBTFNFYCBpZiB0aGUgcGF0aWVudCBpcyBhbGl2ZSBhbmQgYFRSVUVgIG90aGVyd2lzZQ0KLSBUaGUgYG92ZXJhbGxfc3Vydml2YWxgIGNvbHVtbiBzaG91bGQgcmVmbGVjdCB0aGUgZm9sbG93LXVwIHRpbWUgaWYgdGhlIHBhdGllbnQgaXMgYWxpdmUgYW5kIHRoZSBkYXlzIHRvIGRlYXRoIG90aGVyd2lzZQ0KDQpgYGB7cn0NCmRvd25sb2FkX2NsaW5pY2FsX2RhdGEgPC0gZnVuY3Rpb24ocHJvamVjdCkgew0KICBjbGluaWNhbF9kYXRhIDwtIEdEQ3F1ZXJ5X2NsaW5pYyhwcm9qZWN0KQ0KICBjbGluaWNhbF9kYXRhJGRlY2Vhc2VkIDwtIGlmZWxzZShjbGluaWNhbF9kYXRhJHZpdGFsX3N0YXR1cyA9PSAiQWxpdmUiLCBGQUxTRSwgVFJVRSkNCiAgY2xpbmljYWxfZGF0YSRvdmVyYWxsX3N1cnZpdmFsIDwtIGlmZWxzZShjbGluaWNhbF9kYXRhJHZpdGFsX3N0YXR1cyA9PSAiQWxpdmUiLA0KICAgIGNsaW5pY2FsX2RhdGEkZGF5c190b19sYXN0X2ZvbGxvd191cCwNCiAgICBjbGluaWNhbF9kYXRhJGRheXNfdG9fZGVhdGgNCiAgKQ0KDQogIHJldHVybihjbGluaWNhbF9kYXRhKQ0KfQ0KYGBgDQoNCmBgYHtyfQ0KdGNnYV9jbGluaWNhbCA8LSBsaXN0KCkNCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICB0Y2dhX2NsaW5pY2FsW1twcm9qZWN0XV0gPC0gZG93bmxvYWRfY2xpbmljYWxfZGF0YShwcm9qZWN0KQ0KfQ0KYGBgDQoNCiMjIFZJLiBQZXJmb3JtaW5nIHN1cnZpdmFsIGFuYWx5c2lzDQoNCldyaXRlIHV0aWxpdHkgZnVuY3Rpb25zIGZvciBwZXJmb3JtaW5nIHN1cnZpdmFsIGFuYWx5c2lzLg0KDQoNCmBgYHtyfQ0KY29uc3RydWN0X2dlbmVfZGYgPC0gZnVuY3Rpb24oZ2VuZV9vZl9pbnRlcmVzdCwgcHJvamVjdCkgew0KICBnZW5lX2RmIDwtIHZzZFtbcHJvamVjdF1dICU+JQ0KICAgIGFzLmRhdGEuZnJhbWUoKSAlPiUNCiAgICByb3duYW1lc190b19jb2x1bW4odmFyID0gImdlbmVfaWQiKSAlPiUNCiAgICBnYXRoZXIoa2V5ID0gImNhc2VfaWQiLCB2YWx1ZSA9ICJjb3VudHMiLCAtZ2VuZV9pZCkgJT4lDQogICAgbGVmdF9qb2luKC4sIGdlbmVzLCBieSA9ICJnZW5lX2lkIikgJT4lDQogICAgZHBseXI6OmZpbHRlcihnZW5lID09IGdlbmVfb2ZfaW50ZXJlc3QpICU+JQ0KICAgIGRwbHlyOjpmaWx0ZXIoY2FzZV9pZCAlaW4lIHJvd25hbWVzKHNhbXBsZXNbW3Byb2plY3RdXSAlPiUgZHBseXI6OmZpbHRlcih0eXBlID09ICJub3JtYWwiKSkpDQoNCiAgcTEgPC0gcXVhbnRpbGUoZ2VuZV9kZiRjb3VudHMsIHByb2JzID0gMC4yNSkNCiAgcTMgPC0gcXVhbnRpbGUoZ2VuZV9kZiRjb3VudHMsIHByb2JzID0gMC43NSkNCiAgZ2VuZV9kZiRzdHJhdGEgPC0gaWZlbHNlKGdlbmVfZGYkY291bnRzID49IHEzLCAiSElHSCIsIGlmZWxzZShnZW5lX2RmJGNvdW50cyA8PSBxMSwgIkxPVyIsICJNSURETEUiKSkNCiAgZ2VuZV9kZiA8LSBnZW5lX2RmICU+JSBkcGx5cjo6ZmlsdGVyKHN0cmF0YSAlaW4lIGMoIkxPVyIsICJISUdIIikpDQogIGdlbmVfZGYkY2FzZV9pZCA8LSBwYXN0ZTAoc2FwcGx5KHN0cnNwbGl0KGFzLmNoYXJhY3RlcihnZW5lX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDEpLCAnLScsDQogICAgICAgICAgICAgICAgICAgICAgICAgIHNhcHBseShzdHJzcGxpdChhcy5jaGFyYWN0ZXIoZ2VuZV9kZiRjYXNlX2lkKSwgIi0iKSwgYFtgLCAyKSwgJy0nLCANCiAgICAgICAgICAgICAgICAgICAgICAgICAgc2FwcGx5KHN0cnNwbGl0KGFzLmNoYXJhY3RlcihnZW5lX2RmJGNhc2VfaWQpLCAiLSIpLCBgW2AsIDMpKQ0KICBnZW5lX2RmIDwtIG1lcmdlKGdlbmVfZGYsIHRjZ2FfY2xpbmljYWxbW3Byb2plY3RdXSwgYnkueCA9ICJjYXNlX2lkIiwgYnkueSA9ICJzdWJtaXR0ZXJfaWQiKQ0KICANCiAgcmV0dXJuKGdlbmVfZGYpDQp9DQpgYGANCg0KYGBge3J9DQpjb21wdXRlX3N1cml2YWxfZml0IDwtIGZ1bmN0aW9uKGdlbmVfZGYpIHsNCiAgcmV0dXJuIChzdXJ2Zml0KFN1cnYob3ZlcmFsbF9zdXJ2aXZhbCwgZGVjZWFzZWQpIH4gc3RyYXRhLCBkYXRhID0gZ2VuZV9kZikpDQp9DQpgYGANCg0KYGBge3J9DQpjb21wdXRlX2NveCA8LSBmdW5jdGlvbihnZW5lX2RmKSB7DQogIHJldHVybiAoY294cGgoU3VydihvdmVyYWxsX3N1cnZpdmFsLCBkZWNlYXNlZCkgfiBzdHJhdGEsIGRhdGE9Z2VuZV9kZikpDQp9DQpgYGANCg0KYGBge3J9DQpwbG90X3N1cnZpdmFsIDwtIGZ1bmN0aW9uKGZpdCkgew0KICByZXR1cm4oZ2dzdXJ2cGxvdChmaXQsDQogICAgZGF0YSA9IGdlbmVfZGYsDQogICAgcHZhbCA9IFQsDQogICAgcmlzay50YWJsZSA9IFQsDQogICAgcmlzay50YWJsZS5oZWlnaHQgPSAwLjMNCiAgKSkNCn0NCmBgYA0KDQpgYGB7cn0NCmNvbXB1dGVfc3Vydml2YWxfZGlmZiA8LSBmdW5jdGlvbihnZW5lX2RmKSB7DQogIHJldHVybihzdXJ2ZGlmZihTdXJ2KG92ZXJhbGxfc3Vydml2YWwsIGRlY2Vhc2VkKSB+IHN0cmF0YSwgZGF0YSA9IGdlbmVfZGYpKQ0KfQ0KYGBgDQoNClBlcmZvcm0gc3Vydml2YWwgYW5hbHlzaXMgYnkgdGVzdGluZyBmb3IgdGhlIGRpZmZlcmVuY2UgaW4gdGhlIEthcGxhbi1NZWllciBjdXJ2ZXMgdXNpbmcgdGhlIEctcmhvIGZhbWlseSBvZiBIYXJyaW5ndG9uIGFuZCBGbGVtaW5nIHRlc3RzOiBodHRwczovL3JkcnIuaW8vY3Jhbi9zdXJ2aXZhbC9tYW4vc3VydmRpZmYuaHRtbA0KDQpPdXIgZ2VuZXMgb2YgaW50ZXJlc3QgYXJlIHRoZSBkaWZmZXJlbnRpYWxseSBleHByZXNzZWQgZ2VuZXMuDQoNCmBgYHtyfQ0Kc2lnbmlmaWNhbnRfcHJvamVjdHMgPC0gYygpDQpzaWduaWZpY2FudF9nZW5lcyA8LSBjKCkNCg0KY3RyIDwtIDENCmZvciAocHJvamVjdCBpbiBwcm9qZWN0cykgew0KICBmb3IgKGdlbmUgaW4gYyhnZW5lcyRnZW5lKSkgew0KICAgIGNhdChwcm9qZWN0LCBnZW5lLCAiXG5cbiIpDQogICAgZXJyb3IgPC0gdHJ5Q2F0Y2ggKA0KICAgICAgew0KICAgICAgICBnZW5lX2RmIDwtIGNvbnN0cnVjdF9nZW5lX2RmKGdlbmUsIHByb2plY3QpDQogICAgICB9LA0KICAgICAgZXJyb3IgPSBmdW5jdGlvbihlKSB7DQogICAgICAgIGNhdCgiXG5cbj09PT09PT09PT09PT09PT09PT09PT09PT09PT1cblxuIikNCiAgICAgICAgZQ0KICAgICAgfQ0KICAgICkNCiAgICANCiAgICBpZihpbmhlcml0cyhlcnJvciwgImVycm9yIikpIG5leHQNCg0KICAgIGlmIChucm93KGdlbmVfZGYpID4gMCkgew0KICAgICAgZml0IDwtIGNvbXB1dGVfc3VyaXZhbF9maXQoZ2VuZV9kZikNCiAgICAgIHRyeUNhdGNoICgNCiAgICAgICAgew0KICAgICAgICAgIHN1cnZpdmFsIDwtIGNvbXB1dGVfc3Vydml2YWxfZGlmZihnZW5lX2RmKQ0KICAgICAgICAgIGNveCA8LSBjb21wdXRlX2NveChnZW5lX2RmKQ0KICAgICAgICAgIHByaW50KGN0cikNCiAgICAgICAgICBjdHIgPC0gY3RyICsgMQ0KICAgICAgICAgIHByaW50KHN1cnZpdmFsKQ0KICAgICAgICAgIGNhdCgiXG4iKQ0KICAgICAgICAgIHByaW50KGNveCkNCiAgICAgICAgICBwcmludChwbG90X3N1cnZpdmFsKGZpdCkpDQogICAgICAgICAgaWYgKHBjaGlzcShzdXJ2aXZhbCRjaGlzcSwgbGVuZ3RoKHN1cnZpdmFsJG4pLTEsIGxvd2VyLnRhaWwgPSBGQUxTRSkgPCAwLjA1KSB7DQogICAgICAgICAgICBzaWduaWZpY2FudF9wcm9qZWN0cyA8LSBjKHNpZ25pZmljYW50X3Byb2plY3RzLCBwcm9qZWN0KQ0KICAgICAgICAgICAgc2lnbmlmaWNhbnRfZ2VuZXMgPC0gYyhzaWduaWZpY2FudF9nZW5lcywgZ2VuZSkNCiAgICAgICAgICB9DQogICAgICAgIH0sDQogICAgICAgIGVycm9yID0gZnVuY3Rpb24oZSkgew0KICAgICAgICB9DQogICAgICApDQogICAgICANCiAgICB9DQogICAgDQogICAgY2F0KCJcblxuPT09PT09PT09PT09PT09PT09PT09PT09PT09PVxuXG4iKQ0KICB9DQp9DQpgYGANCg0KRGlzcGxheSB0aGUgcmVzdWx0cyBvbmx5IGZvciBnZW5lcyB3aGVyZSBhIHNpZ25pZmljYW50IGRpZmZlcmVuY2UgaW4gc3Vydml2YWwgaGFzIGJlZW4gcmVwb3J0ZWQuDQoNCmBgYHtyfQ0Kc2lnbmlmaWNhbnRfZ2VuZXMNCmBgYA0KDQpgYGB7cn0NCm51bV9zaWduaWZpY2FudF9nZW5lcyA8LSBsZW5ndGgoc2lnbmlmaWNhbnRfZ2VuZXMpDQoNCmlmIChudW1fc2lnbmlmaWNhbnRfZ2VuZXMgPiAwKSB7DQogIGZvciAoaSBpbiAxIDogbnVtX3NpZ25pZmljYW50X2dlbmVzKSB7DQogICAgcHJvamVjdCA8LSBzaWduaWZpY2FudF9wcm9qZWN0c1tbaV1dDQogICAgZ2VuZSA8LSBzaWduaWZpY2FudF9nZW5lc1tbaV1dDQogICAgDQogICAgY2F0KHByb2plY3QsIGdlbmUsICJcblxuIikNCiAgICBnZW5lX2RmIDwtIGNvbnN0cnVjdF9nZW5lX2RmKGdlbmUsIHByb2plY3QpDQogICAgDQogICAgZml0IDwtIGNvbXB1dGVfc3VyaXZhbF9maXQoZ2VuZV9kZikNCiAgICBzdXJ2aXZhbCA8LSBjb21wdXRlX3N1cnZpdmFsX2RpZmYoZ2VuZV9kZikNCiAgICBjb3ggPC0gY29tcHV0ZV9jb3goZ2VuZV9kZikNCiAgICBwcmludChzdXJ2aXZhbCkNCiAgICBjYXQoIlxuIikNCiAgICBwcmludChjb3gpDQogICAgcHJpbnQocGxvdF9zdXJ2aXZhbChmaXQpKQ0KICAgIA0KICAgIGNhdCgiXG5cbj09PT09PT09PT09PT09PT09PT09PT09PT09PT1cblxuIikNCiAgfSANCn0NCmBgYA==