#PAGE_PARAMS# #ADS_HEAD_SCRIPTS# #MICRODATA#

Quartet-based inference of cell differentiation trees from ChIP-Seq histone modification data


Authors: Nazifa Ahmed Moumi aff001;  Badhan Das aff001;  Zarin Tasnim Promi aff001;  Nishat Anjum Bristy aff001;  Md. Shamsuzzoha Bayzid aff001
Authors place of work: Department of Computer Science and Engineering, Bangladesh University of Engineering and Technology, Dhaka, Bangladesh aff001
Published in the journal: PLoS ONE 14(9)
Category: Research Article
doi: https://doi.org/10.1371/journal.pone.0221270

Summary

Understanding cell differentiation—the process of generation of distinct cell-types—plays a pivotal role in developmental and evolutionary biology. Transcriptomic information and epigenetic marks are useful to elucidate hierarchical developmental relationships among cell-types. Standard phylogenetic approaches such as maximum parsimony, maximum likelihood and neighbor joining have previously been applied to ChIP-Seq histone modification data to infer cell-type trees, showing how diverse types of cells are related. In this study, we demonstrate the applicability and suitability of quartet-based phylogenetic tree estimation techniques for constructing cell-type trees. We propose two quartet-based pipelines for constructing cell phylogeny. Our methods were assessed for their validity in inferring hierarchical differentiation processes of various cell-types in H3K4me3, H3K27me3, H3K36me3, and H3K27ac histone mark data. We also propose a robust metric for evaluating cell-type trees.

Keywords:

analýza hlavních komponent – Epigenetics – Phylogenetics – Phylogenetic analysis – Cell differentiation – Blood – Fibroblasts – Lung development

Introduction

Cellular differentiation is one of the key aspects of developmental biology. Cell differentiation is known to be a hierarchical process where totipotent cell-types become more specialized cell-types [1, 2]. Thus, the relationship of cell-types is expected to form a tree-like structure [3, 4]. This hypothetical tree-like relationship of cell-types in ontogeny and phylogeny is called a “cell-type tree” [5, 6].

The changes of gene expression patterns during cellular differentiation are recorded as epigenetic changes in the genome [3, 7]. Epigenetic and transcription factors play a vital role in cell differentiation since all cell-types in an individual organism have the same genome [810]. Histone modification creates one important class in epigenetic marks which have been found to vary across different cell-types and play an important role in gene regulation [11]. Histone modifications such as methylation, acetylation, phosphorylation, ubiquitination alter their interactions with the DNA and thereby influence transcription and genomic function [11]. A study of the change in histone marks across various cell-types can help us understand how cell differentiation occurs [12]. Since the development of the sister cell-types is the same up to the last stages of differentiation [1], evolutionary relatedness of cell-types is expected to be congruent with the ontogenetic hierarchy of cellular differentiation [13]. Therefore, constructing and analyzing cell-type trees could play an important role in our understanding of developmental biology and how cell differentiation occurs [6, 14, 15].

The process of elucidating the hierarchical developmental relationships among cell-types depends on extremely laborious experiments involving in vitro differentiation of cell-types from various stem cell-types [1618]. Fortunately, the propitious advancement in sequencing technologies has enabled us to capture transcriptomic and epigenetic information at various developmental stages [4]. Considering the hypothesis about the tree-like structure of the cell differentiation process, various techniques from phylogenetic tree estimation have been adapted to form cell-type trees by leveraging various sequence data (e.g., ChIP-Seq, RNA-seq).

The application of traditional phylogenetic tree estimation methods (maximum likelihood (ML), maximum-parsimony (MP) and neighbor joining (NJ)) have previously been applied for building cell-type trees [14, 15]. These studies underscore the usefulness of phylogenetic tree estimation techniques for reconstructing the hierarchical process of cell differentiation. ML-based technique was shown to be a better technique than MP and NJ. In this paper, we demonstrate the usefulness of quartet-based tree estimation methods in the context of cell-type trees. Quartet based phylogenetic tree estimation is very popular and highly accurate since quartet is a statistically consistent estimate of the true species phylogeny despite gene tree heterogeneity due to the presence of incomplete lineage sorting [19, 20]. Quartet based methods are robust to the “anomaly zone” [20, 21] (a condition where there could be gene tree topologies that are more likely than the one that has the same topology as the species tree) as there are no anomalous unrooted four-taxon species trees [19, 20]. Thus, various quartet-based techniques have been developed and are being widely used due to their excellent accuracy [2226].

In this study, we attempt to leverage the theoretical and practical advantages of quartet-based techniques in constructing the cell-type trees. We propose two pipelines for inferring cell-type trees: 1) Induced Quartet Amalgamation (IQA), and 2) Most Likely Quartet Amalgamation (MLQA). Both these pipelines start with estimating quartets (in two different ways) from ChIP-Seq data and then amalgamate the quartets to construct cell-type trees. We performed an extensive experimental study using H3K4me3, H3K27me3 and H3K36me3 histone modification data, and compared our techniques with ML-based technique. Unlike previous studies, we included both the normal and cancerous cell-types to examine the power and applicability of phylogenetic methods in analyzing both kinds. We also proposed a new evaluation criterion to evaluate the cell-type trees which is more robust than the evaluation metrics used in previous studies [14, 15], especially in the presence of “alien” cell-types within a cluster of a particular cell-type. This can happen either because the data do not have enough phylogenetic information to clearly distinguish the cell-types or due to the presence of “rogue taxa”—some taxa that are relatively unstable in phylogenetic analyses [2729]. Rogue taxa assume varying phylogenetic positions in a collection of trees and thus have negative impact in phylogenetic analyses, especially in estimating consensus history [28, 29]. Finally, we conclude that quartet-based phylogenetic tree estimation can be considered as a useful and robust technique for inferring cell-type trees.

Materials and methods

Data preprocessing

Histone marks are found in every 200 base pair length of DNA [15]. ChIP-Seq is a technology which records histone modification throughout the whole genome. It is assumed that histone marks can be independently gained or lost in regions of the genome during cell differentiation [6].

ChIP-Seq data are converted into peak data where the peak signifies presence of histone marks in the genome. Similar to previous studies [6], we used peak lists as the raw data for our study. We represent the data based on the presence or absence of peaks at any given position and treat this as a binary character. One can use any peak finder, such as MACS (Model-based analysis of ChIP-Seq [30]), PeakSeq [31], Hotspot [32], to convert the ChIP-Seq histone modification libraries into peaks. We used the publicly available peaks given by the ENCODE project (for H3K4me3, H3K27me3, H3k36me3) and CISTROME DB [33] (for H3K27ac) in our analysis. Previous studies [6] introduced two different data representations: 1) Windowing representation and 2) Overlap representation. In windowing representation, a ChIP-Seq library (a cell-type) is divided into bins of certain sizes, and each of the bins are coded as either 1 or 0 depending on whether there exist at least one peak in a bin. In overlap data representation, all ChIP-Seq libraries are taken into account at once and “interesting regions” based on genome peaks are identified (see [6] for details). Considering each peak as an interval on the genome, the interval graph is defined by all peaks in all libraries. An interval graph has one vertex for each interval and an edge between two vertices when the corresponding intervals overlap [34]. With these representation techniques, ChIP-Seq libraries are represented as strings of 0s and 1s. In this study, we used the overlap representation since no notable difference was found between these two techniques in terms of the reliability of the cell-type trees, and overlap representation was preferred in previous studies for its compactness [6, 15].

We wrote necessary scripts in C++, Perl and Python to implement our proposed methods (available at https://github.com/Moumiiiiii/cell-differentiation-trees). The scripts for overlap representation was obtained from the authors (Nair et al. [6]). We used QFM [23] to amalgamate quartets (as described in the following section). The code for QFM was obtained from the authors (Reaz et al. [23]).

Overview of the quartet-based pipelines

Quartet is an unrooted tree with four taxa. We denote a quartet by q = ab|cd, where the internal edge in q separates a and b from c and d (meaning that ab|cd is the bipartition defined by the internal edge in q). Unlike previous studies [6, 15] that used maximum-parsimony, maximum-likelihood or neighbor joining method on the binary data matrix obtained from the ChIP-Seq libraries, we estimate quartets—representing the evolutionary history of four cell-types. For a collection of n cell-types, we estimate a set of ( n 4 ) quartets (one for each group of 4 cell-types). We generate this set of ( n 4 ) quartets in two different ways (referred to as IQA and MLQA, and are described in subsequent sections). Finally, we amalgamate these quartets to get a single coherent tree on n cell-types. A quartet q is consistent with a tree when the tree has an internal edge that separates the same pairs of taxa as in q. Note that it may not always be possible to find a tree which is consistent with all the ( n 4 ) quartets. In that case, we try to find a tree such that maximum number of quartets are consistent with it. This is an NP-hard problem [35], but efficient methods such as QFM [23] and QMC [24] are available for quartet amalgamation. We used QFM since it was shown to have better accuracy compared to QMC [23]. However, QMC is faster than QFM and we recommend QMC in case the dataset is too large for QFM to analyze. Fig 1 illustrates our proposed methodologies for quartet-based cell-type tree construction.

Illustration of the methodology for quartet-based cell-type tree construction.
Fig. 1. Illustration of the methodology for quartet-based cell-type tree construction.
We begin with the binary data matrix resulted from the ChIP-Seq data libraries using the overlap representation. Next, we generate a set of ( n 4 ) quartets in two different ways. Finally, we amalgamate these quartets using QFM [23].

Induced Quartet Amalgamation (IQA)

Given a binary data matrix M on n cell-types obtained from the overlap representation, we consider all possible combinations of 4 cell-types and thus have a collection of ( n 4 ) groups. For each group of 4 cell-types, we generate a data matrix Mi (1 ≤ i ≤ ( n 4 )) which contains four rows corresponding to the four cell-types. Next, for each Mi, we estimate a quartet using maximum-likelihood approach. For this purpose, we used RAxML [36]. Thus we have a set of ( n 4 ) induced quartets from M. Finally, we combine these quartets using QFM to estimate a tree on n cell-types.

Most Likely Quartet Amalgamation (MLQA)

For each group of 4 taxa (a, b, c, d), there are three different quartet topologies: ((a, b), (c, d)), ((a, c), (b, d)) and ((a, d), (b, c)). Thus, there are 3 * ( n 4 ) possible quartets on n cell-types. In MLQA, we generate all these quartets and their associated likelihood values (with respect to M) using RAxML. Next, from the three different quartet topologies on four cell-types, we retain the one which has the highest likelihood value. In this way we have a collection of ( n 4 ) quartets. Finally, we combine these most likely quartets using QFM to get a single cell-type tree.

Experimental studies

Dataset

Histone modification ChIP-Seq data was collected from the ENCODE database [37]. We used H3K4me3, H3k27me3, H3k36me3 and H3K27ac dataset. The histone modification peak data was obtained from the ENCODE database and CISTROME DB [33]. Although the differentiation process of cancerous cell-types differ from normal cell-types, we considered both normal and cancerous cell-types to determine how phylogenetic approaches perform under various cell differentiation processes. All the cell-types used for the experimentation process are listed in Table 1. We used two replicates for most of the cell-types except for HCFaa, HFF, and CD14 since the ENCODE database contains only one replicate for these cell-types. We have data from different timestamps (day 0, 2, 5, 9, 14) of differentiation process for human Embryonic Stem cell-types (hESC). So we denote by H7_hESC_T5 the data from day 5.

Tab. 1. Cell-types, short description, and general group for H3K4me3, H3K27me3, H3K36me3, and H3K27ac data.
Cell-types, short description, and general group for H3K4me3, H3K27me3, H3K36me3, and H3K27ac data.

Evaluation criteria

To evaluate the estimated cell-type trees, total number of cell-types in a subtree that belong to a particular group was considered by Nair et al. [6, 15]. Since the cell-types within a particular group (e.g., Fibroblast, Epithelial, etc.) can be scattered across multiple subtrees, the two largest subtrees were considered for each cell-type. The larger this quantity is for a certain approach, the better its performance is for that particular cell-type. We note that this metric tends to be very sensitive towards a single intrusion of an alien cell-type of a different group within a subtree since it considers the clades containing only a particular group of cell-types. Therefore, we have introduced a new metric (α), which takes the relative abundance of a particular group of cell-type in a clade compared to the other groups of cell-types. A formal definition of the α ratio is as follows.


Higher values of α ratio indicate better clustering of the same cell-types (α = 1 indicates that there is a clade that contains only the cell-types within a particular group). This evaluation metric is comparatively more tolerant towards an intrusion of alien cell-types within a cluster of a particular cell-type. For better understanding of our proposed α ratio, we have shown an example in Fig 2. The cell-type tree in this figure contains three different groups of cell-types (F1F8, Ep1Ep4, and B1B3). For the eight Fibroblast cell-types, the two largest clades containing only Fibroblast cell-types are of size 2 ((F1, F2) and (F7, F8)). Thus, according to the metric used in previous studies, the evaluation measure for the Fibroblast cell is (2,2). This result gives a misleading impression of the Fibroblast cell-types being scattered sparsely. This happened because of the intrusion of a single Epithelial cell within a clade that contains all the eight Fibroblast types. On the other hand, the α ratio for this cell-type is 8 9, implying that all the eight Fibroblast cell-types were contained in a subtree with nine cell-types. So the α ratio rightly shows that the result is not as bad as the first metric indicated.

Example for <i>α</i> ratio.
Fig. 2. Example for α ratio.
One Eplithelial (EP1) cell-type has been placed within a subtree containing all the Fibroblast cell-types (F1F8). Thus the largest subtree containing only Fibroblast cell-types is 2.

Thus, the α ratio along with the previous metric used in [6] can better elucidate the relative accuracy of various estimated cell-type trees. We have considered this ratio for groups with substantial numbers of cell-types (mostly Fibroblast and Epithelial), since for the other groups with small numbers of cell-types, α ratio may not be required to get a better understanding of the relative performance.

Results and discussion

Results on H3K4me3 dataset

Trimethylation of Histone H3 at Lysine 4 (H3K4me3) is a well studied histone mark which is associated with transcription start sites of active genes [38]. We analyzed both replicate 1 and 2 for H3k4me3 dataset. Replicate 1 includes 37 cell-types and replicate 2 includes 34 cell-types of 8 different groups. We did not consider both the replicates together as the combined dataset becomes prohibitively large (in terms of computational time and space complexity) to analyze as we have to consider 3*(713) quartets. This dataset does not contain any cancerous cell-type.

Replicate 1

Cell-type tree was constructed using overlap representation from the histone mark of the 37 cell-types. Fig 3 shows the trees constructed by three approaches (ML, IQA and MLQA) with color coding to clearly differentiate various groups of cell-types. In general, we can observe that similar types of cell-types tend to form a clade. For example, all the hESC cell-types are placed inside a single subtree and are clustered together. Moreover, even within this subtree in IQA tree, cell-types from day 9 and day 14 are clustered together and are separated from the subtree that includes day 0, 2 and 5; whereas cell-types from day 5, 9, 14 and cell-types from day 0, 2 are clustered separately in two adjacent subtrees in MLQA approach and ML based approach.

Cell-type trees on H3K4me3 (replicate 1).
Fig. 3. Cell-type trees on H3K4me3 (replicate 1).
(a) IQA approach, (b) MLQA approach, and (c) ML approach.

Table 2 shows the number of cell-types belonging to the largest and the second-largest clusters for a particular cell-type. Ideally one group should include all of the cell-types and the other should have zero member (just like hESC group) to exhibit their tendency in clustering together. However, it is not necessarily the case for some of the cell-types. While hESC, Skeletal muscle, Blood, Myocytes, and Astrocytes were clustered ideally for IQA approach, all of the 8, 2 and 16 Epithelial, Endothelial and Fibroblast cell-types were not clustered together. Likewise, in MLQA approach, we can observe ideal clustering for hESC, Skeletal muscle, Blood and Myocytes. But it failed to cluster 2 cell-types from Astrocytes. But it is noteworthy from Fig 3 that, a single Epithelial cell (HCPEpiC) has entered within the Fibroblast cluster in IQA approach, in absence of which, IQA tree would have a (15,1) pair for this dataset. Similar trends hold for MLQA and ML trees. In MLQA tree, HCPEpiC has been placed within a cluster of Fibroblast cell-types, and in ML tree HCPEpiC is not clustered with other Epithelial cell-types.

Tab. 2. Groupings for cell-type trees on H3K4me3 (replicate 1) data using various phylogenetic approaches.
Groupings for cell-type trees on H3K4me3 (replicate 1) data using various phylogenetic approaches.

In order to investigate this unstable placement of some cell-types, we performed Principal Component Analysis (PCA) [39] on the overlap representation of the histone modification data. PCA reduces the dimensionality of the data while retaining most of the variation in the dataset by identifying directions, called principal components, along which the variation in the data is maximal [39]. In the PCA plot in Fig 4, we plotted the cell-types along PC1 and PC2 (two principal components that captures the largest and the second largest amounts of variance). PCA analysis reflects that the histone mark data of HCPEpiC is indeed more closely related to the Fibroblast cell-types than it is to the other Epithelial cell-types. PCA analysis also explains the placement of two Endothelial cell-types in two separate clusters as the PCA plot clearly shows that these two cell-types are not closely related according to the data from histone modification. Moreover, PCA analyses support the groupings of the hESC and Blood cell-types (as recovered by most of the the phylogenetic approaches) without the intrusion of any alien entity. Therefore, phylogenetic methods are able to capture the variability in the histone modification data.

PCA performed on H3K4me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
Fig. 4. PCA performed on H3K4me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
(a) 9 closely clustered cell-types that include 8 Fibroblast cell-types and one alien Epithelial cell-type are selected from the 37 cell-types in a rectangular box. It is notable that this intruder Epithelial cell-type (HCPEpiC) is the same one from the cluster of 15 Fibroblast cell-types in the tree (Fig 3) generated using IQA approach. This observation reflects a deeper similitude between the cell-type tree using IQA based approach and the PCA for this dataset. (b) 9 cell-types from (a) are zoomed in for a comprehensible view.

We now compare the trees in terms of the α ratio (see Table 3). We considered α ratio for two cell groups: Epithelial and Fibroblast. Since the other cell-types in different groups are clustered together or lacks substantial numbers of cell-types in them, they are not considered for being analyzed with the α ratio. For each cell group, we first show the α ratio for the largest subtrees that contain only the cell-types of a particular group. Then we gradually increase the number of cell-types from that group and consider the smallest clade required to house those numbers of cell-types. The largest clades in the ML, MLQA and IQA trees that contain only cell-types from Epithelial group have 6, 5, and 4 cell-types, respectively. Next, as we increase the number of cell-types, it takes a subtree of 13 cell-types for IQA to accommodate 5 Epithelial cell-types. Next, to house 7 cell-types, IQA needs a subtree of 16 entities. Finally, to include all the 8 Epithelial cell-types, it takes a subtree of 27 cell-types. Similarly, we show the α ratio for the three approaches for both Epithelial and Fibroblast groups. MLQA approach takes a subtree with 29 cell-types to accommodate 8 Epithelial cell-types whereas ML based method takes a subtree of 22 cell-types and IQA approach takes a subtree with 27 cell-types. Therefore, the Epithelial cell-types are more closely related in IQA approach and ML based approach than they are in the MLQA based approach. The relevance and strength of the α ratio in assessing the quality of cell-type trees is more prominent when we looked at the Fibroblast cell-types. Although MLQA seemed to be performing very poorly on Fibroblast group (see Table 2) with (6,2) groupings compared to the ML-based technique with (15,1) groupings, we can see that MLQA takes a subtree of 22 cell-types to cluster all the 16 Fibroblast cell-types whereas ML tree takes 26 cell-types. Similar trend holds for IQA which takes 16 cell-types to house 15 Fibroblast cell-types (just one more than the ML tree), but reconstructs a clade with 24 cell-types (which is 2 less than the ML tree) containing all the 16 Fibroblast cell-types. Thus α ratio enables us to evaluate cell-type trees by looking at various numbers of cell-types within a particular cell-type group and gives a better understanding about the relative performance.

Tab. 3. α ratio for various cell-type trees on H3K4me3 (replicate 1) data.
<i>α</i> ratio for various cell-type trees on H3K4me3 (replicate 1) data.

We also looked at how similar cell-types from different tissue types are related to each other and observed interesting and biologically meaningful relationships. HUVEC (which is an endothelial cell) was placed as a sister to the clade containing CD14 and CD20 (blood type). This placement seems to be biologically meaningful as HUVEC is from blood vessel and CD14 and CD20 are from blood tissue. Another important observation is that, among the fibroblast cell-types, those that are from lung tissue (AG04450, NHLF and HPF) are clustered together. We note that WI_38 and WI_38_TAM—two cell-types from embryonic lung tissue—are sister in the ML tree, but they are not sister in the IQA tree. Interestingly, in the IQA tree, WI_38 was placed as a sister to the clade containing NHLF and HPF that are also from lung tissue. Similarly, the fibroblast cell-types from the skin and foreskin tissues tend to be grouped together. Moreover, cell-types from heart (HCFaa, HCF, HCM) and blood vessel (HPAF, HBMEC) appear to be closely related. Among the epithelial cell-types, those that are from epithelium tissue tend to form a cluster. Moreover, all the cells from embryonic stem cell tissue type are placed within a single clade. Similar trends are observed for other dataset as well, and thus are not detailed in the subsequent sections.

Fig 5 shows the trees constructed by IQA, MLQA and ML on replicate 2. All these trees ideally placed the hESC, Skeletal Muscles, Blood and Myocytes cell-types in separate clusters. In addition to these, IQA and MLQA clustered the Astrocytes cell-types together, where ML tree failed to put them together in a single cluster. ML tree produced better groupings for the 12 cell-types in the Fibroblast group by placing 8 of them in a single subtree (see Table 4). However, if we look at the intermediate α values in Table 5, IQA and MLQA are in fact better than ML as they take smaller subtrees to group various numbers of cell-types than ML tree. When we consider all the 12 Fibroblast cell-types, the α ratio is same for all these three methods. Similar to replicate 1, we performed PCA analysis which is consistent with the placement of the cell-types in the trees (see Fig 6).

Cell-type trees for H3K4me3 (replicate 2).
Fig. 5. Cell-type trees for H3K4me3 (replicate 2).
(a) IQA approach, (b) MLQA approach, and (c) ML approach.
PCA on H3K4me3 (replicate 2) and corresponding scores are plotted on PC1 and PC2.
Fig. 6. PCA on H3K4me3 (replicate 2) and corresponding scores are plotted on PC1 and PC2.
(a) 7 closely clustered cell-types including Fibroblast cell-types and one alien Epithelial cell (HCPEpiC) are selected from the 34 cell-types in a rectangular box. This particular Epithelial cell-type was placed within a subtree containing the Fibroblast cell-types in the cell-type trees estimated by all three methods (see Fig 5). (b) 7 cell-types from (a) are zoomed in for a comprehensible view.
Tab. 4. Groupings for cell-type trees on H3K4me3 (replicate 2) data.
Groupings for cell-type trees on H3K4me3 (replicate 2) data.
Tab. 5. α ratio for cell-type trees on H3K4me3 (replicate 2) data.
<i>α</i> ratio for cell-type trees on H3K4me3 (replicate 2) data.

In terms of grouping the 9 Epithelial cell-types, MLQA is better than IQA and ML since it placed 7 of them in a single cluster. Likewise, for grouping 8 Fibroblast cell-types, MLQA took substantially less number of cell-types compared to ML (14 for MLQA and 22 for ML tree). However, when we considered all the 9 Epithelial cell-types, ML and IQA achieved better α values than MLQA.

H3K27me3 dataset

Histone H3 lysine 27 trimethylation (H3K27me3) is an important epigenetic mark which is associated with the downregulation of genes [40]. Thus, it acts in opposition to H3K4me3 which is associated with gene activation [41]. Replicate 1 from this dataset has 20 cell-types which contains both the normal and cancerous cell-types and replicate 1 and 2 together has 37 cell-types.

Replicate 1

Fig 7 shows the ML, IQA and MLQA estimated trees on the 5 cell-type groups from replicate 1. All these methods are comparable in terms of grouping various cell-types. IQA tree is better than ML and MLQA since it did a better job in grouping the Blood and Epithelial cell-types (see Table 6). All these methods performed poorly on the Epithelial cell-types as the size of the largest cluster with only the Epithelial cell-types is 2. Table 7 shows the similarity among these three approaches in terms of the α ratio for Epithelial group. Note that all these methods take a subtree with 9 cell-types to group 6 (out of 8) Epithelial cell-types. However, to accommodate all the 8 cell-types, the size of the subtree was increased to 13.

Cell-type trees on H3K27me3 (replicate 1).
Fig. 7. Cell-type trees on H3K27me3 (replicate 1).
(a) IQA approach, (b) MLQA approach, and (c) ML approach.
Tab. 6. Groupings for cell-type trees on H3K27me3 (replicate 1) data.
Groupings for cell-type trees on H3K27me3 (replicate 1) data.
Tab. 7. α ratio for cell-type trees on H3K27me3 (replicate 1) data.
<i>α</i> ratio for cell-type trees on H3K27me3 (replicate 1) data.

We can see from Table 6 that IQA approach outperforms the other two on the cell-types from Blood (the largest cluster in IQA tree contains 2 cell-types whereas the other two trees contain only 1 cell-type). Likewise, for Epithelial group, IQA and ML based approaches perform slightly better than the MLQA approach. For the remaining groups, these three approaches show identical clustering. PCA analysis on this data is shown in Fig 8 which strongly support our findings from the cell-type trees estimated by various approaches.

PCA on H3K27me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
Fig. 8. PCA on H3K27me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
(a) 12 closely clustered cell-types are selected from the 20 cell-types in a rectangular box. (b) 12 cell-types from (a) are zoomed in for a comprehensible view which helps us note that these 12 includes 2 Fibroblast cell-types just like the cell-type trees from all three approaches in Fig 7. Here 2 Fibroblast cell-types (BJ and AG04450) are located close to the cluster of 3 Blood cell-types and 8 Epithelial cell-types. 7 cell-types from these 12 are similarly enclosed in a rectangle for further investigation. (c) 7 cell-types from (b) are zoomed in and annotated where we can see 2 Blood cell-types (K562 and GM06990) are closely related to 5 Epithelial cell-types which is a nearly similar scenario for the corresponding trees as well.

Replicate 1 and 2

IQA and ML trees are very similar except that ML tree is slightly better on the Blood cell-types. The MLQA approach reconstructs a slightly worse tree in terms of grouping the Epithelial cell-types (see Fig 9 and Table 8). The other two methods (IQA and ML) also performed poorly on Epithelial cell-types as they were able to cluster only 3 cell-types in the largest cluster.

Cell-type trees on H3K27me3 (replicate 1 and 2).
Fig. 9. Cell-type trees on H3K27me3 (replicate 1 and 2).
(a) IQA approach, (b) MLQA approach and (c) ML approach.
Tab. 8. Groupings for cell-type trees on H3K27me3 (replicate 1 and 2) data.
Groupings for cell-type trees on H3K27me3 (replicate 1 and 2) data.

Fig 9 shows that while IQA approach succeeds in clustering hESC and Endothelial cell-types, ML based approach showed slightly better performance for Epithelial and Blood cell-types. MLQA estimated tree is comparatively worse than the other two trees. All the approaches exhibited poor performance on the Epithelial group. There are 15 cell-types in this group but all the approaches were able to cluster only 3 cell-types in the largest subtree.

Table 9 shows α ratio for Epithelial group and it is noteworthy that a similar performance degradation (as we observed on Replicate 1) was observed when we considered all the cell-types. For 14 cell-types of this group, IQA approach provides the smallest α value. Yet, while adding the 15th, ML based approach achieved a smaller value of α than IQA and MLQA. PCA analyses are demonstrated in Fig 10 which support the findings from the cell-type trees. We note that the cancerous cell-types from Epithelial group (Hela(1), Hela(2) and HepG2) and Blood group (K562(1), K562(2) and GM06990) are closely related both in the cell-type trees and in the PCA plot.

Tab. 9. α ratio for cell-type trees on H3K27me3 (replicate 1 and 2) data.
<i>α</i> ratio for cell-type trees on H3K27me3 (replicate 1 and 2) data.
PCA on H3K27me3 (replicate 1 and 2) and corresponding scores are plotted on PC1 and PC2.
Fig. 10. PCA on H3K27me3 (replicate 1 and 2) and corresponding scores are plotted on PC1 and PC2.
(a) 23 closely clustered cell-types including Blood, Epithelial and Fibroblast cell-types are selected from the 37 cell-types in a rectangular box. (b) Upon zooming in the 23 cell-types from (a), we can see that 3 Fibroblast cell-types (BJ(1), BJ(2) and AG04450) have entered into the cluster comprising Epithelial and Blood cell-types which is an identical situation to the clustering tendencies exhibited in the cell-type trees in Fig 9. 6 cell-types from these 23 are similarly enclosed in a rectangle for further investigation. (c) 6 cell-types from (b) are zoomed in and annotated. Close relationships among the the cancerous cell-types from Epithelial group (Hela(1), Hela(2) and HepG2) and the cancerous cell-types from Blood group (K562(1), K562(2) and GM06990) are suggested by both the PCA plot and the cell-type trees.

Comparative analyses on H3k4me3 and H3K27me3

We compared the trees estimated on H3K4me3 with the trees estimated on H3K27me3. We observed that the relationships between various cell-types are consistent between these two dataset. Similar cell-types tend to group together with a few exceptions (as described in previous sections). Moreover, cell-types from the same tissue type tend to form clusters on both H3k4me3 and H3K27me3. The similarity of results between the two dataset reinforces our opinion and the results from previous studies [1, 6, 13] that phylogenetic analyses yield biologically meaningful results on such data.

H3K36me3 dataset

H3K36me3 (Histone H3 lysine 36 methylation) is a histone modification involved in epigenetic regulation and is a common epigenetic mark [42]. The modifications of H3K36 are very diverse and play roles in many important biological processes such as DNA replication, transcription, recombination and repair of DNA damage [43]. This dataset (replicate 1) includes 17 cell-types. Fig 11 shows the trees estimated by ML, IQA and MLQA. The performance metrics are shown in Tables 10 and 11. PCA plot is shown in Fig 12. In general, the relative performance of these three methods are similar to what we observed on the previous two datasets (H3K4me3 and H3K27me3).

Cell-type trees on H3K36me3 (replicate 1).
Fig. 11. Cell-type trees on H3K36me3 (replicate 1).
(a) IQA approach, (b) MLQA approach, and (c) ML based approach.
PCA on H3K36me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
Fig. 12. PCA on H3K36me3 (replicate 1) and corresponding scores are plotted on PC1 and PC2.
(a) 11 closely clustered cell-types that include Blood, Epithelial and Fibroblast are selected from the 17 cell-types in a rectangular box. (b) When these 11 cell-types from (a) are zoomed in, it becomes evident that BJ from Fibroblast and GM06990, GM12878 and K562 from Blood are intruders in the Epithelial cluster which is a comparable scenario with the Epithelial clusters from the cell-type trees in Fig 11.
Tab. 10. Groupings for cell-type trees on H3K36me3 (replicate 1) data.
Groupings for cell-type trees on H3K36me3 (replicate 1) data.
Tab. 11. α ratio for cell-type trees on H3K36me3 (replicate 1) data.
<i>α</i> ratio for cell-type trees on H3K36me3 (replicate 1) data.

H3K27ac dataset

Enhancer is an active regulatory element in genome which can affect gene transcription [44]. We analyzed H3K27ac as it is an important enhancer mark and computed cell-type trees using IQA, MLQA and ML based approaches (Fig 13). This dataset contains 22 cells of 4 different types (Epithelial, Fibroblast, Blood and Endothelial). The performance of various methods on H3K27ac dataset is demonstrated in Tables 12 and 13 and Fig 13. The experimental results show that, similar to our observation on other dataset, the proposed phylogenetic approaches can construct meaningful trees on histone acetylation data since they tend to cluster the similar cell-types together. Table 12 reflects the fact that IQA tree clusters Epithelial cell-lines better than the other two approaches. MLQA tree fails to cluster all Blood cell-lines in one sub-tree devoid of any alien cell-lines. ML based approach performed slightly better than IQA and MLQA on Fibroblas cell-types as the largest Fibroblast clade in ML tree contains 4 cell-types, whereas for IQA and MLQA approaches, this value is 3. Table 13 shows the alpha ratio for Epithelial and Fibroblast groups. We have not included Blood in this table since both IQA and ML approaches were able to cluster this group in an ideal manner.

Cell-type trees for H3K27ac.
Fig. 13. Cell-type trees for H3K27ac.
(a) IQA approach (b) MLQA approach and (c) ML approach.
Tab. 12. Groupings for cell-type trees on H3K27ac data.
Groupings for cell-type trees on H3K27ac data.
Tab. 13. α ratio for cell-type trees on H3K27ac data.
<i>α</i> ratio for cell-type trees on H3K27ac data.

Combined analyses with H3k4me3 and H3K27me3

Combined analyses (also known as concatenation) is a traditional approach to species tree (a phylogenetic tree showing the evolutionary history of a group of species) estimation from multi-locus data. Combined analyses concatenates gene sequence alignments into a supergene matrix, and then estimates the species tree using a sequence based tree estimation technique (e.g., maximum parsimony, maximum likelihood, Bayesian analysis, etc.). Although combined analyses is not statistically consistent [45] and can return inaccurate trees with high confidence [4649], it has been used in many biological studies since it can construct highly accurate species trees by leveraging the high amount of phylogenetic signal from the combined supermatrix, especially when the degree of gene tree discordance is low [50, 51]. To demonstrate the applicability of combined analyses and thereby showing the feasibility of analyzing multiple egigenetic marks at the same time, we performed combined analyses on H3k4me3 and H3K27me3 data.

We selected these two epigenetic marks since they have the highest number of common cell-lines among the datasets that we have analysed in this study. There are 13 cells common to both these dataset. We combined the alignments containing 13 cell-lines, resulting from the overlapping representations of H3k4me3 and H3K27me3, into a supermatrix and analyzed the data using maximum likelihood and quartet based techniques.

We selected 13 common cell-types from these two marks and computed cell-type tree based on three approaches (IQA, MLQA and ML). The results from combined analyses show that the cell-type trees constructed from merged peak data of the same cell-lines from these two epigenetic marks appear to carry a meaningful clustering pattern. We can see from Fig 14 that, 5 cell-lines from hESC are always clustered together which is similar to the behavior of hESC clusters from the previous cell-type trees computed from individual epigenetic mark. Also, Tables 14 and 15 reflect the fact that, IQA and MLQA approaches outperforms ML based approach while clustering Epithelial cell-lines. For other cell-types, performance of all these methods are similar.

Cell-type trees estimated using combined analyses on H3K4me3 and H3K27me3.
Fig. 14. Cell-type trees estimated using combined analyses on H3K4me3 and H3K27me3.
(a) IQA approach, (b) MLQA approach, and (c) ML based approach.
Tab. 14. Groupings for cell-type trees estimated by combined analyses on H3K4me3 and H3K27me3.
Groupings for cell-type trees estimated by combined analyses on H3K4me3 and H3K27me3.
Tab. 15. α ratio for cell-type trees estimated by combined analyses on H3K4me3 and H3K27me3.
<i>α</i> ratio for cell-type trees estimated by combined analyses on H3K4me3 and H3K27me3.

These results demonstrate the feasibility of applying combined anslysis on multiple epigenetic marks. Although epigenetic marks can be modified relatively independently from each other which is similar to the independent evolution of multiple markers (genes) within a group of species [52], combined analyses on multiple epigenetic marks can be useful to elucidate the relationships among various cell-types.

Conclusions

We proposed two quartet-based phylogenetic tree construction methods to infer cell differentiation trees. Due to the growing awareness that phylogenetic tree estimation methods are useful in inferring processes of cell differentiation, various standard phylogenetic methods have been applied on various epigenetic information. The results of this study supported the validity of quartet-based approach (which is being widely used in constructing species trees from multi-locus data) for inferring reliable cell-type trees using ChIP-Seq histone modification data. We analyzed a collection of real biological data, containing both normal and cancerous cell-types with multiple replicates, to assess the performance of our proposed methods. Experimental results suggest that our methods can reconstruct meaningful cell-type trees. In this study, we also proposed a new metric to evaluate the reliability of cell-type trees.

Phylogenetic methods, in most of the cases, were successfully able to place similar cell-types together within a clade, but we observed a few cases (especially for Epithelial cell-types) where different cell-types from different groups were clustered together. PCA analyses of the overlap representation of the ChIP-Seq histone modification data suggest that this is possibly not due to any shortcomings of the phylogenetic tree estimation methods, rather the underlying data may not have sufficient information to clearly distinguish these cell-types. It could also be due to the close interaction and transition between cell-types [5355]. For example, Epithelial cells can give rise to Fibroblasts under certain conditions, which is known as epithelial-mesenchymal transition (EMT) [56, 57]. The reverse phenomenon, where Fibroblasts may give rise to Epithelial, a process called mesenchymal–epithelial transition (MET), is also possible [58, 59]. However, more rigorous experiments are required to further validate these hypotheses regarding the presence of different cell-types within the subtree of a particular group.

This study shows the strength and applicability of standard phylogenetic tree estimation techniques in supplementing the traditional laborious in vitro experiments for elucidating the relationships among various cell-types. Thus, we believe that the approaches presented in this study will help biologists and systematists to address various fundamental questions in cell development and differentiation. However, this study can be extended in several directions. Our proposed methods are applicable to other epigenetic marks (e.g., RNA-seq) as well given that we have an appropriate data representation (e.g., window and overlap representation) technique so we can apply various phylogenetic methods. Kin et al. [1] converted the expression data into qualitative data (expressed/non-expressed) and applied maximum parsimony based phylogenetic tree estimation method to construct cell-type trees from RNA-Seq data. Similarly, our techniques can be applied to the RNA-Seq data to infer cell differentiation trees. It would be interesting to analyze how various phylogenetic approaches perform on RNA-Seq data and to investigate what types of data representations are appropriate for various epigenetic marks. We leave this as a future work. Another important avenue is to investigate how to remove “batch effects”—the systematic error introduced when samples are processed in multiple batches. The batch effect may mislead the phylogenetic analysis, because it can inflate the correlations within the same batch [60]. However, it remains unclear to what extent batch effect may influence the phylogenetic analyses of the Chip-Seq data, and appropriate extensive simulation studies need to be designed and performed to better understand the impact of batch effects. One approach for eliminating the risk of batch effects is to perform the whole study in a single batch [60]. More sophisticated methods (for an example, principal variation component analysis (PVCA) [61, 62]) can be used to measure how much variation in the data is due to batch effects. Finally, proposing theoretical framework and mathematical basis for comparing various phylogenetic approaches for estimating cell-differentiation trees using epigenetic data would be important to understand the relative performance of various techniques under different realistic model conditions.


Zdroje

1. Kin K, Nnamani MC, Lynch VJ, Michaelides E, Wagner GP. Cell-type phylogenetics and the origin of endometrial stromal cells. Cell reports. 2015;10(8):1398–1409. doi: 10.1016/j.celrep.2015.01.062 25732829

2. Graf T, Enver T. Forcing cells to change lineages. Nature. 2009;462(7273):587. doi: 10.1038/nature08533 19956253

3. Koyanagi KO. Inferring cell differentiation processes based on phylogenetic analysis of genome-wide epigenetic information: hematopoiesis as a model case. Genome biology and evolution. 2015;7(3):699–705. doi: 10.1093/gbe/evv024 25638259

4. Gifford CA, Ziller MJ, Gu H, Trapnell C, Donaghey J, Tsankov A, et al. Transcriptional and epigenetic dynamics during specification of human embryonic stem cells. Cell. 2013;153(5):1149–1163. doi: 10.1016/j.cell.2013.04.037 23664763

5. Kin K. Inferring cell type innovations by phylogenetic methods—concepts, methods, and limitations. Journal of Experimental Zoology Part B: Molecular and Developmental Evolution. 2015;324(8):653–661. doi: 10.1002/jez.b.22657

6. Nair NU, Lin Y, Manasovska A, Antic J, Grnarova P, Sahu AD, et al. Study of cell differentiation by phylogenetic analysis using histone modification data. BMC bioinformatics. 2014;15(1):269. doi: 10.1186/1471-2105-15-269 25104072

7. Rivera CM, Ren B. Mapping human epigenomes. Cell. 2013;155(1):39–55. doi: 10.1016/j.cell.2013.09.011 24074860

8. Lee JH, Hart SRL, Skalnik DG. Histone deacetylase activity is required for embryonic stem cell differentiation. genesis. 2004;38(1):32–38. doi: 10.1002/gene.10250 14755802

9. Lister R, Pelizzola M, Kida YS, Hawkins RD, Nery JR, Hon G, et al. Hotspots of aberrant epigenomic reprogramming in human induced pluripotent stem cells. Nature. 2011;471(7336):68. doi: 10.1038/nature09798 21289626

10. Lobe CG. 9 Transcription Factors and Mammalian Development. In: Current topics in developmental biology. vol. 27. Elsevier; 1992. p. 351–383. doi: 10.1016/S0070-2153(08)60539-6

11. Berger SL. Histone modifications in transcriptional regulation. Current opinion in genetics & development. 2002;12(2):142–148. doi: 10.1016/S0959-437X(02)00279-4

12. Martin C, Zhang Y. Mechanisms of epigenetic inheritance. Current opinion in cell biology. 2007;19(3):266–272. doi: 10.1016/j.ceb.2007.04.002 17466502

13. Arendt D. The evolution of cell types in animals: emerging principles from molecular studies. Nature Reviews Genetics. 2008;9(11):868. doi: 10.1038/nrg2416 18927580

14. Nair NU, Lin Y, Bucher P, Moret BM. Phylogenetic analysis of cell types using histone modifications. In: International Workshop on Algorithms in Bioinformatics. Springer; 2013. p. 326–337.

15. Nair NU, Hunter L, Shao M, Grnarova P, Lin Y, Bucher P, et al. A maximum-likelihood approach for building cell-type trees by lifting. In: BMC genomics. vol. 17. BioMed Central; 2016. p. 14. doi: 10.1186/s12864-015-2297-3

16. Bryder D, Rossi DJ, Weissman IL. Hematopoietic stem cells: the paradigmatic tissue-specific stem cell. The American journal of pathology. 2006;169(2):338–346. doi: 10.2353/ajpath.2006.060312 16877336

17. Pronk CJ, Rossi DJ, Månsson R, Attema JL, Norddahl GL, Chan CKF, et al. Elucidation of the phenotypic, functional, and molecular topography of a myeloerythroid progenitor cell hierarchy. Cell stem cell. 2007;1(4):428–442. doi: 10.1016/j.stem.2007.07.005 18371379

18. Villadsen R, Fridriksdottir AJ, Rønnov-Jessen L, Gudjonsson T, Rank F, LaBarge MA, et al. Evidence for a stem cell hierarchy in the adult human breast. The Journal of cell biology. 2007;177(1):87–101. doi: 10.1083/jcb.200611114 17420292

19. Allman ES, Degnan JH, Rhodes JA. Identifying the Rooted Species Tree from the Distribution of Unrooted Gene Trees under the Coalescent. J Math Biol. 2011;62(6):833–862. doi: 10.1007/s00285-010-0355-7 20652704

20. Degnan JH. Anomalous unrooted gene trees. Systematic Biology. 2013;62(4):574–590. doi: 10.1093/sysbio/syt023 23576318

21. Degnan JH, Rosenberg NA. Discordance of species trees with their most likely gene trees. PLoS Genetics. 2006;2:762–768. doi: 10.1371/journal.pgen.0020068

22. Ané C, Larget B, Baum DA, Smith SD, Rokas A. Bayesian estimation of concordance among gene trees. Mol Biol Evol. 2007;24:412–426. doi: 10.1093/molbev/msl170 17095535

23. Reaz R, Bayzid MS, Rahman MS. Accurate phylogenetic tree reconstruction from quartets: A heuristic approach. PLoS One. 2014;9(8):e104008. doi: 10.1371/journal.pone.0104008 25117474

24. Snir S, Rao S. Quartets MaxCut: A Divide and Conquer Quartets Algorithm. IEEE/ACM Trans Comput Biol Bioinform. 2010;7(4):704–718. doi: 10.1109/TCBB.2008.133 21030737

25. Mirarab S, Reaz R, Bayzid MS, Zimmermann T, Swenson MS, Warnow T. ASTRAL: genome-scale coalescent-based species tree estimation. Bioinformatics. 2014;30(17):i541–i548. doi: 10.1093/bioinformatics/btu462 25161245

26. Avni E, Cohen R, Snir S. Weighted quartets phylogenetics. Systematic biology. 2014;64(2):233–242. doi: 10.1093/sysbio/syu087 25414175

27. Wilkinson M. Majority-rule reduced consensus trees and their use in bootstrapping. Molecular Biology and evolution. 1996;13(3):437–444. doi: 10.1093/oxfordjournals.molbev.a025604 8742632

28. Aberer AJ, Krompass D, Stamatakis A. Pruning rogue taxa improves phylogenetic accuracy: an efficient algorithm and webservice. Systematic biology. 2012;62(1):162–166. doi: 10.1093/sysbio/sys078 22962004

29. Aberer AJ, Stamatakis A. A simple and accurate method for rogue taxon identification. In: 2011 IEEE International Conference on Bioinformatics and Biomedicine. IEEE; 2011. p. 118–122.

30. Zhang Y, Liu T, Meyer CA, Eeckhoute J, Johnson DS, Bernstein BE, et al. Model-based analysis of ChIP-Seq (MACS). Genome biology. 2008;9(9):R137. doi: 10.1186/gb-2008-9-9-r137 18798982

31. Rozowsky J, Euskirchen G, Auerbach RK, Zhang ZD, Gibson T, Bjornson R, et al. PeakSeq enables systematic scoring of ChIP-seq experiments relative to controls. Nature biotechnology. 2009;27(1):66. doi: 10.1038/nbt.1518 19122651

32. John S, Sabo PJ, Thurman RE, Sung MH, Biddie SC, Johnson TA, et al. Chromatin accessibility pre-determines glucocorticoid receptor binding patterns. Nature genetics. 2011;43(3):264. doi: 10.1038/ng.759 21258342

33. Zheng R, Wan C, Mei S, Qin Q, Wu Q, Sun H, et al. Cistrome Data Browser: expanded datasets and new tools for gene regulatory analysis. Nucleic acids research. 2018;47(D1):D729–D735. doi: 10.1093/nar/gky1094

34. Fishburn PC. Interval orders and interval graphs: A study of partially ordered sets. John Wiley & Sons; 1985.

35. Steel M. The complexity of reconstructing trees from qualitative characters and subtrees. Journal of classification. 1992;9(1):91–116. doi: 10.1007/BF02618470

36. Stamatakis A. RAxML version 8: a tool for phylogenetic analysis and post-analysis of large phylogenies. Bioinformatics. 2014;30(9):1312–1313. doi: 10.1093/bioinformatics/btu033 24451623

37. Consortium EP, et al. A user’s guide to the encyclopedia of DNA elements (ENCODE). PLoS biology. 2011;9(4):e1001046. doi: 10.1371/journal.pbio.1001046

38. Benayoun BA, Pollina EA, Ucar D, Mahmoudi S, Karra K, Wong ED, et al. H3K4me3 breadth is linked to cell identity and transcriptional consistency. Cell. 2014;158(3):673–688. doi: 10.1016/j.cell.2014.06.027 25083876

39. Jolliffe I. Principal component analysis. Springer; 2011.

40. Ferrari KJ, Scelfo A, Jammula S, Cuomo A, Barozzi I, Stützer A, et al. Polycomb-dependent H3K27me1 and H3K27me2 regulate active transcription and enhancer fidelity. Molecular cell. 2014;53(1):49–62. doi: 10.1016/j.molcel.2013.10.030 24289921

41. Liu X, Wang C, Liu W, Li J, Li C, Kou X, et al. Distinct features of H3K4me3 and H3K27me3 chromatin domains in pre-implantation embryos. Nature. 2016;537(7621):558. doi: 10.1038/nature19362 27626379

42. Suzuki S, Murakami Y, Takahata S. H3K36 methylation state and associated silencing mechanisms. Transcription. 2017;8(1):26–31. doi: 10.1080/21541264.2016.1246076 27723431

43. Lee JS, Smith E, Shilatifard A. The language of histone crosstalk. Cell. 2010;142(5):682–685. doi: 10.1016/j.cell.2010.08.011 20813257

44. Creyghton MP, Cheng AW, Welstead GG, Kooistra T, Carey BW, Steine EJ, et al. Histone H3K27ac separates active from poised enhancers and predicts developmental state. Proceedings of the National Academy of Sciences. 2010;107(50):21931–21936. doi: 10.1073/pnas.1016071107

45. Roch S, Steel M. Likelihood-based tree reconstruction on a concatenation of aligned sequence data sets can be statistically inconsistent. Theoretical population biology. 2015;100:56–62. doi: 10.1016/j.tpb.2014.12.005

46. Kubatko LS, Degnan JH. Inconsistency of phylogenetic estimates from concatenated data under coalescence. Syst Biol. 2007;56:17. doi: 10.1080/10635150601146041 17366134

47. Edwards SV, Liu L, Pearl DK. High-resolution species trees without concatenation. Proceedings of the National Academy of Sciences. 2007;104(14):5936–5941. doi: 10.1073/pnas.0607004104

48. Leaché AD, Rannala B. The accuracy of species tree estimation under simulation: a comparison of methods. Syst Biol. 2011;60(2):126–137. doi: 10.1093/sysbio/syq073 21088009

49. DeGiorgio M, Degnan JH. Fast and consistent estimation of species trees using supermatrix rooted triples. Molecular biology and evolution. 2009;27(3):552–569. doi: 10.1093/molbev/msp250 19833741

50. Bayzid MS, Warnow T. Naive binning improves phylogenomic analyses. Bioinformatics. 2013;29(18):2277–2284. doi: 10.1093/bioinformatics/btt394 23842808

51. Mirarab S, Bayzid MS, Boussau B, Warnow T. Statistical binning enables an accurate coalescent-based estimation of the avian tree. Science. 2014;346(6215):1250463. doi: 10.1126/science.1250463 25504728

52. Maddison WP. Gene trees in species trees. Systematic Biology. 1997;46:523–536. doi: 10.1093/sysbio/46.3.523

53. Sakai N, Tager AM. Fibrosis of two: Epithelial cell-fibroblast interactions in pulmonary fibrosis. Biochimica et Biophysica Acta (BBA)-Molecular Basis of Disease. 2013;1832(7):911–921. doi: 10.1016/j.bbadis.2013.03.001

54. Iwano M, Plieth D, Danoff TM, Xue C, Okada H, Neilson EG. Evidence that fibroblasts derive from epithelium during tissue fibrosis. The Journal of clinical investigation. 2002;110(3):341–350. doi: 10.1172/JCI15518 12163453

55. Okada H, Danoff TM, Kalluri R, Neilson EG. Early role of Fsp1 in epithelial-mesenchymal transformation. American Journal of Physiology-Renal Physiology. 1997;273(4):F563–F574. doi: 10.1152/ajprenal.1997.273.4.F563

56. Hay ED. An overview of epithelio-mesenchymal transformation. Cells Tissues Organs. 1995;154(1):8–20. doi: 10.1159/000147748

57. Kalluri R, Weinberg RA. The basics of epithelial-mesenchymal transition. The Journal of clinical investigation. 2009;119(6):1420–1428. doi: 10.1172/JCI39104 19487818

58. Polyak K, Weinberg RA. Transitions between epithelial and mesenchymal states: acquisition of malignant and stem cell traits. Nature Reviews Cancer. 2009;9(4):265. doi: 10.1038/nrc2620 19262571

59. Hugo H, Ackland ML, Blick T, Lawrence MG, Clements JA, Williams ED, et al. Epithelial—mesenchymal and mesenchymal—epithelial transitions in carcinoma progression. Journal of cellular physiology. 2007;213(2):374–383. doi: 10.1002/jcp.21223 17680632

60. Gu X. Understanding tissue expression evolution: from expression phylogeny to phylogenetic network. Briefings in bioinformatics. 2015;17(2):249–254. doi: 10.1093/bib/bbv041 26141828

61. Scherer A. Batch effects and noise in microarray experiments: sources and solutions. vol. 868. John Wiley & Sons; 2009.

62. Chen C, Grennan K, Badner J, Zhang D, Gershon E, Jin L, et al. Removing batch effects in analysis of expression microarray data: an evaluation of six batch adjustment methods. PloS one. 2011;6(2):e17238. doi: 10.1371/journal.pone.0017238 21386892


Článok vyšiel v časopise

PLOS One


2019 Číslo 9
Najčítanejšie tento týždeň
Najčítanejšie v tomto čísle
Kurzy

Zvýšte si kvalifikáciu online z pohodlia domova

Získaná hemofilie - Povědomí o nemoci a její diagnostika
nový kurz

Eozinofilní granulomatóza s polyangiitidou
Autori: doc. MUDr. Martina Doubková, Ph.D.

Všetky kurzy
Prihlásenie
Zabudnuté heslo

Zadajte e-mailovú adresu, s ktorou ste vytvárali účet. Budú Vám na ňu zasielané informácie k nastaveniu nového hesla.

Prihlásenie

Nemáte účet?  Registrujte sa

#ADS_BOTTOM_SCRIPTS#