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

Searching for transcription factor binding sites in vector spaces

Abstract

Background

Computational approaches to transcription factor binding site identification have been actively researched in the past decade. Learning from known binding sites, new binding sites of a transcription factor in unannotated sequences can be identified. A number of search methods have been introduced over the years. However, one can rarely find one single method that performs the best on all the transcription factors. Instead, to identify the best method for a particular transcription factor, one usually has to compare a handful of methods. Hence, it is highly desirable for a method to perform automatic optimization for individual transcription factors.

Results

We proposed to search for transcription factor binding sites in vector spaces. This framework allows us to identify the best method for each individual transcription factor. We further introduced two novel methods, the negative-to-positive vector (NPV) and optimal discriminating vector (ODV) methods, to construct query vectors to search for binding sites in vector spaces. Extensive cross-validation experiments showed that the proposed methods significantly outperformed the ungapped likelihood under positional background method, a state-of-the-art method, and the widely-used position-specific scoring matrix method. We further demonstrated that motif subtypes of a TF can be readily identified in this framework and two variants called the k NPV and k ODV methods benefited significantly from motif subtype identification. Finally, independent validation on ChIP-seq data showed that the ODV and NPV methods significantly outperformed the other compared methods.

Conclusions

We conclude that the proposed framework is highly flexible. It enables the two novel methods to automatically identify a TF-specific subspace to search for binding sites. Implementations are available as source code at:http://biogrid.engr.uconn.edu/tfbs_search/.

Background

Transcription of genes followed by translation of their transcripts into proteins determines the type and functions of a cell. Expression of certain genes even initiates or suppresses differentiation of stem cells. It is therefore crucial to understand the mechanisms of transcriptional regulation. Among them, transcription factor (TF) binding is the one that has been given considerable attention by computational biologists for the past decade and is still being actively researched. A TF is a protein or protein complex that regulates transcription of one or more genes by binding to the double-stranded DNA. A first step in computational identification of target genes regulated by a TF is to pinpoint its binding sites in the genome. Once the binding sites are found, the putative target genes can be searched and located in flanking regions of the binding sites.

In general, there are two approaches to computational transcription factor binding site (TFBS) identification, motif discovery and TFBS search. The former assumes that a set of sequences is given and each of the sequences may or may not contain TFBSs. An algorithm then predicts the locations and lengths of TFBSs. The term motif refers to the pattern that are shared by the discovered TFBSs. These algorithms rely on no prior knowledge of the motif and hence are known as de novo motif discovery algorithms. The latter assumes that, in addition to a set of sequences, the locations and lengths of TFBSs are known. An algorithm then learns from these examples and predicts TFBSs in new sequences. Such algorithms are also called supervised learning algorithms since they are guided by the given sequences with known TFBSs. Plenty of efforts have been devoted to the de novo motif discovery problem[111]. Comprehensive evaluation and comparison of the developed tools have been performed[12, 13]. In this study, we focus on the problem of TFBS search. We refer readers interested in the motif discovery problem to the evaluation and review articles[1214] and references therein.

A typical TFBS search method searches for the binding sites of a particular transcription factor in the following manner. It scans a target DNA sequence and compare each length l sub-sequence (l -mer) to the binding site profile of the TF, where l is the length of a binding site. Each of the l -mer is scored when comparing to the profile. A cut-off score is then set by the method to select candidate TF binding sites. The position-specific scoring matrix (PSSM)[15] is a widely used profile representation, where the binding sites of a TF are encoded as a 4 × l matrix. Column i of the matrix stores the scores of matching the ith letter in an l -mer to nucleotides A, C, G and T, respectively. Depending on the method of choice, the score of A at position i can be the count of A at position i in the known TFBSs, the log-transformed probability of observing A at position i , or any other reasonable number. Once computed, the scoring matrix of a TF can be stored in a database. These matrices are used by tools[1621] to scan sequences for TFBSs.

One assumption the PSSM representation makes is that positions in a binding site are independent, which is often not the case. Osada et al.[22] exploited dependence between positions by considering nucleotide pairs in scoring methods. It was shown that incorporating nucleotide pairs significantly improved the performance of a method, meaning that most transcription factors studied demonstrated correlation between positions in a binding site. This result was reinforced in a recent study[23], in which the authors showed correlations between two nucleotides within a binding site by plotting the mutual information matrix. A novel scoring method called the ungapped likelihood under positional background (ULPB) method was proposed in this study. The ULPB method models a TFBS by two first-order Markov chains and scores a candidate binding site by likelihood ratio produced by the two Markov chains. leave-one-out cross-validation results on 22 TFs with 20 or more binding sites showed that ULPB is superior to the methods compared in their work.

In this work, we approach the TFBS search problem from a different perspective. We propose to search for binding sites in vector spaces. Specifically, l -mers are placed in the Euclidean space such that each l -mer corresponds to a vector in the space. With known binding sites of a TF, we construct a profile vector for the TF. This profile vector can then be used as a query vector to search for the unknown binding sites in the space given a similarity measure between two vectors. The vector space model has long been used in information retrieval (IR)[24, 25]. Under this model, each document in a collection is embedded in a t -dimensional space. That is, each document is represented by a t -element vector, where t is the number of distinct terms present in the document collection or corpus. To search for documents on a particular topic, a query composed of terms relevant to the topic is constructed. The query can be similarly embedded in the t -dimensional space. Similarity between the query and a document can then be measured by measuring the similarity between the two corresponding vectors. In the TFBS search problem, the entire genome or the collection of promoter region sequences corresponds to the corpus, whereas an l -mer is analogous to a document in IR. On the other hand, a TF is analogous to a topic, while a TF representation is the analog of a query for the topic.

In this framework, we propose two novel approaches to constructing a query vector for a TF of interests. We compare the proposed methods to a state-of-the-art method, the ULPB method, as well as the widely-used PSSM method. Performance of a method is assessed by cross-validation experiments on two data sets collected from RegulonDB[26] and JASPAR[27], respectively. Independent validation on human ChIP-seq data gives further insights into the proposed methods. Finally, we discuss the advantages of searching for TF binding sites in the proposed framework.

The paper is organized as follows. In Methods, we present the novel negative-to-positive vector and optimal discriminating vector methods, in addition to introducing the existing methods compared in this work. Cross-validation results on prokaryotic and eukaryotic transcription factors are presented and discussed in Results and Discussion. Finally, we give the concluding remarks in Conclusions.

Methods

Data sets

To understand the compared methods in this work, we experimented on prokaryotic as well as eukaryotic transcription factors. The known prokaryotic TF binding sites were collected from from RegulonDB[26] release 6.8. Considered in[23], this data source contains binding sites of TFs in the E. coli K-12 genome. We considered a data set of 26 TFs with 17 or more known binding sites. The filtering criterion ensures that, for each TF, we have enough examples to learn from. Similar filtering criteria were used in[23]. This data set is summarized in Table1.

Table 1 Statistics of the E. coli TFs in RegulonDB

The known eukaryotic TF binding sites were collected from JASPAR CORE database (the 4th release)[27]. TFs of Homo sapiens and Mus musculus were filtered by two criteria. A TF was kept only if it has at least 20 known binding sites and the length of its binding sites is at least 6 nucleotides. The length criterion, arbitrarily chosen, ensures a TF under consideration is specific enough. This data set is summarized in Table2.

Table 2 Statistics of TFs in the JASPAR database

Notation

For clarity, we list and define functions and variables used throughout this paper. Please see Additional file1 for more details.

  • f i (u) denotes the probability of observing letter u at position i of a TFBS, where u {A, C, G, T}.

  • fi,j(u,v) denotes the probability of observing letters u and v at positions i and j , respectively, where i <j and u,v {A, C, G, T}.

  • f i (v|u) denotes the position-specific conditional probability of observing v at position i + 1 given u has been seen at position i , where u ,v {A, C, G, T}.

  • f (v|u) denotes the background conditional probability of observing v given u has been observed at the previous position, where u ,v {A, C, G, T}.

  • I u (·)

    is the indicator function given by

    I u (v)= 1 if v = u , 0 otherwise,
    (1)

where u ,v {A, C, G, T}.

  • I u 1 u 2 (·)

    is similarly defined as follows:

    I u 1 u 2 ( v 1 v 2 )= 1 if v 1 = u 1 and v 2 = u 2 , 0 otherwise,
    (2)

where u1,u2,v1,v2{A, C, G, T}.

  • I C i denotes the information content at position i of a binding site. Information content is closely related to entropy, a measure of uncertainty in information theory. The entropy at position i is given by E i = u { A, C, G, T } f i (u) log 2 f i ( u ) . When f i (u)= 1 4 for all u {A, C, G, T}, E i attains the maximal entropy of 2 and we are most uncertain about the letter at position i . I C i is simply defined as

    I C i =2 E i =2+ u { A, C, G, T } f i (u) log 2 f i ( u ) .
    (3)
  • I Ci,j denotes the information content of the position pair (i ,j ) of a binding site. Similarly,

    I C i , j =4+ u , v { A, C, G, T } f i , j (u,v) log 2 f i , j ( u , v ) ,
    (4)

where the maximal entropy of 4 is attained when f i , j (u,v)= 1 16 for all u ,v {A, C, G, T}.

Embedding short sequences in vector spaces

We describe how a short sequence of l nucleotides or an l -mer is placed in a vector space. Let s be an l -mer and s i denote its ith nucleotide. Each nucleotide in s is converted to 4 variables, that is, s i is converted to w i I A ( s i ), w i I C ( s i ), w i I G ( s i )and w i I T ( s i ) for i = 1,2,…,l . Hence, s is converted to 4l variables, placing s in R 4 l . Figure1 illustrates the conversion of each nucleotide in an l -mer to 4 variables when w i = 1 for i = 1,2,…,l .

Figure 1
figure 1

Illustration of embedding a short sequence in vector space. Each nucleotide in the sequence is converted to 4 indicator variables.

We further consider nucleotide pair (s i ,s j ), where i < j . Only pairs in close proximity are considered in this study. We consider (s i ,s j ) only if ji = 1 or 2, i.e., a pair of nucleotides is considered only if they are adjacent or separated by one nucleotide. Nucleotide pair (s i ,s j ) is similarly converted to 16 variables, w i , j I AA ( s i s j ), w i , j I AC ( s i s j ),, w i , j I TT ( s i s j ), as there are 16 possible nucleotide pairs, {AA, AC,…,TT}. We use 32l −48 additional variables to encode the pairs since there are l −1 adjacent pairs and l −2 pairs separated by one nucleotide. Consequently, considering individual nucleotides and nucleotide pairs, each l -mer is converted to a (36l −48)-element vector.

In this study, we consider two choices of w i ’s and wi,j’s. For the first choice, all the nucleotides and nucleotide pairs are given the same weight, i.e., w i = 1 and wi,j= 1 for all i and j . The second one assigns weight to the ith nucleotide according to the information content at position i . Similarly, it assigns weight to pair i ,j) according to the information content at this pair of positions. Specifically, w i = I C i and w i , j = I C i , j for all i and j .

Searching for TFBSs in vector spaces

Given a query vector t in space, we score an l -mer s as follows:

Score(s)= s T t,
(5)

where s denote the corresponding vector of s . In other words, the score of s is obtained by taking the dot-product between s and t. It can be seen that Score(s ) measures the similarity between s and t. Assuming that t corresponds to an l -mer t , Score(s ) counts the number of nucleotides and nucleotide pairs shared between s and t when w i = 1 and wi,j= 1 for all i and j . However, we note that t can be any vector in the space and does not necessarily correspond to an l -mer.

As described above, an l -mer is converted to a (36l −48)-element vector. Hence, we use t to search for binding sites in R ( 36 l 48 ) . Our approach offers great flexibility in that it easily allows searching for binding sites in a lower dimensional subspace. By setting all but the first 4l elements in t to zero, we are essentially searching for binding sites in R 4 l . In this work, we exploit this advantage and simultaneously search for transcription factor binding sites in three subspaces. Two of them are R 4 l and R ( 36 l 48 ) . The third one is R ( 16 l 12 ) . This subspace is obtained from considering only the first nucleotide and the l −1 adjacent nucleotide pairs as in a first order Markov chain.

The NPV method

We first introduce a simple approach to constructing a query vector. Let P be the set of n+ binding sites and N be the set of nnon-binding sites of a particular transcription factor. We embed all the l -mers in P and N in R ( 36 l 48 ) . We then find the mean binding site vector

μ + = 1 n + s P s

as well as the mean non-binding site vector

μ = 1 n s N s .

The query vector t is found by subtracting μfrom μ+, that is, t= μ+μ. The query vector t can be seen as the vector pointing from the center of the non-binding site vectors to the center of the binding site vectors. Hence, we call it the negative-to-positive vector (NPV) method. Figure2 illustrates the idea.

Figure 2
figure 2

Illustration of the NPV method. The solid arrow represents the negative-to-positive vector μ+μ, pointing from μto μ+. The hallow triangles denote the known binding sites, whereas the circles represent the known non-binding sites. The center of the binding site vectors is marked by the solid triangle, while the center of the non-binding site vectors is marked by the solid circle.

The score of an l -mer s given by the NPV method is therefore

Score(s)= s T ( μ + μ )= s T μ + s T μ .
(6)

We can see that it computes the similarity between s and the mean binding site vector as well as the similarity between s and the mean non-binding site vector. It then scores s by the difference of the two similarity scores. The more similar s is to the mean binding site vector, the higher the score. The less similar s is to the mean non-binding site vector, the higher the score.

From the perspective of geometry, we note that Score(s ) in (5) is proportional to Score(s )/||t|| , where ||t|| is the length of the query vector t. Moreover, by virtue of the equality

s T t = | | s | | | | t | | cos θ ,

we know Score(s )/||t|| equals the orthogonal projection of s onto t, where θ is the angle formed by vectors s and t (see Figure3 for an illustration). The computation of Score(s) is therefore equivalent to computation of the orthogonal projection of s onto t. Similarly, the computation of Score(s) in (6) is equivalent to computation of the orthogonal projection of s onto μ+μ. In Figure2, we observe that vector μ+μis pointing to the left and, projected onto this vector, most of the binding sites are on the left of the non-binding sites. This implies that most of the binding sites have a higher score than the non-binding sites.

Figure 3
figure 3

The orthogonal projection of s onto t . It can be seen that the projection of s onto t is equal toScore(s)/||t||Score(s).

The ODV method

We have described the NPV method, which offers a heuristic way of constructing a query vector. We now introduce a way of finding an optimal query vectorβ R ( 36 l 48 ) . Suppose that |P |=n+ and |N |=n, that is, there are n+ binding sites and n non-binding sites for a particular TF. Let P ={s(1),s(2),…,s(n+)} andN={ s ( n + + 1 ) , s ( n + + 2 ) ,, s ( n ) } , where s(i) denotes the ithl -mer in the union of the two sets and n =n+ + n. We find the optimal β by solving the following minimization problem:

min β , b , ξ 1 2 | | β | | 2 + C n + i = 1 n + ξ i + C n i = n + + 1 n ξ i
(7)
subject to Score ( s ( i ) ) | | β | | b + 1 ξ i | | β | | for s ( i ) P ,
(8)
Score ( s ( i ) ) | | β | | b 1 + ξ i | | β | | for s ( i ) N ,
(9)
ξ i 0 i.
(10)

The constraint in (8) ensures that the projection of a TFBS s(i) onto the vector β, Score ( s ( i ) ) | | β | | , exceeds the threshold b + 1 | | β | | . On the other hand, the constraint in (9) ensures that the projection of a non-TFBS s(i) onto β stays below the threshold b 1 | | β | | . Flexibility is given to the thresholds by introducing ξ i ’s with cost captured by the last two terms in (7). Finally, to clearly distinguish TFBSs from non-TFBSs, the squared difference between the two thresholds ( b + 1 | | β | | and b 1 | | β | | ) is made as large as possible. This amounts to maximizing 2 | | β | | 2 or, equivalently, minimizing 1 2 ||β| | 2 , which is the first term in (7). We call this approach the optimal discriminating vector (ODV) method.

The optimization problem in (7) is known as a quadratic programming problem with linear inequality constraints specified in (8), (9) and (10). There are p + n + 1 variables and 2n constraints, where p =36l −48 is the dimension of β. We can see that (8) and (9) specify n constraints whereas (10) imposes n constraints on the variables. Quadratic programming[28] is well-studied and hence general solvers are available, e.g., the OpenOpt framework[29]. To solve this problem, the parameter C (>0) is first arbitrarily chosen. A solver then searches for values ofβ= ( β 1 , , β p ) T , b andξ= ( ξ 1 , , ξ n ) T such that the objective function in (7) is minimized while the constraints in (8), (9) and (10) are satisfied simultaneously. It can be seen that an optimal solution to (7) always exists since the search space of {β b ξ} is never empty. To find a feasible solution, one can arbitrarily pickβ0 R p and b R . For s(i)P , one can pick ξ i R such that the constraint in (8) is satisfied. Similarly, for s(i)N , one can pick ξ i R such that the constraint in (9) is met. We can then compute the value of the objective function as the values of all the variables are known. One way to choose the parameter C in (7) is to search for C in a range by cross-validation. The parameter is TF-dependent in general, but experiments showed that a small C =2−6 will usually suffice and hence we set C =2−6for all the ODV experiments in this study.

The PSSM and ULPB methods

We briefly describe the ungapped likelihood under positional background (ULPB) method proposed in[23] and the position-specific scoring matrix (PSSM) method compared therein. We refer readers to section Notation for functions and variables used here. Consider a specific TF with binding sites of length l . The PSSM method scores an l -mer s by

i = 1 l log f i ( s i ) ,
(11)

where s i denotes the ith letter in s . We note that usually the ratio f i (s i )/f (s i ) is used in place of f i (s i ), where f (s i ) is the background probability of s i . The simpler form in (11) was compared in[23] and hence it serves as a baseline method in this study.

The ULPB models a TFBS by a first-order Markov chain and models the background by another first-order Markov chain. The background transition probabilities are estimated using the entire genome of a species and hence the ULPB method uses negative examples implicitly. It scores an l -mer s by

log f 1 ( s 1 )+ i = 1 l 1 log f i ( s i + 1 | s i ) f ( s i + 1 | s i ) .
(12)

Although ULPB does not consider background probability in the first term of (12), the score is approximately the log-likelihood ratio of the two Markov chains.

The main difference between the PSSM method and the NPV, ODV and ULPB methods is that the PSSM method does not score nucleotide pairs nor does it utilize a background distribution. The NPV and ODV methods explicitly take advantage of negative binding sites, while the ULPB method does it implicitly by using a background distribution. The flexibility of the proposed framework allows the NPV and ODV methods to easily search in subspaces, further distinguishing the PSSM and ULPB methods from the proposed ones.

Results and discussion

Performance assessment and evaluation metrics

The performance of a TFBS search method is evaluated by ν -fold cross-validation (CV). Consider a TF with n+ TFBSs of length l with flanking regions on both sides. A set of negative examples, Ntest, called the test negatives is constructed from the TFBSs of the other TFs with filtering as in[22]. Another set of negative examples, Ntrain, called the training negatives is collected from sequences embedding the n+binding sites. It is comprised of all the l -mers except for the TFBSs and two neighboring l -mers of each TFBS.

The n+ TFBSs are first divided into ν sets, each of which contains n + ν or n + ν + 1 TFBSs. At each iteration of ν -fold CV, one of the ν TFBS sets called the test TFBS set Ptestis left out. The rest of the TFBSs are therefore called the training TFBSs . A scoring function is obtained using the training TFBSs and non-TFBSs randomly sampled from the training negatives, where the ratio of numbers of non-TFBSs to TFBSs is set to 10. The test TFBSs in Ptest along with the non-TFBSs in Ntestare then scored by the scoring function. To score a test sequence, both the forward and reverse strands are scored and, in case the test sequence is longer or shorter than l , the l -mer producing the highest score is used. For each test TFBS t Ptest, we find its rank relative to all the non-TFBSs in Ntest. Formally, the rank of t equals 1 + |{s Ntest|Score(s ) ≥ Score(t )}|.

After the ν -fold CV, we end up with n+ ranks, each of which corresponds to a TFBS. To allow comparison of methods, we use the area under the ROC curve (AUC) to gauge the performance of a method on the TF. The ROC curve is a plot of true positive rate (TPR) against false positive rate (FPR), displaying the trade-off between TPR and FPR. We refer readers to[30] for an introduction to this metric. In this study, ν =10 for all the CV experiments. For the NPV and ODV methods, the best weight and subspace combination is obtained at each iteration of the ν -fold CV. Specifically, another (ν −1)-fold CV is performed on the ν −1 sets of TFBSs to search for the best combination.

Prokaryotic transcription factor binding sites

To understand the behavior of search methods on prokaryotic TF binding sites, we conducted 10-fold cross-validation experiments on the 26-TF RegulonDB data set. The proposed NPV and ODV methods were compared to the ULPB method[23]. The PSSM method, considered in[23], was also included for comparison since it served as a simple baseline method.

Figure4a shows the plot of area under the ROC curve (AUC) across the 26 TFs for each method. We can see that the ODV method has the best AUC on 12 out of 26 TFs and the NPV method has the best AUC on 9 out of 26 TFs whereas the ULPB and PSSM methods have the best AUC on 1 and 4 TFs, respectively. To gauge the relative performance between two methods, statistical tests[31] were performed on all the 6 pairs of methods. Figure4b shows the p -values of the pair-wise comparisons. We first notice that, consistent with the results in[23], ULPB outperformed PSSM with a slightly larger p -value of 0.0679 than the usual 0.05 significance cut-off. As seen in Figure4b, the NPV and ODV methods are significantly better than the PSSM and ULPB methods. We can see that the ODV method benefited from optimization albeit minimizing the objective function in (7) does not guarantee maximization of the AUC.

Figure 4
figure 4

Comparison of the PSSM, ULPB, NPV and ODV methods on the RegulonDB data set. (a) Plot of AUC values across the 26 prokaryotic TFs for each method. (b) Matrix of p -values from pair-wise comparisons. A red solid circle in row i and column j indicates that method i outperformed method j , while a blue one in row i and column j indicates that method i is inferior to method j . The size and darkness of a circle imply the significance of the relationship between two methods. The larger and darker a circle, the more significant the relationship. White background indicates exceeding the usual 0.05 significance cut-off, while gray background indicates the opposite.

Eukaryotic transcription factor binding sites

Here we compare the proposed NPV and ODV methods to the ULPB and PSSM methods on eukaryotic TF binding sites. As in the previous section, we conducted 10-fold cross-validation experiments on the 28-TF JASPAR data set. Figure5a shows the plot of AUC across the 28 TFs for each method. We can see that both the ODV and NPV methods have the best AUC on 13 out of 28 TFs while the ULPB and PSSM methods have the best AUC on 6 and 4 TFs, respectively. All the methods have the best AUC of 1 on MA0149.1 and MA0115, while the ODV, NPV and PSSM methods have the best AUC of 0.999 on MA0137.2.

Figure 5
figure 5

Comparison of the PSSM, ULPB, NPV and ODV methods on the JASPAR data set. (a) Plot of AUC values across the 28 eukaryotic TFs for each method. (b) Matrix of p -values from pair-wise comparisons. A red solid circle in row i and column j indicates that method i outperformed method j , while a blue one in row i and column j indicates that method i is inferior to method j. The size and darkness of a circle imply the significance of the relationship between two methods. The larger and darker a circle, the more significant the relationship. White background indicates exceeding the usual 0.05 significance cut-off, while gray background indicates the opposite.

Similarly, statistical tests[31] were performed on all the 6 pairs of methods. Figure5b shows that the NPV and ODV methods are significantly better than the PSSM and ULPB methods. ULPB is significantly better than PSSM, which is again consistent with the results reported in[23]. Overall, performance of the four methods remain unchanged as we shift from prokaryotic transcription factors to eukaryotic ones. This implies that a TFBS search method effective on prokaryotic transcription factors will perform equally well on eukaryotic transcription factors and vice versa.

Motif subtype identification in vector spaces

It has been shown that the binding sites of a TF can be better represented by 2 motif subtypes than by a single motif[32, 33]. In search for new binding sites, two position-specific scoring matrices are used to score an l -mer and the higher score of the two is assigned to this l -mer. Searching with two PSSMs was shown to be superior to searching with a single PSSM by cross-species conservation statistics in these studies.

We demonstrate that motif subtypes can be readily identified once we embed l -mers in a vector space. The purpose here, however, is not to compare motif subtype identification algorithms. We adopted a slightly different approach to motif subtype identification from those in previous work[32, 33], while the idea is similar. As usual, all the l -mers were first embedded in a vector space. The known binding sites of a TF were clustered into two subtypes by the k -means algorithm[34]. Immediately, we have a variant of the NPV method called the k NPV method, where k =2 denotes the number of motif subtypes. The k NPV method first computes the mean vectors of these two subtypes, μ+ 1 and μ+ 2, and scores an l -mer s by

Score ( s ) = max s T μ + 1 μ , s T μ + 2 μ ,
(13)

where μ is the mean vector of the non-binding sites. Figure6 illustrates the k NPV method.

Figure 6
figure 6

Illustration of the k NPV method. The solid arrows represent the negative-to-positive vectors μ+ 1μand μ+ 2μ, pointing from μto μ+ 1and μ+ 2, respectively. The hallow triangles denote the known binding sites, whereas the circles represent the known non-binding sites. The centers of the binding site vectors are marked by the solid triangles, while the center of the non-binding site vectors is marked by the solid circle.

Similarly, the k ODV method scores an l -mer s by

Score ( s ) = max s T β + 1 / | | β + 1 | | , s T β + 2 / | | β + 2 | | ,
(14)

where β+ i is obtained using TFBSs in cluster i , i =1,2. Unlike the k NPV method, the lengths of β+ i’s may be very different and hence β+ i’s are scaled to unit vectors so as not to bias the scoring function. We note that the choice of k =2 came from previous studies[32, 33]. Generally, k can be greater than 2 or even automatically selected[35]. This however is beyond the scope of this study and may be investigated in the future.

We assessed the k NPV and k ODV methods by 10-fold cross-validation on both the RegulonDB and JASPAR data sets. Figure7 shows the results in terms of AUC. We observe in Figure7a that overall introducing motif subtypes into the NPV and ODV methods improves the search performance (p -values: 6.41 × 10−7 and 8.31 × 10−5, respectively). Results in Figure7b also support this observation (p -values: 1.61 × 10−3 and 3.04 × 10−3, respectively). The k NPV and k ODV are comparable on both the RegulonDB and JASPAR data sets (p -values: 0.197 and 0.47, respectively). These results are consistent with those reported in[32, 33].

Figure 7
figure 7

The k NPV ( k ODV) method versus the NPV (ODV) method. The number of motif subtypes k is set to 2. (a) Plot of AUC values across the 26 prokaryotic TFs for each method. (b) Plot of AUC values across the 28 eukaryotic TFs for each method.

Independent validation on ChIP-seq data

To evaluate the proposed NPV and ODV methods on the whole genome scale, we built TF models using TFBSs in the JASPAR database to scan all the human (build hg19) 1000-base promoter sequences obtained from the UCSC Genome Browser database[36]. ChIP-seq peaks from the ENCODE project were also retrieved[37]. Specifically, the wgEncodeRegTfbsClusteredV2 table of build hg19 was obtained. We checked TFs in Table2 against the annotations and found 14 JASPAR TFs, recognized by 17 antibodies present in the ENCODE annotations. The mapping is listed in the first 3 columns of Table3.

Table 3 Results of independent validation on ChIP-seq data

For the NPV and ODV methods, the best weight and subspace combination was found by 5-fold cross-validation on the JASPAR TFBSs, while flanking genomic sequences of the TFBSs were the sources of negative binding sites. To assess the 4 compared methods, we considered the part of a ROC curve where FPR is at most 0.01 and calculated the AUC scaled to between 0 and 1. This is nearly equivalent to allowing at most 10 false positive hits per promoter on average. As a peak spans about 200 bases, it is considered recalled when it fully contains a predicted binding site. Similarly, a predicted binding site must be fully covered by a peak to be a true positive hit.

In Table3, we observe that ODV, NPV, ULPB and PSSM produced the best AUC on 13, 1, 1 and 3 out of 18 tests, respectively. Statistical tests showed that ODV significantly outperformed the other 3 methods (p -values ≤ 0.0028), NPV significantly outperformed ULPB and PSSM (p -values ≤ 0.0449), and ULPB and PSSM are comparable (p -value: 0.433). We notice that both NPV and ODV performed worse than the other two methods on MEF2A. As NPV and ODV both sample negative examples from flanking sequences of TFBSs, we suspect that this is one example where the flanking sequences do not represent well the entire promoters. ODV performed consistently across tests corresponding to the same JASPAR ID such as the three for CTCF. Examining the best weight and subspace, we can see that the subspace agrees on 11 out of 14 TF models, while the weight agrees on only 7 of them. The latter may be because ODV optimizes the β vector and hence is less sensitive to the weight used to embed an l -mer.

Conclusions

In this work, we proposed to search for transcription factor binding sites in vector spaces. The novel NPV and ODV methods were introduced to construct a query vector to search for binding sites of a TF. We compared our methods to a state-of-the-art method, the ULPB method, and the widely-used PSSM method. Cross-validation experiments revealed that the NPV and ODV methods significantly outperformed the ULPB and PSSM methods on prokaryotic as well as eukaryotic TF binding sties. Independent validation on human ChIP-seq data further verified that the NPV and ODV methods are significantly better than the other compared methods.

One of the advantages of our framework is that it allows one to easily search for binding sites in various subspaces. Hence, one can search in the best subspace for each individual TF since one can hardly find an optimal subspace for all the TFs. Another advantage is that under the proposed framework one can readily identify motif subtypes for a TF. Hence, to exploit this advantage, we introduced the k NPV and k ODV methods, immediate variants of the NPV and ODV methods. We demonstrated that, consistent with results in previous studies, k NPV (k ODV) significantly improved NPV (ODV) on the two data sets.

Our future work aims for extending our proposed methods to handling known binding sites of variable lengths. We will seek to approach this problem without resorting to multiple sequence alignment, which is notoriously time-consuming. In the meantime, we will also seek to identify additional promising subspaces to search for TF binding sites in.

Author’s contributions

CL and CH conceived the study. CL collected the data, carried out the experiments and drafted the manuscript. CH guided the study and revised the manuscript. Both authors read and approved the final manuscript.

References

  1. Vilo J, Brazma A, Jonassen I, Robinson A, Ukkonen E: Mining for Putative Regulatory Elements in the Yeast Genome Using Gene Expression Data. In Proceedings of the Eighth International Conference on Intelligent Systems for Molecular Biology. San Diego, USA: AAAI Press; 2000:384–394.

    Google Scholar 

  2. Barash Y, Bejerano G, Friedman N: A Simple Hyper-Geometric Approach for Discovering Putative Transcription Factor Binding Sites. In WABI ’01: Proceedings of the First International Workshop on Algorithms in Bioinformatics. London, UK: Springer-Verlag; 2001:278–293.

    Chapter  Google Scholar 

  3. Buhler J, Tompa M: Finding motifs using random projections. In RECOMB ’01: Proceedings of the fifth annual international conference on Computational biology. New York, NY, USA: ACM; 2001:69–76.

    Chapter  Google Scholar 

  4. Sinha S: Discriminative motifs. In RECOMB ’02: Proceedings of the sixth annual international conference on Computational biology. New York, NY, USA: ACM; 2002:291–298.

    Chapter  Google Scholar 

  5. Takusagawa KT, Gifford DK: Negative information for motif discovery. In Pacific Symposium on Biocomputing. Big Island of Hawaii, USA: World Scientific; 2004:360–371.

    Google Scholar 

  6. Rajasekaran S, Balla S, Huang CH: Exact Algorithms for Planted Motif Problems. J Comput Biol 2005, 12(8):1117–1128. 10.1089/cmb.2005.12.1117

    Article  CAS  PubMed  Google Scholar 

  7. Balla S, Thapar V, Verma S, Luong T, Faghri T, Huang CHH, Rajasekaran S, del Campo JJ, Shinn JH, Mohler WA, Maciejewski MW, Gryk MR, Piccirillo B, Schiller SR, Schiller MR: Minimotif Miner: a tool for investigating protein function. Nat methods 2006, 3(3):175–177. 10.1038/nmeth856

    Article  CAS  PubMed  Google Scholar 

  8. Li N, Tompa M: Analysis of computational approaches for motif discovery. Algorithms for Mol Biol 2006, 1: 8. 10.1186/1748-7188-1-8

    Article  Google Scholar 

  9. Zaslavsky E, Singh M: A combinatorial optimization approach for diverse motif finding applications. Algorithms for Mol Biol 2006, 1: 13. 10.1186/1748-7188-1-13

    Article  Google Scholar 

  10. Yanover C, Singh M, Zaslavsky E: M are better than one: an ensemble-based motif finder and its application to regulatory element prediction. Bioinformatics 2009, 25(7):868–874. 10.1093/bioinformatics/btp090

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Georgiev S, Boyle A, Jayasurya K, Ding X, Mukherjee S, Ohler U: Evidence-ranked motif identification. Genome Biol 2010, 11(2):R19. 10.1186/gb-2010-11-2-r19

    Article  PubMed Central  PubMed  Google Scholar 

  12. Tompa M, Li N, Bailey TL, Church GM, De Moor B, Eskin E, Favorov AV, Frith MC, Fu Y, Kent WJ, Makeev VJ, Mironov AA, Noble WSS, Pavesi G, Pesole G, Régnier M, Simonis N, Sinha S, Thijs G, van Helden J, Vandenbogaert M, Weng Z, Workman C, Ye C, Zhu Z: Assessing computational tools for the discovery of transcription factor binding sites. Nat biotechnol 2005, 23: 137–144. 10.1038/nbt1053

    Article  CAS  PubMed  Google Scholar 

  13. Hu J, Li B, Kihara D: Limitations and potentials of current motif discovery algorithms. Nucleic Acids Res 2005, 33(15):4899–4913. 10.1093/nar/gki791

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  14. Sandve G, Drablos F: A survey of motif discovery methods in an integrated framework. Biol Direct 2006, 1: 11. 10.1186/1745-6150-1-11

    Article  PubMed Central  PubMed  Google Scholar 

  15. Staden R: Computer methods to locate signals in nucleic acid sequences. Nucleic Acids Res 1984, 12(1Part2):505–519. 10.1093/nar/12.1Part2.505

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  16. Schug J: Using TESS to Predict Transcription Factor Binding Sites in DNA Sequence. In Curr Protoc Bioinf. Edited by: Baxevanis AD. New York: J. Wiley and Sons; 2003.

    Google Scholar 

  17. Kel A, Gößling E, Reuter I, Cheremushkin E, Kel-Margoulis O, Wingender E: MATCH™: a tool for searching transcription factor binding sites in DNA sequences. Nucleic Acids Res 2003, 31(13):3576–3579. 10.1093/nar/gkg585

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Sandelin A, Wasserman WW, Lenhard B: ConSite: web-based prediction of regulatory elements using cross-species comparison. Nucleic Acids Res 2004, 32(suppl 2):W249-W252.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Chekmenev DS, Haid C, Kel AE: P-Match: transcription factor binding site search by combining patterns and weight matrices. Nucleic Acids Res 2005, 33(suppl_2):W432–437.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  20. Turatsinze JVV, Thomas-Chollier M, Defrance M, van Helden J: Using RSAT to scan genome sequences for transcription factor binding sites and cis-regulatory modules. Nat Protoc 2008, 3(10):1578–1588. 10.1038/nprot.2008.97

    Article  CAS  PubMed  Google Scholar 

  21. Zambelli F, Pesole G, Pavesi G: Pscan: finding over-represented transcription factor binding site motifs in sequences from co-regulated or co-expressed genes. Nucleic Acids Res 2009, 37(suppl 2):W247-W252.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Osada R, Zaslavsky E, Singh M: Comparative analysis of methods for representing and searching for transcription factor binding sites. Bioinformatics 2004, 20(18):3516–3525. 10.1093/bioinformatics/bth438

    Article  CAS  PubMed  Google Scholar 

  23. Salama RA, Stekel DJ: Inclusion of neighboring base interdependencies substantially improves genome-wide prokaryotic transcription factor binding site prediction. Nucleic Acids Res 2010, 38(12):e135. 10.1093/nar/gkq274

    Article  PubMed Central  PubMed  Google Scholar 

  24. Salton G, Wong A, Yang CS: A vector space model for automatic indexing. Commun ACM 1975, 18: 613–620. 10.1145/361219.361220

    Article  Google Scholar 

  25. Lee DL, Chuang H, Seamons K: Document Ranking and the Vector-Space Model. IEEE Software 1997, 14: 67–75.

    Article  Google Scholar 

  26. Gama-Castro S, Jiménez-Jacinto V, Peralta-Gil M, Santos-Zavaleta A, Peñaloza-Spinola MI, Contreras-Moreira B, Segura-Salazar J, Muñiz-Rascado L, Martínez-Flores I, Salgado H, Bonavides-Martínez C, Abreu-Goodger C, Rodríguez-Penagos C, Miranda-Ríos J, Morett E, Merino E, Huerta AM, Treviño-Quintanilla L, Collado-Vides J: RegulonDB (version 6.0): gene regulation model of Escherichia coli K-12 beyond transcription, active (experimental) annotated promoters and Textpresso navigation. Nucleic Acids Res 2008, 36(suppl 1):D120-D124.

    PubMed Central  CAS  PubMed  Google Scholar 

  27. Portales-Casamar E, Thongjuea S, Kwon AT, Arenillas D, Zhao X, Valen E, Yusuf D, Lenhard B, Wasserman WW, Sandelin A: JASPAR 2010: the greatly expanded open-access database of transcription factor binding profiles. Nucleic Acids Res 2010, 38(suppl 1):D105-D110.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Bertsekas DP: Nonlinear Programming. Belmont, MA: Athena Scientific; 1999.

    Google Scholar 

  29. Kroshko DL: OpenOpt 0.36. 2011.http://openopt.org/

    Google Scholar 

  30. Fawcett T: An introduction to ROC analysis. Pattern Recogn Lett 2006, 27: 861–874. 10.1016/j.patrec.2005.10.010

    Article  Google Scholar 

  31. Wilcoxon F: Individual Comparisons by Ranking Methods. Biometrics Bulletin 1945, 1(6):80–83. 10.2307/3001968

    Article  Google Scholar 

  32. Hannenhalli S, Wang LS: Enhanced position weight matrices using mixture models. Bioinformatics 2005, 21(suppl_1):i204–212.

    Article  CAS  PubMed  Google Scholar 

  33. Georgi B, Schliep A: Context-specific independence mixture modeling for positional weight matrices. Bioinformatics 2006, 22(14):e166-e173. 10.1093/bioinformatics/btl249

    Article  CAS  PubMed  Google Scholar 

  34. de Hoon MJ, Imoto S, Nolan J, Miyano S: Open source clustering software. Bioinformatics 2004, 20(9):1453–1454. 10.1093/bioinformatics/bth078

    Article  CAS  PubMed  Google Scholar 

  35. Jain AK: Data clustering: 50 years beyond K-means. Pattern Recognit Lett 2010, 31(8):651–666. 10.1016/j.patrec.2009.09.011

    Article  Google Scholar 

  36. Fujita PA, Rhead B, Zweig AS, Hinrichs AS, Karolchik D, Cline MS, Goldman M, Barber GP, Clawson H, Coelho A, Diekhans M, Dreszer TR, Giardine BM, Harte RA, Hillman-Jackson J, Hsu F, Kirkup V, Kuhn RM, Learned K, Li CH, Meyer LR, Pohl A, Raney BJ, Rosenbloom KR, Smith KE, Haussler D, Kent WJ: The UCSC Genome Browser database: update 2011. Nucleic Acids Res 2011, 39(suppl 1):D876-D882.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  37. Rosenbloom KR, Dreszer TR, Pheasant M, Barber GP, Meyer LR, Pohl A, Raney BJ, Wang T, Hinrichs AS, Zweig AS, Fujita PA, Learned K, Rhead B, Smith KE, Kuhn RM, Karolchik D, Haussler D, Kent WJ: ENCODE whole-genome data in the UCSC Genome Browser. Nucleic Acids Res 2010, 38(suppl 1):D620-D625.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

This work was supported in part by National Science Foundation [grant numbers CCF-0755373 and OCI-1156837].

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Chun-Hsi Huang.

Additional information

Competing interests

Both authors declared that they have no competing interests.

Electronic supplementary material

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Lee, C., Huang, CH. Searching for transcription factor binding sites in vector spaces. BMC Bioinformatics 13, 215 (2012). https://doi.org/10.1186/1471-2105-13-215

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-13-215

Keywords