Title: | Explores Cancer Testis Genes |
---|---|
Description: | The CTexploreR package re-defines the list of Cancer Testis/Germline (CT) genes. It is based on publicly available RNAseq databases (GTEx, CCLE and TCGA) and summarises CT genes' main characteristics. Several visualisation functions allow to explore their expression in different types of tissues and cancer cells, or to inspect the methylation status of their promoters in normal tissues. |
Authors: | Axelle Loriot [aut, cre] , Julie Devis [aut] , Anna Diacofotaki [ctb], Charles De Smet [ths], Laurent Gatto [aut, ths] |
Maintainer: | Axelle Loriot <[email protected]> |
License: | Artistic-2.0 |
Version: | 1.3.0 |
Built: | 2024-11-05 14:32:27 UTC |
Source: | https://github.com/uclouvain-cbio/ctexplorer |
All genes description, imported from CTdata
all_genes
all_genes
A tibble
object with 24488 rows and 47 columns.
Rows correspond to CT genes
Columns give CT genes characteristics
See CTdata::all_genes
documentation for details
A tibble of all 24 488 genes with their characteristics
See scripts/make_all_genes.R
in CTdata
for details on how this
list was created.
all_genes
all_genes
Plots an expression heatmap of genes in CCLE tumor cell lines.
CCLE_expression( genes = NULL, type = NULL, units = c("TPM", "log_TPM"), include_CTP = FALSE, values_only = FALSE )
CCLE_expression( genes = NULL, type = NULL, units = c("TPM", "log_TPM"), include_CTP = FALSE, values_only = FALSE )
genes |
|
type |
|
units |
|
include_CTP |
|
values_only |
|
A heatmap of selected genes in CCLE cell lines from
specified type. If values_only
is TRUE
, expression values are
returned instead.
## Not run: CCLE_expression( genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "MAGEA10"), type = c("Skin", "Lung"), units = "log_TPM") ## End(Not run)
## Not run: CCLE_expression( genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "MAGEA10"), type = c("Skin", "Lung"), units = "log_TPM") ## End(Not run)
Checks the spelling of a vector of entered variable(s) comparing it to a vector of valid names, and removes the ones that are absent from the vector of valid names.
check_names(variable, valid_vector)
check_names(variable, valid_vector)
variable |
|
valid_vector |
|
A character with valid variables.
CTexploreR:::check_names( variable = c("Ovarian", "leukemia", "wrong_name"), valid_vector = c("ovarian", "leukemia") )
CTexploreR:::check_names( variable = c("Ovarian", "leukemia", "wrong_name"), valid_vector = c("ovarian", "leukemia") )
Cancer-Testis (CT) genes description, imported from CTdata
CT_genes
CT_genes
A tibble
object with 280 rows and 47 columns.
Rows correspond to CT genes
Columns give CT genes characteristics
See CTdata::CT_genes
documentation for details
A tibble of all 280 CT and CTP genes with their characteristics
See scripts/make_CT_genes.R
in CTdata
for details on how this
list of curated CT genes was created.
CT_genes
CT_genes
Plots a heatmap of normalised gene counts (log-transformed) in a selection of cells treated or not by 5-Aza-2'-Deoxycytidine (DAC), a demethylating agent.
DAC_induction( genes = NULL, multimapping = TRUE, include_CTP = FALSE, values_only = FALSE )
DAC_induction( genes = NULL, multimapping = TRUE, include_CTP = FALSE, values_only = FALSE )
genes |
|
multimapping |
|
include_CTP |
|
values_only |
|
RNAseq data from cells treated or not with 5-aza downloaded from
SRA. (SRA references and information about cell lines and DAC
treatment are stored the colData of DAC_treated_cells
). Data was
processed using a standard RNAseq pipeline.
hisat2 was used
to align reads to grch38 genome.
featurecounts
was used to assign reads to genes. Note that -M parameter was used
or not to allow or not counting multi-mapping reads.
A heatmap of selected genes in cells treated or not by a
demethylating agent. If values_only
is TRUE
, gene normalised
logcounts are returned instead.
DAC_induction(genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "CTAG1A")) DAC_induction(genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "CTAG1A", multimapping = FALSE))
DAC_induction(genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "CTAG1A")) DAC_induction(genes = c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEA6", "CTAG1A", multimapping = FALSE))
Plots a heatmap of genes expression in human early embryos, from "Petropoulos" scRNAseq dataset ("Single-Cell RNA-Seq Reveals Lineage and X Chromosome Dynamics in Human Preimplantation Embryos". Petropoulos et al., Cell 2016) or from "Zhu" scRNAseq dataset ("Single-cell DNA methylome sequencing of human preimplantation embryos". Zhu et al. Nat genetics 2018)
embryo_expression( dataset = c("Petropoulos", "Zhu"), genes = NULL, include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
embryo_expression( dataset = c("Petropoulos", "Zhu"), genes = NULL, include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
dataset |
|
genes |
|
include_CTP |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in single cells from
embryos. If values_only = TRUE
, a SingleCellExperiment is returned instead.
## Not run: embryo_expression(dataset = "Petropoulos", include_CTP = FALSE) embryo_expression(dataset = "Zhu", include_CTP = FALSE) ## End(Not run)
## Not run: embryo_expression(dataset = "Petropoulos", include_CTP = FALSE) embryo_expression(dataset = "Zhu", include_CTP = FALSE) ## End(Not run)
Plots a heatmap of mean promoter methylation levels of any genes in early embryos, using WGSB data from ("Single-cell DNA methylome sequencing of human preimplantation embryos". Zhu et al. Nat genetics 2018). Methylation levels in tissues correspond to the mean methylation of CpGs located in range of 1000 pb upstream and 500 pb downstream from gene TSS.
embryos_mean_methylation( genes = NULL, stage = c("GV Oocyte", "MII Oocyte", "Sperm", "Zygote", "2-cell", "4-cell", "8-cell", "Morula", "Blastocyst", "Post-implantation"), include_CTP = FALSE, values_only = FALSE )
embryos_mean_methylation( genes = NULL, stage = c("GV Oocyte", "MII Oocyte", "Sperm", "Zygote", "2-cell", "4-cell", "8-cell", "Morula", "Blastocyst", "Post-implantation"), include_CTP = FALSE, values_only = FALSE )
genes |
|
stage |
|
include_CTP |
|
values_only |
|
Heatmap of mean promoter methylation of any gene in embryos.
If values_only = TRUE
, a RangedSummarizedExperiment with methylation values
is returned instead.
embryos_mean_methylation() embryos_mean_methylation(c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEC2", "MAGEB16"), stage = c( "MII Oocyte", "Sperm", "Zygote", "2-cell", "4-cell", "8-cell", "Morula"))
embryos_mean_methylation() embryos_mean_methylation(c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEC2", "MAGEB16"), stage = c( "MII Oocyte", "Sperm", "Zygote", "2-cell", "4-cell", "8-cell", "Morula"))
Plots a heatmap of genes expression in fetal germ cells, using scRNAseq data from "Single-cell roadmap of human gonadal development" (Garcia-Alonso, Nature 2022)
fetal_germcells_expression( genes = NULL, include_CTP = FALSE, ncells_max = 200, scale_lims = NULL, values_only = FALSE )
fetal_germcells_expression( genes = NULL, include_CTP = FALSE, ncells_max = 200, scale_lims = NULL, values_only = FALSE )
genes |
|
include_CTP |
|
ncells_max |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in single cells from fetal
germ cells. If values_only = TRUE
, a SingleCellExperiment is returned
instead.
## Not run: fetal_germcells_expression(include_CTP = FALSE, ncells_max = 100) ## End(Not run)
## Not run: fetal_germcells_expression(include_CTP = FALSE, ncells_max = 100) ## End(Not run)
Plots a heatmap of mean promoter methylation levels of any genes in fetal germ cells, using WGSB data from "Dissecting the epigenomic dynamics of human fetal germ cell development at single-cell resolution" (Li et al. 2021). Methylation levels in tissues correspond to the mean methylation of CpGs located in range of 1000 pb upstream and 500 pb downstream from gene TSS.
fetal_germcells_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE )
fetal_germcells_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE )
genes |
|
include_CTP |
|
values_only |
|
Heatmap of mean promoter methylation of any gene in normal tissues.
If values_only = TRUE
, a SummarizeExperiment with methylation values is
returned instead.
fetal_germcells_mean_methylation() fetal_germcells_mean_methylation(c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEC2"))
fetal_germcells_mean_methylation() fetal_germcells_mean_methylation(c("MAGEA1", "MAGEA3", "MAGEA4", "MAGEC2"))
Plots an expression heatmap of genes in normal tissues (GTEx database).
GTEX_expression( genes = NULL, units = c("TPM", "log_TPM"), include_CTP = FALSE, values_only = FALSE )
GTEX_expression( genes = NULL, units = c("TPM", "log_TPM"), include_CTP = FALSE, values_only = FALSE )
genes |
|
units |
|
include_CTP |
|
values_only |
|
A heatmap of selected genes expression in normal tissues.
If values_only = TRUE
, expression values are returned instead.
GTEX_expression(units = "log_TPM") GTEX_expression(genes = c("MAGEA1", "MAGEA3"), units = "log_TPM")
GTEX_expression(units = "log_TPM") GTEX_expression(genes = c("MAGEA1", "MAGEA3"), units = "log_TPM")
Plots a heatmap of genes expression in human embryonic stem cells, using RNAseq data downloaded from Encode database.
hESC_expression( genes = NULL, include_CTP = FALSE, units = c("TPM"), scale_lims = NULL, values_only = FALSE )
hESC_expression( genes = NULL, include_CTP = FALSE, units = c("TPM"), scale_lims = NULL, values_only = FALSE )
genes |
|
include_CTP |
|
units |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in single cells from human
embryonic stem cells. If values_only = TRUE
, a SummarizedExperiment
is returned instead.
## Not run: hESC_expression(include_CTP = FALSE, units = "log_TPM", values_only = FALSE) ## End(Not run)
## Not run: hESC_expression(include_CTP = FALSE, units = "log_TPM", values_only = FALSE) ## End(Not run)
Plots a heatmap of mean promoter methylation levels of any genes in human embryonic cell lines. WGBS methylation data was downloaded from Encode. Methylation levels in tissues correspond to the mean methylation of CpGs located in range of 1000 pb upstream and 200 pb downstream from gene TSS.
hESC_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE, na.omit = TRUE )
hESC_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE, na.omit = TRUE )
genes |
|
include_CTP |
|
values_only |
|
na.omit |
|
Heatmap of mean promoter methylation of any
gene in hESC. If values_only = TRUE
, a SummarizedExperiment cobtaining
methylation values is returned instead.
## Not run: hESC_mean_methylation() ## End(Not run)
## Not run: hESC_mean_methylation() ## End(Not run)
Plots a heatmap of genes expression in the different human cell types based on scRNAseq data obtained from the Human Protein Atlas (https://www.proteinatlas.org)
HPA_cell_type_expression( genes = NULL, units = c("scaled", "TPM", "log_TPM"), include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
HPA_cell_type_expression( genes = NULL, units = c("scaled", "TPM", "log_TPM"), include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
genes |
|
units |
|
include_CTP |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in
different human cell types.
If values_only = TRUE
, a SummarizedExperiment instead of the heatmap
is returned instead.
HPA_cell_type_expression( genes = NULL, units = "scaled", scale_lims = NULL, values_only = FALSE) HPA_cell_type_expression( genes = c("MAGEA1", "MAGEA3", "MAGEA4"), units = "TPM", scale_lims = c(0, 50), values_only = FALSE)
HPA_cell_type_expression( genes = NULL, units = "scaled", scale_lims = NULL, values_only = FALSE) HPA_cell_type_expression( genes = c("MAGEA1", "MAGEA3", "MAGEA4"), units = "TPM", scale_lims = c(0, 50), values_only = FALSE)
Plots a heatmap of gene expression values in a set of normal tissues. Expression values (in TPM) have been evaluated by either counting or discarding multi-mapped reads. Indeed, many CT genes belong to gene families from which members have identical or nearly identical sequences. Some CT can only be detected in RNAseq data in which multimapping reads are not discarded.
normal_tissue_expression_multimapping( genes = NULL, include_CTP = FALSE, multimapping = TRUE, units = c("TPM", "log_TPM"), values_only = FALSE )
normal_tissue_expression_multimapping( genes = NULL, include_CTP = FALSE, multimapping = TRUE, units = c("TPM", "log_TPM"), values_only = FALSE )
genes |
|
include_CTP |
|
multimapping |
|
units |
|
values_only |
|
RNAseq data from a set of normal tissues were downloaded from Encode. (see inst/scripts/make_CT_normal_tissues_multimapping.R for fastq references) Fastq files were processed using a standard RNAseq pipeline including FastQC for the quality control of the raw data, and trimmomatic to remove low quality reads and trim the adapter from the sequences. hisat2 was used to align reads to grch38 genome. featurecounts was used to assign reads to genes using Homo_sapiens.GRCh38.105.gtf.
Two different pipelines were run in order to remove or not multi-mapping reads. When multimapping was allowed, hisat2 was run with -k 20 parameter (reports up to 20 alignments per read), and featurecounts was run with -M parameter (multi-mapping reads are counted).
A heatmap of selected gene expression values in a set of
normal tissues calculated by counting or discarding
multi-mapped reads. If values_only = TRUE
, gene expression values
are returned instead.
normal_tissue_expression_multimapping( genes = c("GAGE13", "CT45A6", "NXF2", "SSX2", "CTAG1A", "MAGEA3", "MAGEA6"), multimapping = FALSE) normal_tissue_expression_multimapping( genes = c("GAGE13", "CT45A6", "NXF2", "SSX2", "CTAG1A", "MAGEA3", "MAGEA6"), multimapping = TRUE)
normal_tissue_expression_multimapping( genes = c("GAGE13", "CT45A6", "NXF2", "SSX2", "CTAG1A", "MAGEA3", "MAGEA6"), multimapping = FALSE) normal_tissue_expression_multimapping( genes = c("GAGE13", "CT45A6", "NXF2", "SSX2", "CTAG1A", "MAGEA3", "MAGEA6"), multimapping = TRUE)
Plots a heatmap of mean promoter methylation levels of any genes in normal tissues. Methylation levels in tissues correspond to the mean methylation of CpGs located in range of 1000 pb upstream and 200 pb downstream from gene TSS.
normal_tissues_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE, na.omit = TRUE )
normal_tissues_mean_methylation( genes = NULL, include_CTP = FALSE, values_only = FALSE, na.omit = TRUE )
genes |
|
include_CTP |
|
values_only |
|
na.omit |
|
Heatmap of mean promoter methylation of any
gene in normal tissues. If values_only = TRUE
, methylation values
are returned instead.
normal_tissues_mean_methylation() normal_tissues_mean_methylation(c("MAGEA1", "MAGEA2", "MAGEA3", "MAGEA4")) normal_tissues_mean_methylation(c("MAGEA1", "MAGEA2", "MAGEA3", "MAGEA4"), na.omit = FALSE)
normal_tissues_mean_methylation() normal_tissues_mean_methylation(c("MAGEA1", "MAGEA2", "MAGEA3", "MAGEA4")) normal_tissues_mean_methylation(c("MAGEA1", "MAGEA2", "MAGEA3", "MAGEA4"), na.omit = FALSE)
Plots a heatmap of the methylation of CpGs located in a promoter, in normal tissues. X-axis corresponds to the CpGs position (related to TSS).
normal_tissues_methylation( gene, nt_up = 1000, nt_down = 200, values_only = FALSE )
normal_tissues_methylation( gene, nt_up = 1000, nt_down = 200, values_only = FALSE )
gene |
Name of selected gene |
nt_up |
Number of nucleotides upstream the TSS to analyse (by default 1000, maximum value 5000) |
nt_down |
Number of nucleotides downstream the TSS to analyse (by default 200, maximum value 5000) |
values_only |
Boolean (FALSE by default). If set to TRUE, the function will return the methylation values of all cytosines in the promoter instead of the heatmap. |
Heatmap of the methylation of CpGs located in a
promoter, in normal tissues. If values_only
= TRUE, methylation values are
returned instead.
normal_tissues_methylation(gene = "TDRD1", 1000, 0)
normal_tissues_methylation(gene = "TDRD1", 1000, 0)
Plots a heatmap of genes expression in oocytes, using scRNAseq data from "Decoding dynamic epigenetic landscapes in human oocytes using single-cell multi-omics sequencing" (Yan et al. Cell Stem Cell 2021)
oocytes_expression( genes = NULL, include_CTP = FALSE, ncells_max = 200, scale_lims = NULL, values_only = FALSE )
oocytes_expression( genes = NULL, include_CTP = FALSE, ncells_max = 200, scale_lims = NULL, values_only = FALSE )
genes |
|
include_CTP |
|
ncells_max |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in single cells from human
oocytes. If values_only = TRUE
, a SingleCellExperiment is returned instead.
## Not run: oocytes_expression(include_CTP = FALSE, ncells_max = 100, values_only = FALSE) ## End(Not run)
## Not run: oocytes_expression(include_CTP = FALSE, ncells_max = 100, values_only = FALSE) ## End(Not run)
Creates a Dataframe giving for each TCGA sample, the methylation level of a gene (mean methylation of probes located in its promoter) and the expression level of the gene (TPM value).
prepare_TCGA_methylation_expression( tumor = "all", gene = NULL, nt_up = NULL, nt_down = NULL, include_normal_tissues = FALSE )
prepare_TCGA_methylation_expression( tumor = "all", gene = NULL, nt_up = NULL, nt_down = NULL, include_normal_tissues = FALSE )
tumor |
|
gene |
|
nt_up |
|
nt_down |
|
include_normal_tissues |
|
a Dataframe giving for each TCGA sample, the methylation level of a gene (mean methylation of probes located in its promoter) and the expression level of the gene (TPM value). The number of probes used to estimate the methylation level is also reported.
## Not run: CTexploreR:::prepare_TCGA_methylation_expression("LUAD", gene = "TDRD1") ## End(Not run)
## Not run: CTexploreR:::prepare_TCGA_methylation_expression("LUAD", gene = "TDRD1") ## End(Not run)
Gives the fontsize to use for the heatmap based on the matrix's dimension.
set_fontsize(matrix)
set_fontsize(matrix)
matrix |
|
A logical number that is the fontsize to use
CTexploreR:::set_fontsize(matrix(1:3, 9,8))
CTexploreR:::set_fontsize(matrix(1:3, 9,8))
Check the presence of the genes in the database then subsets the database to only keep these genes' data.
subset_database(variable = NULL, data, include_CTP = FALSE)
subset_database(variable = NULL, data, include_CTP = FALSE)
variable |
|
data |
|
include_CTP |
|
A Summarized Experiment
or SingleCellExperiment
object with
only the variables data
CTexploreR:::subset_database(variable = "MAGEA1", data = CTdata::GTEX_data())
CTexploreR:::subset_database(variable = "MAGEA1", data = CTdata::GTEX_data())
Plots a heatmap of genes expression in TCGA samples (peritumoral and tumor samples when a specific tumor type is specified, or tumor samples only when tumor option is set to "all")
TCGA_expression( tumor = "all", genes = NULL, include_CTP = FALSE, units = c("TPM", "log_TPM"), values_only = FALSE )
TCGA_expression( tumor = "all", genes = NULL, include_CTP = FALSE, units = c("TPM", "log_TPM"), values_only = FALSE )
tumor |
|
genes |
|
include_CTP |
|
units |
|
values_only |
|
A heatmap of selected CT genes expression in TCGA samples.
If values_only = TRUE
, TPM expression data is returned instead.
## Not run: TCGA_expression( tumor = "LUAD", genes = c("MAGEA1", "MAGEA3"), units = "log_TPM") ## End(Not run)
## Not run: TCGA_expression( tumor = "LUAD", genes = c("MAGEA1", "MAGEA3"), units = "log_TPM") ## End(Not run)
Plots the correlation between methylation and expression values of a gene in TCGA samples.
TCGA_methylation_expression_correlation( tumor = "all", gene = NULL, nt_up = 1000, nt_down = 200, min_probe_number = 3, include_normal_tissues = FALSE, values_only = FALSE )
TCGA_methylation_expression_correlation( tumor = "all", gene = NULL, nt_up = 1000, nt_down = 200, min_probe_number = 3, include_normal_tissues = FALSE, values_only = FALSE )
tumor |
|
gene |
|
nt_up |
|
nt_down |
|
min_probe_number |
|
include_normal_tissues |
|
values_only |
|
The coefficient of correlation is set to NA
if no probes
are found in promoter regions or if less than 1% of tumors are
positive (TPM >= 1) for the gene.
A scatter plot representing for each TCGA sample, gene expression
and mean methylation values of probe(s) located in its promoter region
(defined as 1000 nucleotides upstream TSS and 200 nucleotides downstream
TSS by default). If values_only = TRUE
, methylation and expression values
are returned in a tibble instead.
## Not run: TCGA_methylation_expression_correlation("LUAD", gene = "TDRD1") ## End(Not run)
## Not run: TCGA_methylation_expression_correlation("LUAD", gene = "TDRD1") ## End(Not run)
Plots a heatmap of genes expression in the different types of testis cells, using scRNAseq data from "The adult human testis transcriptional cell atlas" (Guo et al. 2018)
testis_expression( cells = c("all", "germ_cells", "somatic_cells", "SSC", "Spermatogonia", "Early_spermatocyte", "Late_spermatocyte", "Round_spermatid", "Elongated_spermatid", "Sperm1", "Sperm2", "Macrophage", "Endothelial", "Myoid", "Sertoli", "Leydig"), genes = NULL, include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
testis_expression( cells = c("all", "germ_cells", "somatic_cells", "SSC", "Spermatogonia", "Early_spermatocyte", "Late_spermatocyte", "Round_spermatid", "Elongated_spermatid", "Sperm1", "Sperm2", "Macrophage", "Endothelial", "Myoid", "Sertoli", "Leydig"), genes = NULL, include_CTP = FALSE, scale_lims = NULL, values_only = FALSE )
cells |
|
genes |
|
include_CTP |
|
scale_lims |
|
values_only |
|
A heatmap of selected CT genes expression in single cells from adult
testis. If values_only = TRUE
, a SingleCellExperiment is returned
instead.
## Not run: testis_expression(cells = "germ_cells", genes = c("MAGEA1", "MAGEA3", "MAGEA4")) ## End(Not run)
## Not run: testis_expression(cells = "germ_cells", genes = c("MAGEA1", "MAGEA3", "MAGEA4")) ## End(Not run)