1
|
Osabe T, Shimizu K, Kadota K. Differential expression analysis using a model-based gene clustering algorithm for RNA-seq data. BMC Bioinformatics 2021; 22:511. [PMID: 34670485 PMCID: PMC8527798 DOI: 10.1186/s12859-021-04438-4] [Citation(s) in RCA: 8] [Impact Index Per Article: 2.0] [Reference Citation Analysis] [Abstract] [Key Words] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 09/24/2020] [Accepted: 10/11/2021] [Indexed: 11/10/2022] Open
Abstract
Background RNA-seq is a tool for measuring gene expression and is commonly used to identify differentially expressed genes (DEGs). Gene clustering is used to classify DEGs with similar expression patterns for the subsequent analyses of data from experiments such as time-courses or multi-group comparisons. However, gene clustering has rarely been used for analyzing simple two-group data or differential expression (DE). In this study, we report that a model-based clustering algorithm implemented in an R package, MBCluster.Seq, can also be used for DE analysis. Results The input data originally used by MBCluster.Seq is DEGs, and the proposed method (called MBCdeg) uses all genes for the analysis. The method uses posterior probabilities of genes assigned to a cluster displaying non-DEG pattern for overall gene ranking. We compared the performance of MBCdeg with conventional R packages such as edgeR, DESeq2, and TCC that are specialized for DE analysis using simulated and real data. Our results showed that MBCdeg outperformed other methods when the proportion of DEG (PDEG) was less than 50%. However, the DEG identification using MBCdeg was less consistent than with conventional methods. We compared the effects of different normalization algorithms using MBCdeg, and performed an analysis using MBCdeg in combination with a robust normalization algorithm (called DEGES) that was not implemented in MBCluster.Seq. The new analysis method showed greater stability than using the original MBCdeg with the default normalization algorithm. Conclusions MBCdeg with DEGES normalization can be used in the identification of DEGs when the PDEG is relatively low. As the method is based on gene clustering, the DE result includes information on which expression pattern the gene belongs to. The new method may be useful for the analysis of time-course and multi-group data, where the classification of expression patterns is often required. Supplementary Information The online version contains supplementary material available at 10.1186/s12859-021-04438-4.
Collapse
Affiliation(s)
- Takayuki Osabe
- Graduate School of Agricultural and Life Sciences, The University of Tokyo, Yayoi 1-1-1, Bunkyo-ku, Tokyo, 113-8657, Japan
| | - Kentaro Shimizu
- Graduate School of Agricultural and Life Sciences, The University of Tokyo, Yayoi 1-1-1, Bunkyo-ku, Tokyo, 113-8657, Japan.,Collaborative Research Institute for Innovative Microbiology, The University of Tokyo, Yayoi 1-1-1, Bunkyo-ku, Tokyo, 113-8657, Japan.,Interfaculty Initiative in Information Studies, The University of Tokyo, Hongo 7-3-1, Bunkyo-ku, Tokyo, 113-0033, Japan
| | - Koji Kadota
- Graduate School of Agricultural and Life Sciences, The University of Tokyo, Yayoi 1-1-1, Bunkyo-ku, Tokyo, 113-8657, Japan. .,Collaborative Research Institute for Innovative Microbiology, The University of Tokyo, Yayoi 1-1-1, Bunkyo-ku, Tokyo, 113-8657, Japan. .,Interfaculty Initiative in Information Studies, The University of Tokyo, Hongo 7-3-1, Bunkyo-ku, Tokyo, 113-0033, Japan.
| |
Collapse
|
2
|
Righelli D, Angelini C. Easyreporting simplifies the implementation of Reproducible Research layers in R software. PLoS One 2021; 16:e0244122. [PMID: 33970927 PMCID: PMC8109797 DOI: 10.1371/journal.pone.0244122] [Citation(s) in RCA: 0] [Impact Index Per Article: 0] [Reference Citation Analysis] [Abstract] [MESH Headings] [Grants] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 12/01/2020] [Accepted: 04/20/2021] [Indexed: 11/19/2022] Open
Abstract
During last years "irreproducibility" became a general problem in omics data analysis due to the use of sophisticated and poorly described computational procedures. For avoiding misleading results, it is necessary to inspect and reproduce the entire data analysis as a unified product. Reproducible Research (RR) provides general guidelines for public access to the analytic data and related analysis code combined with natural language documentation, allowing third-parties to reproduce the findings. We developed easyreporting, a novel R/Bioconductor package, to facilitate the implementation of an RR layer inside reports/tools. We describe the main functionalities and illustrate the organization of an analysis report using a typical case study concerning the analysis of RNA-seq data. Then, we show how to use easyreporting in other projects to trace R functions automatically. This latter feature helps developers to implement procedures that automatically keep track of the analysis steps. Easyreporting can be useful in supporting the reproducibility of any data analysis project and shows great advantages for the implementation of R packages and GUIs. It turns out to be very helpful in bioinformatics, where the complexity of the analyses makes it extremely difficult to trace all the steps and parameters used in the study.
Collapse
Affiliation(s)
- Dario Righelli
- Department of Statistical Sciences, University of Padova, Padua, Italy
- Istituto per le Applicazioni del Calcolo “Mauro Picone”, National Research Council, Naples, Italy
- * E-mail: (DR); (CA)
| | - Claudia Angelini
- Istituto per le Applicazioni del Calcolo “Mauro Picone”, National Research Council, Naples, Italy
- * E-mail: (DR); (CA)
| |
Collapse
|
3
|
Del Prete E, Facchiano A, Profumo A, Angelini C, Romano P. GeenaR: A Web Tool for Reproducible MALDI-TOF Analysis. Front Genet 2021; 12:635814. [PMID: 33854526 PMCID: PMC8039533 DOI: 10.3389/fgene.2021.635814] [Citation(s) in RCA: 5] [Impact Index Per Article: 1.3] [Reference Citation Analysis] [Abstract] [Key Words] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 11/30/2020] [Accepted: 03/01/2021] [Indexed: 12/21/2022] Open
Abstract
Mass spectrometry is a widely applied technology with a strong impact in the proteomics field. MALDI-TOF is a combined technology in mass spectrometry with many applications in characterizing biological samples from different sources, such as the identification of cancer biomarkers, the detection of food frauds, the identification of doping substances in athletes’ fluids, and so on. The massive quantity of data, in the form of mass spectra, are often biased and altered by different sources of noise. Therefore, extracting the most relevant features that characterize the samples is often challenging and requires combining several computational methods. Here, we present GeenaR, a novel web tool that provides a complete workflow for pre-processing, analyzing, visualizing, and comparing MALDI-TOF mass spectra. GeenaR is user-friendly, provides many different functionalities for the analysis of the mass spectra, and supports reproducible research since it produces a human-readable report that contains function parameters, results, and the code used for processing the mass spectra. First, we illustrate the features available in GeenaR. Then, we describe its internal structure. Finally, we prove its capabilities in analyzing oncological datasets by presenting two case studies related to ovarian cancer and colorectal cancer. GeenaR is available at http://proteomics.hsanmartino.it/geenar/.
Collapse
Affiliation(s)
- Eugenio Del Prete
- Institute for Applied Mathematics, National Research Council, Naples, Italy
| | - Angelo Facchiano
- Institute of Food Sciences, National Research Council, Avellino, Italy
| | - Aldo Profumo
- Proteomica e Spettrometria di Massa, IRCCS Ospedale Policlinico San Martino IST, Genova, Italy
| | - Claudia Angelini
- Institute for Applied Mathematics, National Research Council, Naples, Italy
| | - Paolo Romano
- Proteomica e Spettrometria di Massa, IRCCS Ospedale Policlinico San Martino IST, Genova, Italy
| |
Collapse
|
4
|
Cirino A, Aurigemma I, Franzese M, Lania G, Righelli D, Ferrentino R, Illingworth E, Angelini C, Baldini A. Chromatin and Transcriptional Response to Loss of TBX1 in Early Differentiation of Mouse Cells. Front Cell Dev Biol 2020; 8:571501. [PMID: 33015063 PMCID: PMC7505952 DOI: 10.3389/fcell.2020.571501] [Citation(s) in RCA: 4] [Impact Index Per Article: 0.8] [Reference Citation Analysis] [Abstract] [Key Words] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 06/11/2020] [Accepted: 08/18/2020] [Indexed: 12/19/2022] Open
Abstract
The T-box transcription factor TBX1 has critical roles in the cardiopharyngeal lineage and the gene is haploinsufficient in DiGeorge syndrome, a typical developmental anomaly of the pharyngeal apparatus. Despite almost two decades of research, if and how TBX1 function triggers chromatin remodeling is not known. Here, we explored genome-wide gene expression and chromatin remodeling in two independent cellular models of Tbx1 loss of function, mouse embryonic carcinoma cells P19Cl6, and mouse embryonic stem cells (mESCs). The results of our study revealed that the loss or knockdown of TBX1 caused extensive transcriptional changes, some of which were cell type-specific, some were in common between the two models. However, unexpectedly we observed only limited chromatin changes in both systems. In P19Cl6 cells, differentially accessible regions (DARs) were not enriched in T-BOX binding motifs; in contrast, in mESCs, 34% (n = 47) of all DARs included a T-BOX binding motif and almost all of them gained accessibility in Tbx1 -/- cells. In conclusion, despite a clear transcriptional response of our cell models to loss of TBX1 in early cell differentiation, chromatin changes were relatively modest.
Collapse
Affiliation(s)
- Andrea Cirino
- Department of Molecular Medicine and Medical Biotechnologies, University of Naples Federico II, Naples, Italy
- Institute of Genetics and Biophysics, National Research Council, Naples, Italy
| | - Ilaria Aurigemma
- Department of Molecular Medicine and Medical Biotechnologies, University of Naples Federico II, Naples, Italy
- Department of Chemistry and Biology, University of Salerno, Fisciano, Italy
| | - Monica Franzese
- Institute Applicazioni del Calcolo, National Research Council, Naples, Italy
| | - Gabriella Lania
- Institute of Genetics and Biophysics, National Research Council, Naples, Italy
| | - Dario Righelli
- Department of Chemistry and Biology, University of Salerno, Fisciano, Italy
| | - Rosa Ferrentino
- Institute of Genetics and Biophysics, National Research Council, Naples, Italy
| | | | - Claudia Angelini
- Institute Applicazioni del Calcolo, National Research Council, Naples, Italy
| | - Antonio Baldini
- Department of Molecular Medicine and Medical Biotechnologies, University of Naples Federico II, Naples, Italy
- Institute of Genetics and Biophysics, National Research Council, Naples, Italy
| |
Collapse
|
5
|
Lambert I, Paysant-Le Roux C, Colella S, Martin-Magniette ML. DiCoExpress: a tool to process multifactorial RNAseq experiments from quality controls to co-expression analysis through differential analysis based on contrasts inside GLM models. PLANT METHODS 2020; 16:68. [PMID: 32426025 PMCID: PMC7216733 DOI: 10.1186/s13007-020-00611-7] [Citation(s) in RCA: 26] [Impact Index Per Article: 5.2] [Reference Citation Analysis] [Abstract] [Key Words] [Grants] [Track Full Text] [Subscribe] [Scholar Register] [Received: 12/23/2019] [Accepted: 05/03/2020] [Indexed: 05/08/2023]
Abstract
BACKGROUND RNAseq is nowadays the method of choice for transcriptome analysis. In the last decades, a high number of statistical methods, and associated bioinformatics tools, for RNAseq analysis were developed. More recently, statistical studies realised neutral comparison studies using benchmark datasets, shedding light on the most appropriate approaches for RNAseq data analysis. RESULTS DiCoExpress is a script-based tool implemented in R that includes methods chosen based on their performance in neutral comparisons studies. DiCoExpress uses pre-existing R packages including FactoMineR, edgeR and coseq, to perform quality control, differential, and co-expression analysis of RNAseq data. Users can perform the full analysis, providing a mapped read expression data file and a file containing the information on the experimental design. Following the quality control step, the user can move on to the differential expression analysis performed using generalized linear models thanks to the automated contrast writing function. A co-expression analysis is implemented using the coseq package. Lists of differentially expressed genes and identified co-expression clusters are automatically analyzed for enrichment of annotations provided by the user. We used DiCoExpress to analyze a publicly available RNAseq dataset on the transcriptional response of Brassica napus L. to silicon treatment in plant roots and mature leaves. This dataset, including two biological factors and three replicates for each condition, allowed us to demonstrate in a tutorial all the features of DiCoExpress. CONCLUSIONS DiCoExpress is an R script-based tool allowing users to perform a full RNAseq analysis from quality controls to co-expression analysis through differential analysis based on contrasts inside generalized linear models. DiCoExpress focuses on the statistical modelling of gene expression according to the experimental design and facilitates the data analysis leading the biological interpretation of the results.
Collapse
Affiliation(s)
- Ilana Lambert
- LSTM, Laboratoire des Symbioses Tropicales et Méditerranéennes, IRD, CIRAD, INRAE, SupAgro, Univ Montpellier, Montpellier, France
| | - Christine Paysant-Le Roux
- Institute of Plant Sciences Paris-Saclay (IPS2), Université Paris-Saclay, CNRS, INRAE, Univ Evry, Bat. 630, 91405 Orsay, France
- Institute of Plant Sciences Paris Saclay (IPS2), Université de Paris, CNRS, INRAE, Bat. 630, 91405 Orsay, France
| | - Stefano Colella
- LSTM, Laboratoire des Symbioses Tropicales et Méditerranéennes, IRD, CIRAD, INRAE, SupAgro, Univ Montpellier, Montpellier, France
| | - Marie-Laure Martin-Magniette
- Institute of Plant Sciences Paris-Saclay (IPS2), Université Paris-Saclay, CNRS, INRAE, Univ Evry, Bat. 630, 91405 Orsay, France
- Institute of Plant Sciences Paris Saclay (IPS2), Université de Paris, CNRS, INRAE, Bat. 630, 91405 Orsay, France
- UMR MIA-Paris, AgroParisTech, INRAE, Université Paris-Saclay, 75005 Paris, France
| |
Collapse
|
6
|
Di Filippo L, Righelli D, Gagliardi M, Matarazzo MR, Angelini C. HiCeekR: A Novel Shiny App for Hi-C Data Analysis. Front Genet 2019; 10:1079. [PMID: 31749839 PMCID: PMC6844183 DOI: 10.3389/fgene.2019.01079] [Citation(s) in RCA: 9] [Impact Index Per Article: 1.5] [Reference Citation Analysis] [Abstract] [Key Words] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 07/19/2019] [Accepted: 10/09/2019] [Indexed: 01/14/2023] Open
Abstract
The High-throughput Chromosome Conformation Capture (Hi-C) technique combines the power of the Next Generation Sequencing technologies with chromosome conformation capture approach to study the 3D chromatin organization at the genome-wide scale. Although such a technique is quite recent, many tools are already available for pre-processing and analyzing Hi-C data, allowing to identify chromatin loops, topological associating domains and A/B compartments. However, only a few of them provide an exhaustive analysis pipeline or allow to easily integrate and visualize other omic layers. Moreover, most of the available tools are designed for expert users, who have great confidence with command-line applications. In this paper, we present HiCeekR (https://github.com/lucidif/HiCeekR), a novel R Graphical User Interface (GUI) that allows researchers to easily perform a complete Hi-C data analysis. With the aid of the Shiny libraries, it integrates several R/Bioconductor packages for Hi-C data analysis and visualization, guiding the user during the entire process. Here, we describe its architecture and functionalities, then illustrate its capabilities using a publicly available dataset.
Collapse
Affiliation(s)
- Lucio Di Filippo
- Telethon Institute of Genetics and Medicine (TIGEM), Pozzuoli, Italy
| | - Dario Righelli
- Istituto per le Applicazioni del Calcolo "Mauro Picone," Consiglio Nazionale delle Ricerche, Napoli, Italy
| | - Miriam Gagliardi
- Max Planck Institute for Psychiatry, Munich, Germany.,Institute of Genetics and Biophysics "A. Buzzati A. Traverso," Consiglio Nazionale delle Ricerche, Napoli, Italy
| | - Maria Rosaria Matarazzo
- Institute of Genetics and Biophysics "A. Buzzati A. Traverso," Consiglio Nazionale delle Ricerche, Napoli, Italy
| | - Claudia Angelini
- Istituto per le Applicazioni del Calcolo "Mauro Picone," Consiglio Nazionale delle Ricerche, Napoli, Italy
| |
Collapse
|
7
|
López-Fernández H, Blanco-Míguez A, Fdez-Riverola F, Sánchez B, Lourenço A. DEWE: A novel tool for executing differential expression RNA-Seq workflows in biomedical research. Comput Biol Med 2019; 107:197-205. [PMID: 30849608 DOI: 10.1016/j.compbiomed.2019.02.021] [Citation(s) in RCA: 7] [Impact Index Per Article: 1.2] [Reference Citation Analysis] [Abstract] [Key Words] [Track Full Text] [Journal Information] [Subscribe] [Scholar Register] [Received: 11/22/2018] [Revised: 02/21/2019] [Accepted: 02/21/2019] [Indexed: 01/31/2023]
Abstract
BACKGROUND Transcriptomics profiling aims to identify and quantify all transcripts present within a cell type or tissue at a particular state, and thus provide information on the genes expressed in specific experimental settings, differentiation or disease conditions. RNA-Seq technology is becoming the standard approach for such studies, but available analysis tools are often hard to install, configure and use by users without advanced bioinformatics skills. METHODS Within reason, DEWE aims to make RNA-Seq analysis as easy for non-proficient users as for experienced bioinformaticians. DEWE supports two well-established and widely used differential expression analysis workflows: using Bowtie2 or HISAT2 for sequence alignment; and, both applying StringTie for quantification, and Ballgown and edgeR for differential expression analysis. Also, it enables the tailored execution of individual tools as well as helps with the management and visualisation of differential expression results. RESULTS DEWE provides a user-friendly interface designed to reduce the learning curve of less knowledgeable users while enabling analysis customisation and software extension by advanced users. Docker technology helps overcome installation and configuration hurdles. In addition, DEWE produces high quality and publication-ready outputs in the form of tab-delimited files and figures, as well as helps researchers with further analyses, such as pathway enrichment analysis. CONCLUSIONS The abilities of DEWE are exemplified here by practical application to a comparative analysis of monocytes and monocyte-derived dendritic cells, a study of clinical relevance. DEWE installers and documentation are freely available at https://www.sing-group.org/dewe.
Collapse
Affiliation(s)
- Hugo López-Fernández
- ESEI: Escuela Superior de Ingeniería Informática, University of Vigo, Edificio Politécnico, Campus Universitario As Lagoas s/n, 32004, Ourense, Spain; CINBIO - Centro de Investigaciones Biomédicas, University of Vigo, Campus Universitario Lagoas-Marcosende, 36310, Vigo, Spain; SING Research Group, Galicia Sur Health Research Institute (IIS Galicia Sur), SERGAS-UVIGO, Hospital Álvaro Cunqueiro, 36312, Vigo, Spain; Universidade do Porto, Rua Alfredo Allen, 208, 4200-135, Porto, Portugal; Instituto de Biologia Molecular e Celular (IBMC), Rúa Alfredo Allen, 208, 4200-135, Porto, Portugal
| | - Aitor Blanco-Míguez
- ESEI: Escuela Superior de Ingeniería Informática, University of Vigo, Edificio Politécnico, Campus Universitario As Lagoas s/n, 32004, Ourense, Spain; CINBIO - Centro de Investigaciones Biomédicas, University of Vigo, Campus Universitario Lagoas-Marcosende, 36310, Vigo, Spain; Department of Microbiology and Biochemistry of Dairy Products, Instituto de Productos Lácteos de Asturias (IPLA), Consejo Superior de Investigaciones Científicas (CSIC), Paseo Río Linares s/n, 33300, Villaviciosa, Asturias, Spain
| | - Florentino Fdez-Riverola
- ESEI: Escuela Superior de Ingeniería Informática, University of Vigo, Edificio Politécnico, Campus Universitario As Lagoas s/n, 32004, Ourense, Spain; CINBIO - Centro de Investigaciones Biomédicas, University of Vigo, Campus Universitario Lagoas-Marcosende, 36310, Vigo, Spain; SING Research Group, Galicia Sur Health Research Institute (IIS Galicia Sur), SERGAS-UVIGO, Hospital Álvaro Cunqueiro, 36312, Vigo, Spain
| | - Borja Sánchez
- Department of Microbiology and Biochemistry of Dairy Products, Instituto de Productos Lácteos de Asturias (IPLA), Consejo Superior de Investigaciones Científicas (CSIC), Paseo Río Linares s/n, 33300, Villaviciosa, Asturias, Spain
| | - Anália Lourenço
- ESEI: Escuela Superior de Ingeniería Informática, University of Vigo, Edificio Politécnico, Campus Universitario As Lagoas s/n, 32004, Ourense, Spain; CINBIO - Centro de Investigaciones Biomédicas, University of Vigo, Campus Universitario Lagoas-Marcosende, 36310, Vigo, Spain; SING Research Group, Galicia Sur Health Research Institute (IIS Galicia Sur), SERGAS-UVIGO, Hospital Álvaro Cunqueiro, 36312, Vigo, Spain; CEB - Centre of Biological Engineering, University of Minho, Campus de Gualtar, 4710-057, Braga, Portugal.
| |
Collapse
|
8
|
Hughes LD, Lewis SA, Hughes ME. ExpressionDB: An open source platform for distributing genome-scale datasets. PLoS One 2017; 12:e0187457. [PMID: 29095940 PMCID: PMC5667849 DOI: 10.1371/journal.pone.0187457] [Citation(s) in RCA: 9] [Impact Index Per Article: 1.1] [Reference Citation Analysis] [Abstract] [MESH Headings] [Grants] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 05/10/2017] [Accepted: 10/22/2017] [Indexed: 11/18/2022] Open
Abstract
RNA-sequencing (RNA-seq) and microarrays are methods for measuring gene expression across the entire transcriptome. Recent advances have made these techniques practical and affordable for essentially any laboratory with experience in molecular biology. A variety of computational methods have been developed to decrease the amount of bioinformatics expertise necessary to analyze these data. Nevertheless, many barriers persist which discourage new labs from using functional genomics approaches. Since high-quality gene expression studies have enduring value as resources to the entire research community, it is of particular importance that small labs have the capacity to share their analyzed datasets with the research community. Here we introduce ExpressionDB, an open source platform for visualizing RNA-seq and microarray data accommodating virtually any number of different samples. ExpressionDB is based on Shiny, a customizable web application which allows data sharing locally and online with customizable code written in R. ExpressionDB allows intuitive searches based on gene symbols, descriptions, or gene ontology terms, and it includes tools for dynamically filtering results based on expression level, fold change, and false-discovery rates. Built-in visualization tools include heatmaps, volcano plots, and principal component analysis, ensuring streamlined and consistent visualization to all users. All of the scripts for building an ExpressionDB with user-supplied data are freely available on GitHub, and the Creative Commons license allows fully open customization by end-users. We estimate that a demo database can be created in under one hour with minimal programming experience, and that a new database with user-supplied expression data can be completed and online in less than one day.
Collapse
Affiliation(s)
- Laura D. Hughes
- Division of Pulmonary and Critical Care Medicine, Washington University School of Medicine, St. Louis, Missouri, United States of America
| | - Scott A. Lewis
- Division of Pulmonary and Critical Care Medicine, Washington University School of Medicine, St. Louis, Missouri, United States of America
| | - Michael E. Hughes
- Division of Pulmonary and Critical Care Medicine, Washington University School of Medicine, St. Louis, Missouri, United States of America
- * E-mail:
| |
Collapse
|
9
|
Costa V, Righelli D, Russo F, De Berardinis P, Angelini C, D'Apice L. Distinct Antigen Delivery Systems Induce Dendritic Cells' Divergent Transcriptional Response: New Insights from a Comparative and Reproducible Computational Analysis. Int J Mol Sci 2017; 18:ijms18030494. [PMID: 28245601 PMCID: PMC5372510 DOI: 10.3390/ijms18030494] [Citation(s) in RCA: 8] [Impact Index Per Article: 1.0] [Reference Citation Analysis] [Abstract] [Key Words] [MESH Headings] [Track Full Text] [Download PDF] [Figures] [Journal Information] [Subscribe] [Scholar Register] [Received: 01/05/2017] [Revised: 02/11/2017] [Accepted: 02/21/2017] [Indexed: 12/17/2022] Open
Abstract
Vaccination is the most successful and cost-effective method to prevent infectious diseases. However, many vaccine antigens have poor in vivo immunogenic potential and need adjuvants to enhance immune response. The application of systems biology to immunity and vaccinology has yielded crucial insights about how vaccines and adjuvants work. We have previously characterized two safe and powerful delivery systems derived from non-pathogenic prokaryotic organisms: E2 and fd filamentous bacteriophage systems. They elicit an in vivo immune response inducing CD8+ T-cell responses, even in absence of adjuvants or stimuli for dendritic cells’ maturation. Nonetheless, a systematic and comparative analysis of the complex gene expression network underlying such activation is missing. Therefore, we compared the transcriptomes of ex vivo isolated bone marrow-derived dendritic cells exposed to these antigen delivery systems. Significant differences emerged, especially for genes involved in innate immunity, co-stimulation, and cytokine production. Results indicate that E2 drives polarization toward the Th2 phenotype, mainly mediated by Irf4, Ccl17, and Ccr4 over-expression. Conversely, fd-scαDEC-205 triggers Th1 T cells’ polarization through the induction of Il12b, Il12rb, Il6, and other molecules involved in its signal transduction. The data analysis was performed using RNASeqGUI, hence, addressing the increasing need of transparency and reproducibility of computational analysis.
Collapse
Affiliation(s)
- Valerio Costa
- Institute of Genetics and Biophysics "Adriano Buzzati-Traverso", CNR, Via P. Castellino 111, 80131 Naples, Italy.
| | - Dario Righelli
- Dipartimento di Scienze Aziendali-Management & Innovation Systems/DISA-MIS, University of Salerno, Via Giovanni Paolo II 132, 84084 Fisciano (SA), Italy.
- Istituto per le Applicazioni del Calcolo, CNR, Via P. Castellino 111, 80131 Naples, Italy.
| | - Francesco Russo
- Istituto per le Applicazioni del Calcolo, CNR, Via P. Castellino 111, 80131 Naples, Italy.
- Institute of Protein Biochemistry, Consiglio Nazionale delle Ricerche, Via P. Castellino 111, 80131 Naples, Italy.
| | - Piergiuseppe De Berardinis
- Institute of Protein Biochemistry, Consiglio Nazionale delle Ricerche, Via P. Castellino 111, 80131 Naples, Italy.
| | - Claudia Angelini
- Istituto per le Applicazioni del Calcolo, CNR, Via P. Castellino 111, 80131 Naples, Italy.
| | - Luciana D'Apice
- Institute of Protein Biochemistry, Consiglio Nazionale delle Ricerche, Via P. Castellino 111, 80131 Naples, Italy.
| |
Collapse
|