Skip to main content
  • Research article
  • Open access
  • Published:

A new sequence logo plot to highlight enrichment and depletion

Abstract

Background

Sequence logo plots have become a standard graphical tool for visualizing sequence motifs in DNA, RNA or protein sequences. However standard logo plots primarily highlight enrichment of symbols, and may fail to highlight interesting depletions. Current alternatives that try to highlight depletion often produce visually cluttered logos.

Results

We introduce a new sequence logo plot, the EDLogo plot, that highlights both enrichment and depletion, while minimizing visual clutter. We provide an easy-to-use and highly customizable R package Logolas to produce a range of logo plots, including EDLogo plots. This software also allows elements in the logo plot to be strings of characters, rather than a single character, extending the range of applications beyond the usual DNA, RNA or protein sequences. And the software includes new Empirical Bayes methods to stabilize estimates of enrichment and depletion, and thus better highlight the most significant patterns in data. We illustrate our methods and software on applications to transcription factor binding site motifs, protein sequence alignments and cancer mutation signature profiles.

Conclusions

Our new EDLogo plots and flexible software implementation can help data analysts visualize both enrichment and depletion of characters (DNA sequence bases, amino acids, etc.) across a wide range of applications.

Background

Since their introduction in the early 1990s by Schneider and Stephens [1], sequence logo plots have become widely used for visualizing short conserved patterns known as sequence motifs, in multiple alignments of DNA, RNA and protein sequences. At each position in the alignment, the standard logo plot represents the relative frequency of each character (base, amino acid, etc.) by stacking characters on top of each other, with the height of each character proportional to its relative frequency. The characters are ordered by their relative frequency, and the total height of the stack is determined by the information content of the position. The visualization is so appealing that methods to produce logo plots are now implemented in many software packages (e.g. seqLogo [2], RWebLogo [3], ggseqlogo [4]) and web servers (e.g. WebLogo [5], Seq2Logo [6], iceLogo [7]).

Because the standard logo plot scales the height of each character proportional to its relative frequency, it tends to visually highlight characters that are enriched; that is, at higher than expected frequency. In many applications such enrichments may be the main features of interest, and the standard logo plot serves these applications well. However, sometimes it may be equally interesting to identify depletions: characters that occur less often than expected. One example of this, highlighted in [6], involves glycosylation: N-linked glycosylation sites in proteins are known to have the motif N-X- S/T where X is any amino acid apart from proline P [8, 9]. Another example involves the distribution of histone modifications across the genome: for example, Koch et al. [10] notes depletion of histone marks H4AC and H3K4ME1 at the gene start and gene end regions in lymphoblastoid cell lines. The standard logo plot represents strong depletion(s) by the absence of character(s), which can be difficult to discern visually.

To better highlight depletions in amino acid motifs, Thomsen et al. [6] suggests several alternatives to the standard logo plot. The key idea is to explicitly represent depletions using characters that occupy the negative part of the y axis. However, we have found that the resulting plots sometimes suffer from visual clutter – too many symbols, which distract from the main patterns of enrichment and depletion.

Here we suggest a simple solution to this problem, producing a new sequence logo plot – the Enrichment Depletion Logo or EDLogo plot – that highlights both enrichment and depletion, while minimizing visual clutter. In addition, we extend the applicability of logo plots to new settings by i) allowing each “character” in the plot to be an arbitrary alphanumeric string (potentially including user-defined symbols); and ii) allowing a different “alphabet” of permitted strings at each position. We also introduce Empirical Bayes statistical methods to stabilize estimates of enrichment and depletion, and thus better highlight the most significant patterns in data. All these new features are implemented in our R package, Logolas, which can produce generalized string-based logo and EDLogo plots. We illustrate the utility of the EDLogo plot and the flexibility of the string-based representation through several applications.

Implementation

Intuition

In essence, the goal of a logo plot is to represent, at each position along the x axis, how a probability vector p compares with another probability vector q. For example, suppose that at a specific position in a set of aligned DNA sequences, we observe relative frequencies p=(pA,pC,pG,pT)=(0.33,0.33,0.33,0.01) of the four bases {A,C,G,T}. The goal of the logo plot might be to represent how p compares with the background frequencies of the four bases, which for simplicity we will assume in this example to be equal: q=(qA,qC,qG,qT)=(0.25,0.25,0.25,0.25). Verbally we could describe the change from q to p in several ways: we could say “T is depleted”, or “ A,C and G are enriched”, or “T is depleted, and A,C and G are enriched”. While all of these are valid statements, the first is the most succinct, and our EDLogo plot provides a visual version of that statement. The second statement is more in line with a standard logo representation, and the last is in essence the approach in [6] (also known as weighted Kullback Leibler Divergence Logo or wKL-Logo). See Fig. 1.

Fig. 1
figure 1

Illustration of the differences between standard logo, EDLogo and wKL-Logo representations. The figure shows how the different logos represent observed frequencies p=(pA,pC,pG,pT)=(0.33,0.33,0.33,0.01) (compared with a uniform background, q=(0.25,0.25,0.25,0.25)). The standard logo effectively represents p by highlighting that “A, C and G are enriched”; EDLogo represents it by highlighting “T is depleted”; wKL-Logo represents it as “A, C and G are enriched and T is depleted”. All are correct statements, but the EDLogo representation is the most parsimonious

The EDLogo plot

At a particular position, j, of a sequence (or other indexing set), let p=(p1,p2,…,pn) denote the probabilities of the n elements C1,…,Cn (which can be characters or strings) permitted at that position, and q=(q1,q2,…,qn) denote corresponding background probabilities. Define r=(r1,r2,…,rn) by:

$$ r_{i} = \tilde{r}_{i} - \text{median} \left (\left \{ \tilde{r}_{i} : i = 1, 2, \ldots, n \right \} \right), $$
(1)

where

$$ \tilde{r}_{i}:= \log_{2} \frac{p_{i}}{q_{i}}. $$
(2)

Then at position j along the x axis, the EDLogo plot plots the element Ci, scaled to have height |ri|, and above the x axis if ri is positive, or below the x axis if ri is negative. Elements are stacked (from bottom to top) in order of increasing ri, so that the largest characters are furthest from the axis.

The basic strategy has close connections to ideas in [6], but with the crucial difference that we subtract the median in Eq. 1. As our examples will demonstrate, subtracting the median in this way – which can be motivated by a parsimony argument (see below) – can dramatically change the plot, and substantially reduce visual clutter.

Note that the EDLogo plot for p vs q is essentially a mirror (about the x axis) of the EDLogo plot for q vs p (e.g. Additional file 2: Figure S1). We call this the “mirror property”, and it can be interpreted as meaning that the plots treat enrichment and depletion symmetrically. This property is also satisfied by plots in [6], but not by the standard logo plot.

A model-based view

Suppose we model the relationship of p to q by

$$ p_{i} \propto \lambda_{i} q_{i} $$
(3)

for some unknown (positive) “parameters” λi. For example, this model would arise if q represents the underlying frequencies of elements in a population, and p represents the frequencies of the same elements in a (large) sample from that population, conditional on an event E (e.g. a transcription factor binding). Indeed, by Bayes theorem, under this assumption we would have

$$ p_{i} \propto \Pr(E| \text{element } {i}) q_{i}. $$
(4)

Since the pi must sum to 1, \({\sum }_{i} p_{i} = 1\), the model (3) implies

$$ p_{i} = \lambda_{i} q_{i}/ \sum\limits_{j} \lambda_{j} q_{j}. $$
(5)

Now consider estimating the parameters λ. Even if p and q are observed without error, there is a non-identifiability in estimating λ: we can set λi=cpi/qi for any positive c. Equivalently, if we consider estimating the logarithms li:= logλi, we can set

$$ l_{i} = \log_{2}(p_{i}/q_{i}) + k $$
(6)

for any constant k. Note that ri in (1) has exactly this form, and so the vector r can be interpreted as an estimate of the vector ł. Furthermore, it is easy to show that, among all estimates of the form (6), r has the smallest sum of absolute values (see Additional file 1 for a rigorous proof). That is, r solves the optimization

$$ \mathbf{r} = \arg \min_{\text{\l}} \sum\limits_{i} |l_{i}| $$
(7)

subject to the constraint (6).

Since the sum of absolute values of r is the total height of the stacked characters in the EDLogo plot, one can think of our choice of r as the estimate of łthat produces the smallest stack of characters – that is, the most “parsimonious” estimate.

Interpretation

Roughly speaking, positive values of ri can be interpreted as indicating characters that are “enriched” and negative values of ri as indicating characters that are “depleted”. Formally we must add that here enrichment and depletion are to be interpreted as relative to the median enrichment/depletion across characters. This relative enrichment does not necessarily imply enrichment or depletion in some “absolute” sense: for example, ri could be positive even if pi is smaller than qi. For compositional data it seems natural that enrichment/depletion be interpreted relative to some “baseline”, and our choice of the median as the baseline is motivated above as providing the most parsimonious plot.

It may also help interpretation to note that for any two characters i and i, the difference in their heights \(\phantom {\dot {i}\!}r_{i}-r_{i^{\prime }}\) is equal to the log-odds ratio:

$$ r_{i}-r_{i^{\prime}} = \log_{2} \left(\frac{p_{i}/p_{i^{\prime}}}{q_{i}/q_{i^{\prime}}} \right). $$
(8)

Multiple solutions when n is even

When the number of classes n is even (n=4 DNA bases being a particularly relevant example) the definition of the median of \(\tilde {r}_{1},\dots,\tilde {r}_{n}\), which is subtracted in (1) to minimize total stack height, is ambiguous. Conventionally, the median of an even number of observations is usually taken to be the mean of the two central observations. However, in terms of minimizing total stack height (optimization (7)), every real number between the two central observations (inclusive) performs equally well. For example, if \(\tilde {r}=(0,0,+1,+1)\), subtracting the conventional median (0.5) yields r=(−0.5,−0.5,0.5,0.5) with total stack height 2, but subtracting any number between the two central observations (0 and 1) would lead to the same total stack height. Thus, if we measure parsimony by total stack height, there exist multiple equally-parsimonious plots, giving the user a decision to make.

Among these equally-parsimonious solutions, subtracting the smallest number corresponds to favoring an “enrichment” representation, whereas subtracting the largest number favors a “depletion” representation, and subtracting the median treads a middle ground between the two. See Additional file 2: Figure S6 for an illustration. None of these approaches is uniformly superior to another, but our sense is that – all other things being equal – users find an enrichment representation slightly more natural, and so we made this (subtracting the smallest number) the software default. One cost of this choice is that the plot no longer satisfies the mirror property; the mirror property is preserved by using the conventional median, which is a software option.

Stabilizing estimates of \(\tilde {r}_{i}\)

The basic EDLogo plot described above typically works well provided that no probabilities pi or qi are very small (or zero!). Very small values of pi or qi can cause very large values of \(|\tilde {r}_{i}|=|\log _{2} (p_{i}/q_{i})|\), and consequently large |ri| which can undesirably dominate the plot.

In practice we have found the most common source of this problem (unreasonably large |ri|) is unstable estimates of small probabilities from low counts of rare events. We found that the simplest solution to this problem – use of pseudocounts to stabilize estimates of small probabilities [11] – was only partially successful. We therefore developed a statistical approach that directly stabilizes estimates of \(\tilde {\mathbf {r}}\) from count data. This approach uses Empirical Bayes shrinkage [12] to stabilize estimates of \(\tilde {\mathbf {r}}\), and is especially effective in stabilizing estimates from low count events (see Additional file 1 for details). We produce an EDLogo plot from stabilized estimates for \(\tilde {r}_{i}\) by plugging them into (1).

Although our stabilization method is ideally-suited to settings where p and q are estimated from count data, it can also be applied in other settings by supplying an “effective count” parameter that specifies the approximate precision of supplied values of p and q. (By default we assume an effective count of 1000, which means that p and q are precise to no more than 3 decimal places).

Results

Comparison with existing logo plots

Figure 2 illustrates the EDLogo plot, and compares it with the standard logo and the weighted Kullback–Leibler logo (wKL-Logo) plot [6], in four diverse applications.

Fig. 2
figure 2

Comparison of standard logo plot, weighted KL (w-KL) logo plot and EDLogo plot on four examples. Panel (a): the transcription factor binding site of the EBF1-disc1 transcription factor from the ENCODE project [14]. Panel (b): The N-linked glycosylation motif, with the site of the N amino acid at the center (position 0), and 5 bases on either side of the N (based on data from UniprotKB [19]). The EDLogo clearly shows the N-X- S/T motif where X represents any amino acid except proline (P). Panel (c): a somatic mutation signature (signature 12 from [20]). The heights of the strings in the center of each plot (CG, CT, etc at position 0 on x axis) reflect the relative frequency of each substitution type among somatic mutations contributing to the signature, while the heights of the bases at flanking positions (-2,-1,1,2 on x axis) reflect the relative frequency of each base at positions flanking these somatic mutations. The depletion of G at position +1 - possibly occurring due to the rarity of CpG sites owing to de-amination of methylated cytosines - is clearest in the EDLogo plot. Panel (d): relative abundance of histone modification sites across various genomic regions in the lymphoblastoid cell line GM06990 (Table S2 in Koch et al. 2007 [10]). These examples illustrate the ability of the EDLogo plot to highlight both enrichment and depletion, while avoiding unnecessarily visual clutter. The last two examples also illustrate how our software allows arbitrary strings as elements in a logo plot

The first application (panel (a)) is a setting where the standard logo plot is widely used: visualizing transcription factor binding sites (TFBS) [1318] (see Additional file 3: Table S1). Specifically, the plots represent the primary discovered motif disc1 of Early B cell factor EBF1 from ENCODE [14]. This example showcases the effectiveness of the standard logo plot in highlighting enrichments: in our opinion it does this better than the other two plots, and in this sense the other plots should be viewed as complementing the standard plot rather than replacing it. This example also illustrates the difference between the wKL-Logo and EDLogo plots, both of which aim to highlight depletion as well as enrichment: the EDLogo plot introduces less distracting visual clutter than the wKL-Logo plot, producing a cleaner and more parsimonious visualization that better highlights the primary enrichments and depletions. In particular, the EDLogo plot is most effective at highlighting depletion of bases G and C at the two positions in the middle of the sequence. This depletion is hard to see in the standard logo because of its emphasis on enrichment, and less clear in the wKL-Logo due to visual clutter. This depletion pattern is likely meaningful, rather than a coincidence, since it was also observed in two other previously known motifs (known3 and known4) of the same transcription factor [16, 18] (see Additional file 2: Figure S2).

The second example (panel (b)) shows an amino acid motif corresponding to N-linked glycosylation sites. These sites are expected to have the motif N-X- S/T, where X is any amino acid apart from proline P (data from UniProtKB [19]; see Additional file 3: Table S2). This was used by [6] as an example of a motif where depletion is an important biological feature. The depletion (of the P at position +1) is essentially impossible to see in the standard logo plot, is visually detectable in the wKL-Logo plot, and clearest in the EDLogo plot. Again, the EDLogo plot is more parsimonious than the wKL-Logo plot, and consequently the primary N-X- S/T motif stands out better in the EDLogo plot. In addition to showing depletion of P at the expected position (+1), the EDLogo plot also highlights depletion of P at position +3, suggesting an extended motif N-X- S/T-X.

The next two applications (panels (c) and (d) of Fig. 2) are non-standard settings that illustrate the use of general strings as “characters” in a logo plot, as well as providing further examples where the EDLogo plot is particularly effective at highlighting depletion as well as enrichment.

Panel (c) shows logo plots representing an estimated cancer mutation signature profile (signature 12) from a clustering analysis of a large number (nearly 70,000) somatic mutations by [20] (see Additional file 3: Table S3). Here we follow [20] in representing a mutational signature by the frequency of each mutation type (at position 0 on the x axis), together with base frequencies at the ± 2 flanking bases. We also follow the common convention of orienting the strand so that the mutation is from either a C or a T, yielding six possible mutation types: CT, CA, CG, TA, TC, TG. This Figure panel illustrates two important points. First, it illustrates the flexibility of our software package Logolas, which allows arbitrary strings in a logo. For all three logo plots (standard, wKL and ED) we use this to represent the six mutation types by six strings of the form XY, and we find the resulting plots easier to read than the pmsignature plots in [20] (see Additional file 2: Figure S3 for comparison). Additionally, it also shows that one can use different sets of permitted strings at different positions - strings are used to represent the mutation in the center, while characters are used to represent the flanking bases. Second, it illustrates a case where, in our opinion, the EDLogo plot is a better visual summary than the other plots. Specifically the EDLogo plot best highlights the primary aspects of this signature: enrichment of CT mutations, and depletion of G at position +1. Here the depletion of G at +1 may be a bi-product of the enrichment of CT mutations combined with the overall depletion of CpG sites in the genome due to deamination [21].

In this example the EDLogo plot and the standard logo plot differ on the enrichments they highlight at the central position: unlike the standard plot, the EDLogo plot highlights enrichment of TC in addition to the primary enrichment CT. This is due to an important difference between the plots: in EDLogo enrichments (and depletions) are plotted on a log scale, whereas in the standard plot they are on an absolute scale. This means that in the EDLogo plot it is differences in the heights of characters that matter (and can be interpreted as a log-odds-ratio; see Implementation), whereas in a standard plot it is ratios of heights. In this case the frequency of CT is 0.96 and TC is 0.03, with other mutations essentially absent. Consequently TCis enriched relative to other mutation types, but nowhere near as strongly as CT. When these enrichments are plotted on the raw scale, as in the standard plot, essentially only the CT enrichment is visible. On the log scale, both are visible. Which representation is preferable depends on how much one wants to emphasize subtler vs stronger enrichment patterns.

For readers interested in other cancer mutation signatures, we provide EDLogo plots for all 27 mutational signature profiles reported by [20] in Additional file 2: Figure S4.

Panel (d) shows logo plots summarizing the relative abundance of 5 different histone marks in different genomic contexts (data from lymphoblastoid cell line GM06990, Table S2 of [10], given in Additional file 3: Tables S4 and S5.) Relative abundances naturally yield compositional data that can be visualized in a logo plot. Again this example illustrates the potential to use strings in logo plots. It also represents an example where the EDLogo and wKL-Logo plots seem more informative than the standard logo plot. Specifically, the standard logo plot is dominated by the high deviation from background frequencies at the intergenic, exon and intron regions, and the differences in enrichments and depletions among regions are difficult to discern. In comparison, the EDLogo and wKL-Logo plots highlight a number of differences among regions (some of which are also noted in [10]). For example, both plots highlight the relative enrichment of H3AC and H3K4me3 near the start of genes, and corresponding relative depletion of H4AC and H3K4me1. Both plots also highlight relative enrichment of H3K4me1 compared with other marks in the intergenic, exonic and intronic regions; the relative enrichment of H4AC in intronic and exonic regions; and relative depletion of H3AC in intergenic and intronic regions. As in other examples, the EDLogo plot is more parsimonious than the wKL-Logo plot.

Stabilizing \(\tilde {\mathbf {r}}\) estimates

The example of N-linked glycosylation sites above involves very small (e.g. zero) counts of some amino acids at some sites, and provides an example of both the need to stabilize estimates of \(\tilde {r}\) values, and the benefits of our new Empirical Bayes (EB) approach to this.

Before explaining the benefits of our EB approach, we first motivate the need for stabilization, using the central position of this motif as an example. At this position (and, indeed, other positions) the frequency, pi, of amino acid i is estimated by counting the number of times, mi, that amino acid i occurs in this central position in an observed data set of m=5422 sequences. The maximum likelihood estimate (mle) for pi is mi/m. However, every observed amino acid at this central position is an Asparagine (N), so the mle for pi is 1 for the N amino acid, and is 0 for all other amino acids. These 0 estimates for pi lead to unreasonably large – indeed, infinite – values for \(|\tilde {r}_{i}|\), motivating the need for stabilization.

A standard approach to stabilization of estimates of small probabilities is to use pseudocounts. This approach simply adds a pseudocount (small number) to each observed count before computing estimates. For example, using a pseudo-count of 0.5 for each of the 20 amino acids that could occur, pi is estimated by \({\hat {p}_{i} = (m_{i}+0.5)/(m+10)}\). This avoids zero estimates of probabilities, and an EDLogo plot can be constructed from the pseudo-count-based estimates of p,q. However, we found the resulting plot (Fig. 3a) somewhat unsatisfactory. For example, the approach shows most symbols are either enriched or depleted at the central position, even though the available data can be explained simply by enrichment of N. This occurs because, although the estimated pi are equal for amino acids other than N, the estimated background rates qi vary, and so the estimated \(\tilde {r}_{i}\) vary. For example, the pseudocount-based plot shows W to be enriched and L to be depleted at the central position even when neither occurs at all in the data, simply because L has a higher background rate.

Fig. 3
figure 3

Comparing EDLogo plots from different stabilization methods. The panels show EDLogo plots using (a) pseudocount stabilization and (b) our new EB stabilization method, for the amino acid motif example from Fig. 2. The EB stabilization produces a more parsimonious plot that better highlights the key enrichments and depletions supported by the data. See text for further discussion

Our EB stabilization method takes a different approach. Specifically, it directly stabilizes estimates of \(\tilde {\mathbf {r}}\), instead of separately stabilizing estimates of p and q and then taking their log-ratio. Consequently, the method produces estimates of \(\tilde {\mathbf {r}}\) that vary no more than is supported by the data, resulting in more parsimonious plots. For example, in this example (Fig. 3b) the plot shows a large N alone in the center position, highlighting that the data can be explained purely by strong enrichment of N.

In addition, the EDLogo strategy of using a median adjustment in (1) to reduce visual clutter can be directly applied to derived quantities such as the position specific scoring matrix (PSSM) commonly used to represent protein binding motifs. Additional file 2: Figure S5 shows logo plots of the PSSM matrix (see Additional file 3: Table S6), before and after median adjustment, of the binding motif of protein D-isomer specific 2-hydroxyacid dehydrogenase, catalytic domain (IPR006139) (Motif2,Start = 257, Length = 11) [22, 23]

Conclusions

We present a new sequence logo plot, the EDLogo plot, designed to highlight both enrichment and depletion of elements at each position in a sequence (or other index set). We have also developed statistical methods that can improve these plots by stabilizing enrichment estimates for rare events. We have implemented these methods, as well as standard logo plots, in a flexible R package Logolas, which offers many other features: the ability to use strings instead of characters; various customizable styles and color palettes; several methods for scaling stack heights; and ease of integrating logo plots with external graphics like ggplot2 [24].

Availability and requirements

  • Project Name : Logolas

  • Software Download page : Github R package (https://github.com/kkdey/Logolas)

  • Project Home page : https://kkdey.github.io/Logolas-pages/

  • Operating system : Platform independent

  • Programming Language : R (≥ 3.4)

  • License : GPL (> = 2)

  • Any restrictions to use by non-academics: No

  • Data : The data used in this paper are reported in Additional file 3 and are also accessible as part of our package Logolas using the data() function.

    TFBS example (Fig. 2a, Additional file 2: Figure S1, S6): Additional file 3: Table S1, data(EBF1_disc1)

    N-Glycosylation example (Figs. 2b, 3): Additional file 3: Table S2, data(N_Glycosyl_sequences)

    Mutational Signature example (Fig. 2c, Additional file 2: Figure S3): Additional file 3: Table S3, data(mutation_sig)

    Histone Marks example (Fig. 2d): Additional file 3: Table S4 and S5, data(histone_marks)

    PSSM amino acids example (Additional file 2: Figure S5): Additional file 3: Table S6, data(pssm).

Abbreviations

EDLogo:

Enrichment depletion logo

KLD:

Kullback leibler divergence

PSSM:

Position specific scoring matrix

TFBS:

Transcription factor binding site

wKL-Logo:

weighted Kullback Leibler logo

References

  1. Schneider TD, Stephens R. Sequence logos: a new way to display consensus sequences. Nucleic Acids Res. 1990; 18(20):6097–100.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Bembom O. seqLogo: Sequence logos for DNA sequence alignments. 2018. R package version 1.42.0.

  3. Wagih O. RWebLogo: plotting custom sequence logos. 2014. R package version 1.0.3. https://CRAN.R-project.org/package=RWebLogo.

  4. Wagih O. ggseqlogo: a versatile R package for drawing sequence logos. Bioinformatics. 2017; 33(22):3645–3647.

    Article  CAS  PubMed  Google Scholar 

  5. Crooks GE. Weblogo: A sequence logo generator. Genome Res. 2004; 14(6):1188–90.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  6. Thomsen MC, Nielsen M. Seq2logo: a method for construction and visualization of amino acid binding motifs and sequence profiles including sequence weighting, pseudo counts and two-sided representation of amino acid enrichment and depletion. Nucleic Acids Res. 2012; 40:281–7.

    Article  Google Scholar 

  7. Coalert N, Helsens K, Martens L, Vandekerckhove J, Gevaert K. Improved visualization of protein consensus sequences by icelogo. Nat Methods. 2009; 6:786–7.

    Article  Google Scholar 

  8. Nita-Lazar M, Wacker M, Schegg B, Amber S, Aebi M. The nxs/t consensus sequence is required but not sufficient for bacterial n-linked protein glycosylation. Glycobiology. 2004; 15(4):361–7.

    Article  PubMed  Google Scholar 

  9. Lam PVN, et al.Structure-based comparative analysis and prediction of n-linked glycosylation sites in evolutionarily distant eukaryotes. Genomics, Proteomics Bioinforma. 2013; 11(2):96–104.

    Article  CAS  Google Scholar 

  10. Koch CM, et al.The landscape of histone modifications across 1 in five human cell lines. Genome Res. 2007; 17(6):691–707.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  11. Nishida K, Frith MC, Nakai K. Pseudocounts for transcription factor binding sites. Nucleic Acids Res. 2008; 37(3):939–44.

    Article  PubMed  PubMed Central  Google Scholar 

  12. Stephens M. False discovery rates: a new deal. Biostatistics. 2016; 18(2):275–94.

    PubMed Central  Google Scholar 

  13. Tan G, Lenhard B. Tfbstools: an r/bioconductor package for transcription factor binding site analysis. Bioinformatics. 2016; 32:1555–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. Kheradpour P, Kellis M. Systematic discovery and characterization of regulatory motifs in ENCODE TF binding experiments. Nucleic Acids Res. 2013; 42(5):2976–2987.

    Article  PubMed  PubMed Central  Google Scholar 

  15. Zhao X, et al.Jaspar 2013: An extensively expanded and updated open-access database of transcription factor binding profiles. TBA. 2013; TBA(TBA).

  16. Sandelin A, Wynand A, Engstrom P, Wasserman WW, Lenhard B. Jaspar: an open-access database for eukaryotic transcription factor binding profiles. Nucleic Acids Res. 2004; 32(Database issue):91–4.

    Article  Google Scholar 

  17. Wingender E, et al.Transfac: an integrated system for gene expression regulation. Nucleic Acids Res. 2000; 28(1):316–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Jolma A, Yan J, Whitington T, Toivonen J, Nitta K, Rastas P, Morgunova E, Enge M, Taipale M, Wei G, et al.Dna-binding specificities of human transcription factors. Cell. 2013; 152:327–39.

    Article  CAS  PubMed  Google Scholar 

  19. Apweiler R, et al.Uniprot: the universal protein knowledgebase. Nucleic Acids Res. 2004; 32:115–9.

    Article  Google Scholar 

  20. Shiraishi Y, Tremmel G, Miyano S, Stephens M. A simple model-based approach to inferring and visualizing cancer mutation signatures. PLoS Genet. 2015; 11(12):1005657.

    Article  Google Scholar 

  21. Scarano E, Iaccarino M, Grippo P, Parisi E. The heterogeneity of thymine methyl group origin in dna pyrimidine isostichs of developing sea urchin embryos. Proc Natl Acad Sci. 1967; 57(5):1394–400.

    Article  CAS  PubMed  Google Scholar 

  22. Shameer K, Nagarajan P, Gaurav K, Sowdhamini R. 3pfdb - a database of best representative pssm profiles (brps) of protein families generated using a novel data mining approach. BioData Min. 2009; 2(1):8.

    Article  PubMed  PubMed Central  Google Scholar 

  23. Joseph AP, Shingate P, Upadhyay AK, Sowdhamini R. 3PFDB+: improved search protocol and update for the identification of representatives of protein sequence domain families. Database. 2014.

  24. Wickham H. ggplot2: Elegant Graphics for Data Analysis: Springer-Verlag New York; 2016. http://ggplot2.org.

Download references

Acknowledgements

We thank Hussein Al-Asadi, John Blischak, Peter Carbonetto, Yang Li and Yuichi Shiraishi for valuable feedback and helpful discussions. We thank Edward Wallace for suggestions for improving the software interface, and two anonymous referees for helpful comments.

Funding

This work was supported in part by NIH BD2K grant CA198933 and NIH grant HG002585 to M.S. The funding body did not play any role in the study design and collection, analysis and interpretation of the data and the write-up of the manuscript.

Availability of data and materials

The Logolas package is available for R (≥ 3.4) users as a Github R package (https://github.com/kkdey/Logolas). Code for reproducing figures in this paper is available at https://github.com/kkdey/Logolas-paper. Vignettes and a gallery demonstrating features of Logolas are available at (https://github.com/kkdey/Logolas-pages)

Author information

Authors and Affiliations

Authors

Contributions

KKD and MS conceived the idea. KKD implemented the package. KKD and DX tested Logolas on the data applications. KKD, DX and MS wrote the manuscript. All the authors have proofread and approved the final version of the manuscript.

Corresponding author

Correspondence to Kushal K. Dey.

Ethics declarations

Ethics approval and consent to participate

Not applicable

Consent for publication

Not applicable.

Competing interests

The authors declare no competing interests.

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Additional files

Additional file 1

Statistical justification of the Empirical Bayes stabilization of \(\tilde {r}\) scores. Also, a proof of the result that median minimizes the sum of absolute deviation and the multiple median scenario for even number of observations - a feature that we exploit in our EDLogo scoring. (PDF 219 kb)

Additional file 2

Figure S2.EDLogo plots for six different motifs of the EBF1 transcription factor. The PWMS for known1 and known2 come from the TRANSFAC database [17]; known3 from the JASPAR database [16]; known4 from [18]; disc1 and disc2 were discovered by the ENCODE project [14]. Three of the motifs (known3, known4 and disc1) show depletion of G and C in the middle of the binding site.

Figure S3. Comparison of the EDLogo plot (a) with pmsignature [20] plot (b) for visualizing cancer mutational signatures. Both plots show a cancer mutational signature (signature 12) of from a clustering analysis of somatic mutations by [20]. The EDLogo plot highlights the depletion of G at the right flanking base more clearly than does the pmsignature plot. The use of strings to represent mutations in the center is arguably more intuitive than the pmsignature representation.

Figure S4. Illustration of EDLogo for all mutation signatures from Shiraishi et al. EDLogo plots for the 27 mutation signature profiles estimated by [20] using data from different cancer types. The heights of the strings in the center of each plot (CG, CT, etc at position 0 on x axis) reflect the relative frequency of each substitution type among somatic mutations contributing to the signature profile, while the heights of the bases at flanking positions on either side reflect the relative frequency of each base at these flanking positions.

Figure S5. Illustration of median adjustment of a position specific scoring matrix (PSSM). The PSSM shown here is for the binding motif of the protein D-isomer specific 2-hydroxyacid dehydrogenase, catalytic domain (IPR006139) (Motif2,Start=257, Length=11). The data has been obtained from the 3PFDB website [22, 23]. The median adjusted PSSM Logo (bottom panel) is arguably less cluttered than the non-adjusted version (top panel).

Figure S6. Choice of median. An illustration of how the choice of median value used for centering the \(\tilde {r}_{i}\) when the median is an interval (for an even number of characters/classes) can change the EDLogo representation of the EBF1-disc1 transcription factor binding site example from Fig. 2 (panel a). In general, choosing the smallest median value favors enrichment of symbols (top), whereas choosing the largest median value favors depletion (bottom) and choosing the mid-point of the interval treads a common ground between enrichment and depletion (middle). As default option in our software and for all the EDLogo plots in this paper, we use the smallest median centering. (PDF 2615 kb)

Additional file 3

Supplementary Table. Tables of positional frequency and weight matrices used for creating the different EDLogo plots in the Figures and the Supplementary Figures of the manuscript. (PDF 184 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Dey, K.K., Xie, D. & Stephens, M. A new sequence logo plot to highlight enrichment and depletion. BMC Bioinformatics 19, 473 (2018). https://0-doi-org.brum.beds.ac.uk/10.1186/s12859-018-2489-3

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/s12859-018-2489-3

Keywords