Skip to main content

A hybrid method for the exact planted (l, d) motif finding problem and its parallelization

Abstract

Background

Given a set of DNA sequences s1, ..., s t , the (l, d) motif problem is to find an l-length motif sequence M , not necessary existing in any of the input sequences, such that for each sequence s i , 1 ≤ it, there is at least one subsequence differing with at most d mismatches from M. Many exact algorithms have been developed to solve the motif finding problem in the last three decades. However, the problem is still challenging and its solution is limited to small values of l and d.

Results

In this paper we present a new efficient method to improve the performance of the exact algorithms for the motif finding problem. Our method is composed of two main steps: First, we process qt sequences to find candidate motifs. Second, the candidate motifs are searched in the remaining sequences. For both steps, we use the best available algorithms. Our method is a hybrid one, because it integrates currently existing algorithms to achieve the best running time. In this paper, we show how the optimal value of q is determined to achieve the best running time. Our experimental results show that there is about 24% speed-up achieved by our method compared to the best existing algorithm. Furthermore, we also present a parallel version of our method running on shared memory architecture. Our experiments show that the performance of our algorithm scales linearly with the number of processors. Using the parallel version, we were able to solve the (21, 8) challenging instance using 8 processors in 20.42 hours instead of 6.68 days of the serial version.

Conclusions

Our method speeds up the solution of the exact motif problem. Our method is generic, because it can accommodate any new faster algorithm based on traditional methods. We expect that our method will help to discover longer motifs. The software we developed is available for free for academic research at http://www.nubios.nileu.edu.eg/tools/hymotif.

Background

DNA motifs are short sequences in the genome that play important functional roles in gene regulation. Due to their short length, it is difficult to identify these regions using features intrinsic in their composition. Assuming that the motifs are conserved in closely related species due to the importance of their function, it is possible to discover them by comparing the respective DNA sequences to identify the sub-sequences that are very similar to each other.

There are two common combinatorial formulations that identify the motifs: The first is the consensus motif problem which made its first appearance in 1984 [1], while the second is the planted (l, d)-motif problem that was presented in 2000 [2]. It is worth noting that the latter formulation is a special case of the former. The exact definitions are as follows:

Given a set of t sequences s i where 1 ≤ it defined over an alphabet ∑. The consensus motif problem is to find an l-length motif sequence M such that in each sequence s i , 1 ≤ it, there is at least one subsequence p i differing with at most d mismatches from M; i.e., d H (p i , M)d, where d H is the hamming distance between p i and M.

The planted (l, d) motif problem is a special case of the consensus problem in which we restrict that p i occurs only once in s i .

Due to its combinatorial nature, the consensus motif problem and its variant defined above is extremely challenging. Over a benchmark data of 20 sequences, each of length 600 characters, large instances of (15, 5), (17, 6), (19, 7) and (21, 8) have been addressed and many algorithms have been developed to solve them one after another. These algorithms can be classified into two major categories: approximation algorithms [212] and exact algorithms [1330]. Approximation algorithms are based on probabilistic local search techniques, such as Gibbs Sampling, Expectation Maximization, etc. Although these algorithms may solve the challenging instances in practice, there is no guarantee that the motif can be found even when l is short.

Exact algorithms are based on exhaustive search techniques. The brute force algorithm proceeds by testing all possible motifs of length l using pattern matching, leading to O (l n t 4l) time complexity. This algorithm, however, is not suitable for discovering long motifs in practice, and many algorithms have been developed to provide faster solutions. Examples of these algorithms are CENSUS [23], PMS1 [26], PMSP [27], PMSprune [29], PMS5 [30], SMILE [19], RISO [24], RISOTTO [28], and Voting [25]. In the following we briefly review the most efficient ones and the ones related to our work.

The algorithms SMILE [19], RISO [24], and RISOTTO [28] are based on the use of suffix tree. The time complexity of these algorithms is the same and it is O(t2Nv(l, d)), where v ( l , d ) = d i = 0 C i l 3 i is the size of the d-mismatch neighbourhood of motifs of length l and N = t i = 1 n i , n i is the length of sequence i from input sequences. RISOTTO improved the time complexity of SMILE and RISO in the average case and solved some challenging instances such as (15, 5) and (17, 6).

PMSP [27] is based on exploring the neighbourhood of the l-mer of the first sequence and checking whether the elements of such neighbourhoods are (l, d) motifs. The time complexity is O ( 1 w t n 2 v ( l , d ) ) . It is able to solve some challenging instances such as (15, 5) and (17, 6). PMSprune [29, 31] is an improved version of the PMSP algorithm, based on the branch and bound strategy. Although it has the same worst-case time complexity as PMSP algorithm, it is more efficient in practice and it could tackle the (17, 6) and (19, 7) instances for the first time. PMS5 [30] is based on computing the common d-neighbourhood of three l-mers using integer programming formulation. It combines this novel idea with the algorithms PMS1 and PMSPrune. PMS5 can tackle the large challenging instances (19, 7), (21, 8) and (23, 9). The only drawback of PMS5, it requires larger amount of internal memory to finish computation.

Our contribution

In a previous work [32, 33], we have introduced an idea composed of two stages to speed up the exact algorithms: In the first stage, we generate a set of candidate motifs by applying one of the exact algorithms based on the neighbourhood method (like Voting [25] or PMSP [27] algorithms) using qt sequences. In the second stage, for each candidate motif we check if it is a valid motif or not using pattern matching on the reminder (t - q) sequences. This dramatically reduces the search space and leads to significant speed up. The bottleneck in this approach, however, was the determination of the q value that yields the fastest running time. That is, the user has to guess the value of q, which might lead to non-optimal running time and even no speed up compared to the traditional methods. Also, the authors in [34] have used the same idea on PMS1, RISOTTO, and PMSprune algorithms.

In this paper, we present a theoretical method which can be used to determine the appropriate value of q. Then we apply this strategy on PMSprune algorithm and solve some big challenging instances such as (21, 8). Furthermore, we propose a parallel version of our algorithm to present a practical solution to the challenging instances of the motif problem. Our parallel version further speeds up the solution of the (21, 8) instance.

Definitions and related work

In this section, we introduce some notations and definitions that will help us to describe our algorithm and related work in a concise manner.

Definition 1 adapted from [29]: For any string x, with |x| = l, let B d (x) = {y: |y| = l, d H (y, x) ≤ d}, where d H denotes the Hamming distance and B d (x) denotes the set of neighbourhoods of x. We also write v(l, d) to refer to |B d (x)|.

Definition 2 adapted from [29]: Let s denote a string of length n and let x denote another string of length l, l <n. We define the minimum distance between s and x as d ̄ H ( x , s ) = min x l s d H ( x , x ) , where x l s denotes that x is a substring of s with length l.

Definition 3 adapted from [29]: Given an l-length string x and a set of strings S = {s1, ..., s t } with |s i | = n for i = 1, ..., t and l <n, we define the distance between S and x as d ̄ H ( x , S ) = max i = 1 t { d ̄ H ( x , s i ) } = max i = 1 t { min r l s i { d H ( x , r ) } }

Definition 4 adapted from [29]: A string x is an (l, d) motif for a set of sequences S = {s1, ..., s t }, if:

  1. 1)

    d ̄ H ( x , S ) d .

  2. 2)

    y l s 1 : x B d ( y ) d ̄ H ( x , { s 1 , . . . . , s t } ) d .

Proposition 1 adapted from [10]: Let u and v be two random strings of length l over an alphabet of 4 characters with equal probability of occurrence. The probability p d that d H (u, v) ≤ d is p d = i = 0 d l i 3 / 4 i 1 / 4 l - i , and the probability that d ̄ H ( x , S ) d is (1-(1-p d )n-l+1)t. The expected number of l-length motifs that occur at least once in each of the t sequences with up to d substitutions is E(l, d, t, n) = 4l(1-(1-p d )n-l+1)t.

PMSprune Algorithm

Because the first stage of our method will depend on the PMSprune algorithm. We will review the basic steps of it in the notions presented above.

The main strategy of PMSprune is to generate B d (y), for every l-mer y in s1, using a branch and bound technique. An element xB d (y) is a motif only if d ¯ H x , S d. The step of verifying that d ¯ H x , S d is achieved by scanning all substrings of S. For fixed values of t, n, and l, the expected time complexity of PMSprune is equal to

T P M S p r u n e = O t n - l + 1 2 l + p 2 d i = 1 2 d - d + 1 l i 3 i
(1)

where p2dis the probability that the hamming distance between two strings is at most 2d, and it is defined in Proposition 1. For fixed values of t, n, and l, value d' was estimated such that the probability of d ̄ H ( x , S ) d is close to 1. (The probability of d ̄ H ( x , S ) d is given in Proposition 1 and it is 1 - 1 - p d n - l + 1 t ).

Implementation

Our proposed strategy

Our new strategy, referred to as hybrid exact pattern motif search (HEP), is composed of three steps: first, we determine the value q, corresponding to the size of a subset of input sequences, as explained below. Second, we apply an exact exhaustive algorithm £ (like, PMSprune) on the set of q sequences to find the set of d-neighbourhood B d (x) (review definition 1 for exact definition of d-neighbourhood). We call this set the candidate motif set. Finally, we apply a pattern search algorithm over the remaining sequences to verify each motif. Note that our algorithm is generic in the sense that it takes the program £ also as input in addition to the input sequences and user parameters. A pseudo code for this strategy using the exact algorithm £ is as follows:

Algorithm 2: HEP (£, s1,..., s t , n, l, d)

Begin

  1. 1)

    Determine the number of sequences q using the method given below.

  2. 2)

    Implement the exact algorithm £ on q input sequences. Let C be the set of candidate motifs found in the q sequences.

  3. 3)

    For each pattern v in C, check if v is a valid motif or not in the reminder (t - q) input sequences using pattern matching Algorithm.

End.

Theorem 1: Algorithm 2 correctly finds all (l, d) motifs in a given t input sequences.

Proof: Step 2 of the algorithm is exhaustive and finds the whole set of d-neighborhood for the q sequences. Therefore, and by definition of the (l, d) motif problem, any (l, d) motif belongs to this set, even if q = 1. In Step 3, each candidate motif is verified by comparison to each substring in the remaining sequences. This step is conducted by an approximate pattern matching algorithm for each l-length substring in the candidate motif set and each l-length substring in the remaining sequences such that the hamming distance between these two substrings is ≤ d. This guarantees that no motif is missing.

Theorem 2: The running time of the HEP is equal to

T H E P = T £ ( q ) + l ( t - q ) ( n - l + 1 ) E ( l , d , q , n )
(2)

where T£(q)is the running time of step 2 involving the use of an exact algorithm £ on the q input sequences and l(t - q) (n - l + 1) E(l, d, q, n) is the running time of step 3 such that E(l, d, q, n) is the number of elements in the set C, which is estimated to be 4l(1- (1 - p d )n - l + 1)q. Note that the complexity of step 1 takes constant time, as we will explain below. Note that the running time of the brute force algorithm is acquired if q = 0 in equation 2. The running time of the exact algorithm £ is acquired if q = t in equation 2.

Determination of the best q

The range of the number of sequences q, enhancing the performance of the exact motif finding problem is calculated by solving the following inequality for the parameter q:

T H E P T £
(3)

Definition 5: We define mns as the minimum number of sequences q that yields better running time; i.e., the first value of q that verifies the inequality. We also define ons as the optimal number of sequences q that yields the best running time; i.e., the value of q such that T HEP is minimum over 1 ≤ qt.

Implementing HEP based on PMSprune

We decided to use PMSprune for implementing the first step in our method, because of its superiority compared to other algorithms as discussed in [31]. However, we stress that our approach is generic and can be used with any better algorithm that appears in future. In the following, we will refer to our method based on PMSprune as HEP_PMSprune. If q = mns we will denote it with HEP_PMSprune(mns), and if q = ons we will denote it with HEP_PMSprune(ons).

Determining mns for PMSprune

Replacing T£(q)by the time of PMSprune on q sequences, Equations (1) and (2) can be rewritten as follows:

T P M S p r u n e = q ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) + ( t - q ) ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i )
T H E P _ P M S p r u n e = q ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) + l ( t - q ) ( n - l + 1 ) E ( l , d , q , n )

Replacing T HEP with T HEP_PMSprune and T£ with T PMSprune in the inequality (3)results in the following variation:

l ( t - q ) ( n - l + 1 ) E ( l , d , q , n ) < ( t - q ) ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i )

Substituting the value of E(l, d, q, n) with the value given in Proposition 1 in the left hand side yields

4 l ( 1 - ( 1 - p d ) n - l + 1 ) q < ( n - l + 1 ) ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) l

Dividing both sides by 4l and taking the logarithm,

q > log ( n - l + 1 ) ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) - log ( l 4 l ) log ( 1 - ( 1 - p d ) n - l + 1 )
(4)

The inequality (4) provides the range of the values of q that makes the running time of HEP using PMSprune less than the running time of the original PMSprune over the all set of sequences. The minimum value of q in the range of the inequality is called mns and it is equal to:

log ( n - l + 1 ) ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) - log ( l 4 l ) log ( 1 - ( 1 - p d ) n - l + 1 ) + 1

Determining ons for PMSprune

For fixed values of t, n, l and d, ons can be calculated for PMSprune by selecting the value of q that minimizes the total number of operations THEP _PMSprunefor 1 ≤ qt. The following algorithm computes the value of ons for each instance (l, d).

Algorithm 3: Find ons

Begin

  1. 1)

    q = ons = 1

  2. 2)

    E ( l , d , q , n ) = 4 l ( 1 - ( 1 - ( i = 0 d l i ( 3 / 4 ) i ( 1 / 4 ) l - i ) ) n - l + 1 ) q

  3. 3)

    T min = q ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) +l ( t - q ) ( n - l + 1 ) E ( l , d , q , n )

  4. 4)

    for q = mns to t do

    E ( l , d , q , n ) = 4 l ( 1 - ( 1 - ( i = 0 d l i ( 3 / 4 ) i ( 1 / 4 ) l - i ) ) n - l + 1 ) q
    T = q ( n - l + 1 ) 2 ( l + p 2 d i = 1 2 d - d + 1 l i 3 i ) +l ( t - q ) ( n - l + 1 ) E ( l , d , q , n )

if T <Tmin then

Tmin = T

ons = q

  1. 5)

    return ons

End

The above algorithm computes q in O(t) time. In practice, the time for computing q takes negligible time with respect to the rest of motif finding steps; it took maximum one second for all experiments included in this paper with simulated and real datasets. To save some time, our implementation includes a look-up table containing pre-computed values of q for different values of l, n, and d, where l < 20, d < 3, and selected values of n with n = 300, n = 350, 400, ..., n = 700. For other values of l, n, and d, we compute the best q using the above algorithm.

Parallel version of HEP_PMSprune(ons)

We propose a parallel version for HEP_PMSprune(ons) called PHEP_PMSprune(ons). The two main steps of HEP_PMSprune(ons) can be parallelized as follows:

We parallelize the PMSprune algorithm by assigning a set of l-mers from s1 to each processor for establishing the set of neighboring motifs. The resulting sets are stored in candidate motif lists C i , i {1, 2, ..., p}, where p is the number of processors. After each processor finishes computation, the C i lists are merged together in a larger set C, such that each motif is represented once in this list; i.e., all repetitions are removed. Creating the C list is done in linear time with respect to the number of candidate motifs and it is achieved as follows:

We incrementally construct the partial list C j that contains the L j lists, 1 ≤ j ≤ p, by appending the list L j at the end of the list Cj- 1such that all elements in L j existing in Cj-1are discarded. This continues until j = p; i.e., C p is C. Discarding a repeated element is done efficiently as follows: For small values of l, we create a look-up table with size Σl, where Σ is the alphabet size. Each possible l-length string can be mapped to a number in the range between zero and Σl in O(l) time. The ith entry in this table contains one if a string in Cj- 1is mapped to i. Otherwise, it contains zero. The strings in C j are queried against this look-up table to discard repetitions and set entries they are mapped to with value one. For longer values of l, we use the Aho-Corasick automaton to index all l-length motifs in Cj- 1, and check if a strings in C j exists in the automaton or not and add the new strings of C j to the automaton. For these string matching algorithms, we refer the reader to [35].

In the second step, we validate each candidate motif independently in parallel over the available processors. The running time of this algorithm is O(Ts/p +|C|), where T s is the sequential running time and |C| is the size of set C.

The first step in the parallel algorithm does not lead to loss of any motifs. This is because the set C includes the d-neighborhood set of the q-sequences. The reason is that we run PMSprune in parallel against the strings (x, s2, s3, ..., s q ), where x is a substring of s1. That is, each substring is not processed. The second step in the parallel algorithm is also correct, because the elements in C are independent of each other and checking the validity of each candidate motif can be safely run in parallel. Our experimental results confirm the correctness of our parallelization procedure.

Results and discussion

Experiments on simulated datasets

We used the simulated data sets that are used in many articles [2530, 3234] with t = 20 sequences and n = 600 characters, where the alphabet size is 4. Each (l, d) input instance dataset is generated as follows: We generate random strings with length (n-l) each, where the characters appear randomly with equal probability. Then we generate randomly an l-length string M and plant a copy of it in each sequence at random position after mutating it with at most d random mutations. We tested the algorithms for varying n, l, and d values and for the following challenging instances: (11, 3), (13, 4), (15, 5), (17, 6), (19, 7), and (21, 8).

Experiments overview

Our experiments address three major issues: The first is the performance of our method compared to the use of PMSprune only. The second, we show that our method for selecting q, already achieves the best running time. The third is the performance of the parallel version and its scalability. The algorithms are implemented on a 2 Quad-core processors (2.5 GHz each) machine. The programs are coded in C language. In the parallel version, we use openMP directives for parallelizing the code.

Performance of HEP on PMSprune

Tables 1 and 2 show the performance of the algorithms HEP_PMSprune(mns) and HEP_PMSprune(ons) with respect to PMSprune algorithm respectively. The last column in Tables 1 and 2 displays the improvement in PMSprune which equals to T P M S p r u n e - T H E P _ P M S p r u n e ( m n s ) T P M S p r u n e and T P M S p r u n e - T H E P _ P M S p r u n e ( o n s ) T P M S p r u n e respectively. We used the notations 's', 'm', 'h', and 'dy' in computing the time for seconds, minutes, hours, and days, respectively. The results confirm that, the algorithms HEP_PMSprune(mns) and HEP_PMSprune(ons) significantly reduced the running time compared to the standard PMSprune algorithm in all challenging instances.

Table 1 Time Comparison of PMSPrune and HEP_PMSprune(mns) with the Challenging Instances
Table 2 Time Comparison of PMSPrune and HEP_PMSprune(ons) with the Challenging Instances

Evaluating the choice of q

In this section, we experimentally evaluate our algorithm for determining the best q that minimizes the running time of the HEP_PMSprune(q) algorithm. To achieve this, we will follow the following steps:

1. We run HEP_PMSprune(q), mnsqt for the problem instances (11, 3), (13, 4), (15, 5), (17, 6), (19, 7), and (21, 8) and determine the value of q that minimizes the running time; we will refer to this value with onsexp.

2. Compare the onsexp against our ons computed theoretically.

Figure 1, which plots the running time against different q values, shows the results of applying these steps. We observe the value of ons is equal or very close to the value of onsexp.

Figure 1
figure 1

Performance of our method for different challenging instances. Behavior of HEP_PMSprune(q) for different (l, d) instances such that q {mns,..., t}. (a): (11, 3), (b): (13, 4), (c): (15, 5), (d): (17, 6), (e): (19, 7). We used the following remarks in the figures: 1) Black-triangle-down to indicate the runing time of HEP_PMSprune(mns). 2) Black-star to indicate the running time of PMSprune or HEP_PMSprune(t). 3) White-box to indicate the running time of HEP_PMSprune(ons); i.e., using theoretically estimated q.

We also conducted another experiment, where the problem instances were generated with different n and l and d. Table 3 shows the results for many of these instances, where the number of sequences t = 20. We can observe that our algorithm finds the optimal q in all these instances. We also observe improvement of the running time with respect to the PMSprune algorithm in most of the cases. The cases with no improvement in the running time are attributed to the fact that the expected number of motifs is very low and the original algorithm runs already fast in these cases.

Table 3 The performance of the HEP_PMSprune(ons) for different values of n and l

Note that it was not feasible to list the results for all possible values n, l, and d in Table 3. But in other instances with different values of n, l, and d, we found that ons and its time were consistent with onsexp and its time published in this table.

Performance of PHEP_PMSprune(ons)algorithm

In Table 4, we show the results of applying the parallel version of our algorithm PHEP_PMSprune(ons) using different number of processors and for different problem instances. The running time of the difficult instance (21, 8) has been decreased from 6.68 days to about 20.42 hours using 8 processors. Figure 2 shows the scalability results for the algorithm where speedup = T H E P P M S p r u n e ( o n s ) T H E P P M S p r u n e ( o n s ) . From Table 4 and Figure 2 we note that PHEP_PMSprune(ons) reduce the time of HEP_PMSprune(ons) and the speedup achieved scales well with the increasing number of processors.

Table 4 Running time of PHEP_PMSprune(ons) using different number of processors p for some challenging instances
Figure 2
figure 2

Scalability plot of the parallel version. The plots show speed-up for different number of processors and problem instances.

Experiments on real datasets

We used two collections of real datasets used in previous research papers [10, 26, 29, 36]. The first collection is a dataset including a number of the upstream regions of yeast genes [37] affected by certain transcription factors. The transcription factors are from the SCPD [38] database and the paper [39]. The upstream DNA sequences were extracted using the Saccharomyces Genome Database [37]. The second collection includes the dataset of Blanchette [36] which includes the upstream DNA regions of many genes from different species. This dataset is available at http://bio.cs.washington.edu/supplements/FootPrinter and a copy of it is available with our software tool for testing.

Tables 5 and 6 show the motifs found by our method compared to the published ones for both collections. In each table, we give a reference to the published motif. Our program could detect all published motifs. It is also interesting to note that our program could detect extra novel motifs in the case of the Interleukin-3 problem instance in Table 6. These motifs look interesting, because they are 20 bp long with hamming distance zero; an observation that calls for further biological investigation.

Table 5 Application of the PHEP_PMSprune(ons) on the real yeast dataset
Table 6 Application of the PHEP_PMSprune(ons) on the Blanchette real dataset

Tables 5 and 6 also include the running times (in seconds) of running our method for the listed problem instances and the improvement in time compared to the PMSprune method. The running time for one problem instance is the time needed to run our program in the (l, d) parameters range from (6, 0) until (21, 3), i.e., there are 64 invocations of our program. The results show that our program is superior to the PMSprune for large instances.

Conclusions

In this paper, we introduced an efficient method that can enhance the performance of exact algorithms for the motif finding problem. Our method depends on dividing the sequence space into two sets. Over the first set, we generate a set of candidate motifs. Then, we use the remaining set of sequences to verify if each candidate motif is a real one. The experimental results show that our method is superior to the best methods available so far and could tackle large problems like (21, 8). Finally, we introduced a scalable and efficient parallel version for the proposed method. Our tool is available for free for academic research at http://www.nubios.nileu.edu.eg/tools/hymotif.

Availability and requirements

Project name: hymotif.

Project home page: http://www.nubios.nileu.edu.eg/tools/hymotif

Operating system(s): Linux.

Programming language: C.

Other requirements: C/C++ libraries.

License: GPL.

Any restrictions to use by non-academics: No restrictions.

References

  1. Waterman MS, Aratia R, Galas DJ: Pattern recognition in several sequences: consensus and alignment. Bulletin of Mathematical Biology. 1984, 46 (4): 515-527.

    Article  CAS  PubMed  Google Scholar 

  2. Pevzner P, Sze SH: Combinatorial approaches to finding subtle signals in DNA sequences. Proceedings of Eighth International Conference on Intelligent Systems for Molecular Biology. 2000, 269-278.

    Google Scholar 

  3. Lawrence C, Reilly A: An expectation maximization (EM) algorithm for the identification and characterization of common sites in unaligned biopolymer sequences. Proteins: Structure, Function and Genetics. 1990, 7: 41-51. 10.1002/prot.340070105.

    Article  CAS  Google Scholar 

  4. Lawrence C, Altschul S, Boguski M, Liu J, Neuwald A, Wootton J: Detecting subtle sequence signals: A Gibbs Sampling strategy for multiple alignment. Science. 1993, 262: 208-214. 10.1126/science.8211139.

    Article  CAS  PubMed  Google Scholar 

  5. Bailey T, Elkan C: Unsupervised learning of multiple motifs in biopolymers using Expectation Maximization. Machine Learning. 1995, 21: 51-80.

    Google Scholar 

  6. Fraenkel Y, Mandel Y, Friedberg D, Margalit H: Identification of common motifs in unaligned DNA sequences: application to Escherichia coli Lrp regulon. Bioinformatics. 1995, 11: 379-387. 10.1093/bioinformatics/11.4.379.

    Article  CAS  Google Scholar 

  7. Rigoutsos I, Floratos A: Combinatorial pattern discovery in biological sequences: the TEIRESIAS algorithm. Bioinformatics. 1998, 14: 55-67. 10.1093/bioinformatics/14.1.55.

    Article  CAS  PubMed  Google Scholar 

  8. Hertz GZ, Stormo GD: Identifying DNA and protein patterns with statistically significant alignments of multiple sequences. Bioinformatics. 1999, 15: 563-577. 10.1093/bioinformatics/15.7.563.

    Article  CAS  PubMed  Google Scholar 

  9. Gelfand M, Koonin E, Mironov A: Prediction of transcription regulatory sites in archaea by a comparative genomic approach. Nucleic Acid Res. 2000, 28: 695-705. 10.1093/nar/28.3.695.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  10. Buhler J, Tompa M: Finding motifs using random projections. Journal of Computational Biology. 2002, 9 (2): 225-242. 10.1089/10665270252935430.

    Article  CAS  PubMed  Google Scholar 

  11. Price A, Ramabhadran S, Pevzner PA: Finding subtle motifs by branching from sample strings. Bioinformatics. 2003, 19 (2): ii149-ii155. 10.1093/bioinformatics/btg1072.

    PubMed  Google Scholar 

  12. Huang C, Lee W, Hsieh S: An improved heuristic algorithm for finding motif signals in DNA sequences. IEEE/ACM Transactions on Computational Biology and Bioinformatics. 2011, 8 (4): 959-975.

    Article  CAS  PubMed  Google Scholar 

  13. Galas DJ, Eggert M, Waterman MS: Rigorous pattern-recognition methods for DNA sequences: analysis of promoter sequences from Escherichia coli. Journal of Molecular Biology. 1985, 186 (1): 117-128. 10.1016/0022-2836(85)90262-1.

    Article  CAS  PubMed  Google Scholar 

  14. Staden R: Methods for discovering novel motifs in nucleic acid sequences. Computer Applications in the Biosciences. 1989, 5 (4): 293-298.

    CAS  PubMed  Google Scholar 

  15. Brazma A, Jonassen I, Vilo J, Ukkonen E: Predicting gene regulatory elements in silico on a genomic scale. Genome Research. 1998, 15: 1202-1215.

    Google Scholar 

  16. Sagot MF: Spelling approximate repeated or common motifs using a suffix tree. Latin'98: Theoretical informatics, LNCS. Edited by: Lucchesi CL, Moura AV. 1998, 1380: 111-127.

    Google Scholar 

  17. Van Helden J, Andre B, Collado-Vides J: Extracting regulatory sites from the upstream region of yeast genes by computational analysis of oligonucleotide frequencies. Journal of Molecular Biology. 1998, 281 (5): 827-842. 10.1006/jmbi.1998.1947.

    Article  CAS  PubMed  Google Scholar 

  18. Tompa M: An exact method for finding short motifs in sequences with application to the ribosome binding site problem. Proceedings of seventh International Conference on Intelligent Systems for Molecular Biology. 1999, 262-271.

    Google Scholar 

  19. Marsan L, Sagot MF: Algorithms for extracting structured motifs using a suffix tree with an application to promoter and regulatory site consensus identification. Journal of Computational Biology. 2000, 7 (3-4): 345-362. 10.1089/106652700750050826.

    Article  CAS  PubMed  Google Scholar 

  20. Sinha S, Tompa M: A statistical method for finding transcription factor binding sites. Proceedings of Eighth International Conference on Intelligent Systems for Molecular Biology. 2000, 344-354.

    Google Scholar 

  21. Blanchette M: Algorithms for phylogenetic footprinting. Proceedings of Fifth International Conference Computational Biology (RECOMB 2001). 2001

    Google Scholar 

  22. Eskin E, Pevzner PA: Finding composite regulatory patterns in DNA sequences. Bioinformatics. 2002, 18 (1): 354-363. 10.1093/bioinformatics/18.suppl_1.S354.

    Article  Google Scholar 

  23. Evans PA, Smith A: Toward optimal motif enumeration. Proceedings of Eighth International Workshop Algorithms and Data Structures (WADS03). 2003, 47-58.

    Google Scholar 

  24. Carvalho AM, Freitas AT, Oliveira AL, Sagot MF: A highly scalable algorithm for the extraction of CIS-Regulatory regions. Proceedings of Third Asia Pacific Bioinformatics Conference. 2005, 273-282.

    Chapter  Google Scholar 

  25. Chin FYL, Leung HCM: Voting algorithms for discovering long motifs. Proceedings of Third Asia Pacific Bioinformatics Conference. 2005, 261-271.

    Chapter  Google Scholar 

  26. Rajasekaran S, Balla S, Huang C-H: Exact algorithms for planted motif problems. Journal of Computational Biology. 2005, 12 (8): 1117-1128. 10.1089/cmb.2005.12.1117.

    Article  CAS  PubMed  Google Scholar 

  27. Davila J, Balla S, Rajasekaran S: Space and time efficient algorithms for planted motif search. Proceedings of Second International Workshop on Bioinformatics Research and Applications (LNCS 3992). 2006, 822-829.

    Google Scholar 

  28. Pisanti N, Carvalho A, Marsan L, Sagot MF: RISOTTO: fast extraction of motifs with mismatches. Proceedings of Seventh Latin American Theoretical Informatics Symposium. 2006, 757-768.

    Google Scholar 

  29. Davila J, Balla S, Rajasekaran S: Fastand practical algorithms for planted (l, d) motif search. IEEE/ACM Transactions on Computational Biology and Bioinformatics. 2007, 544-552.

    Google Scholar 

  30. Dinh H, Rajasekaran S, Kundeti V: PMS5: an efficient exact algorithm for the (l, d)-motif finding problem. BMC Bioinformatics. 2011, 12: 410-420. 10.1186/1471-2105-12-410.

    Article  PubMed Central  PubMed  Google Scholar 

  31. Sharma D, Rajasekaran S, Dinh H: An experimental comparison of PMSprune and other algorithms for motif search. CoRR abs. 2011, 1108.5217-

    Google Scholar 

  32. Abbas MM, Bahig HM: Performance and analysis of modified voting algorithm for planted motif search. Proceedings of Seventh ACS/IEEE International Conference on Computer Systems and Applications. 2009, 725-731.

    Google Scholar 

  33. Bahig HM, Abbas MM, Bhery A: Experimental study of modified voting algorithm for planted (l, d)-motif problem. Experimental Medicine and Biology, special issue Advanced in Computational Biology, Springer. 2010, 65-73.

    Google Scholar 

  34. Rajasekaran S, Dinh H: A speedup technique for (l, d)-motif finding algorithms. BMC Research Notes. 2011, 54-61. 4

  35. Gusfield D: Algorithms on strings, trees, and sequences: computer science and computational biology. Cambridge university Press, New York. 1977

    Google Scholar 

  36. Blanchette J, Tompa M: Discovery of regulatory elements by a computational method for phylogenetic footprinting. Genome Research. 2002, 12 (5): 739-748. 10.1101/gr.6902.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  37. Cherry JM, Adler C, Ball C, Chervitz SA, Dwight SS, Hester ET, Jia Y, Juvik G, Roe T, Schroeder M, Weng S, Botstein D: SGD: Saccharomyces Genome Database. Nucleic Acid Res. 1998, 26: 73-79. 10.1093/nar/26.1.73. [http://www.yeastgenome.org/]

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  38. Zhu J, Zhang M: SCPD: A Promoter Database of the Yeast Saccha-Romyces Cerevisiae. Bioinformatics. 1999, 15 (7-8): 607-611. [http://cgsigma.cshl.org/jian/]

    Article  CAS  PubMed  Google Scholar 

  39. McInerny CJ, Partridge JF, Mikesell GE, Creemer DP, Breeden LL: A novel Mcm1-dependent element in the SWI4, CLN3, CDC6, and CDC47 promoters activates M/G1-specific transcription. Genes Dev. 1997, 11 (10): 1277-1288. 10.1101/gad.11.10.1277.

    Article  CAS  PubMed  Google Scholar 

  40. Wingender E, Dietze P, Karas H, Knuppel R: TRANSFAC: a database on transcription factors and their DNA binding sites. Nucleic Acids Research. 1996, 24 (1): 238-241. 10.1093/nar/24.1.238. [http://transfac.gbf-braunschweig.de/TRANSFAC/]

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  41. Natesan S, Gilman M: YY1 facilitates the association of serum response factor with the c-fos serum response element. Mol Cell Biol. 1995, 15 (11): 5975-5982.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

The authors are grateful to M.M. Mohie Eldin for useful discussion. The authors also thank Sanguthevar Rajasekaran for providing us with the source code of PMSprune and real datasets.

This article has been published as part of BMC Bioinformatics Volume 13 Supplement 17, 2012: Eleventh International Conference on Bioinformatics (InCoB2012): Bioinformatics. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/13/S17.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Mostafa M Abbas or Mohamed Abouelhoda.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

All authors contributed to theoretical and practical developments which form the basis of HEP method. All authors wrote and approved the manuscript.

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

Abbas, M.M., Abouelhoda, M. & Bahig, H.M. A hybrid method for the exact planted (l, d) motif finding problem and its parallelization. BMC Bioinformatics 13 (Suppl 17), S10 (2012). https://doi.org/10.1186/1471-2105-13-S17-S10

Download citation

  • Published:

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

Keywords