Skip to main content

Ranking and compacting binding segments of protein families using aligned pattern clusters

Abstract

Background

Discovering sequence patterns with variation can unveil functions of a protein family that are important for drug discovery. Exploring protein families using existing methods such as multiple sequence alignment is computationally expensive, thus pattern search, called motif finding in Bioinformatics, is used. However, at present, combinatorial algorithms result in large sets of solutions, and probabilistic models require a richer representation of the amino acid associations. To overcome these shortcomings, we present a method for ranking and compacting these solutions in a new representation referred to as Aligned Pattern Clusters (APCs). To tackle the problem of a large solution set, our method reveals a reduced set of candidate solutions without losing any information. To address the problem of representation, our method captures the amino acid associations and conservations of the aligned patterns. Our algorithm renders a set of APCs in which a set of patterns is discovered, pruned, aligned, and synthesized from the input sequences of a protein family.

Results

Our algorithm identifies the binding or other functional segments and their embedded residues which are important drug targets from the cytochrome c and the ubiquitin protein families taken from Unitprot. The results are independently confirmed by pFam's multiple sequence alignment. For cytochrome c protein the number of resulting patterns with variations are reduced by 76.62% from the number of original patterns without variations. Furthermore, all of the top four candidate APCs correspond to the binding segments with one of each of their conserved amino acid as the binding residue. The discovered proximal APCs agree with pFam and PROSITE results. Surprisingly, the distal binding site discovered by our algorithm is not discovered by pFam nor PROSITE, but confirmed by the three-dimensional cytochrome c structure. When applied to the ubiquitin protein family, our results agree with pFam and reveals six of the seven Lysine binding residues as conserved aligned columns with entropy redundancy measure of 1.0.

Conclusion

The discovery, ranking, reduction, and representation of a set of patterns is important to avert time-consuming and expensive simulations and experimentations during proteomic study and drug discovery.

Introduction

A key concern in healthcare is the major human diseases of the decade, i.e. cancer [1], Alzheimer disease, and SARS [2]. Researchers are critically pursuing solutions to address these diseases. During drug discovery, it is crucial to identify proteins as drug targets and validate their functionality [3]. Binding sites are typically the central function of a protein, and therefore, recognizing them is essential in protein function analysis. Although each protein of the same protein family performs the same function, there are variations amongst the amino acids on each primary sequence. Hence, the conserved amino acid associations on the protein sequences from one protein family reflect important functions. For example, a significant functionality of the cytochrome c protein is to bind the heme ligand from its binding sites [4], and the iron atom in the heme ligand is bonded by two binding residues, one for each side. In our experiments, it was found that each of these two binding residues is contained in a binding segment, which is represented by a sequence pattern with variations. The binding of cytochrome c and its release from the mitochondria has been shown to prevent cell death for cancer treatment [5]. Similarly, the ubiquitin protein contains seven binding residues that are also surrounded by binding segments. These binding residues and segments function by linking individual ubiquitins to create a unique poly-ubiquitin that can be recognized by other ubiquitins. Linking of these binding proteins is directly involved in the control of cancer progression [6]. A common approach to studying a protein family's function is finding the sequence patterns that have variations. Functional patterns can mutate through evolution [7, 8]; thus each occurrence of the pattern may not be an exact repeat at the same location. Hence it is difficult to find and locate the segments that embed the binding residues. Figure 1 illustrates simpler patterns that might occur in the consensus region of a protein family. The example contains six text patterns embedded five times each in 30 input sequences and will be referred to as the illustrative example throughout the paper.

Figure 1
figure 1

An intuitive example from the cytochrome c protein showing parts of the protein sequence that represent the binding sites.

Figure 1: An intuitive example from the cytochrome c protein showing parts of the protein sequence that represent the binding sites.

In Bioinformatics, two common approaches for identifying the protein family's function are by multiple sequence alignment and by motif finding. Multiple sequence alignment aligns a set of protein sequences from the same protein family in order to identify important regions and sites in the resulting alignment. Common multiple sequence alignments include Clustal Omega [9], T-Coffee [10], DIALIGN [11] and HMMER [12]. However, finding the global optimal alignment is computationally expensive, and is known in computational complexity as an NP-complete problem [13]. Even with approximate heuristics added, multiple sequence alignment is not efficient in handling large datasets. Moreover, this approach is only appropriate for highly similar sequences, but not for sequences with considerable dissimilarity. Therefore, instead of aligning the entire sequence globally, it is only suitable to identify similarities locally. Thus, the suspected consensus regions have to be located and preprocessed ahead of alignment.

Another approach for identifying the protein family's function by similar local subsequences [14] is called motif finding, which builds motifs into combinatorial models and probabilistic models. The combinatorial model identifies commonly repeated sequence patterns exhaustively [1517]. Work reported in Pevzner et al. [18] and Mandoiu et al. [19] created cliques where vertices are sequence patterns, edges connect similar sequence patterns, and complete graphs represent the best consensus patterns. However, these combinatorial methods are computationally intensive [20, 21] and produce too many possible candidates. The probabilistic model commonly uses the position weight matrix (PWM), which estimates an amino acid at each position while assuming that each position is independent [22, 23]. An alternative random sequence synthesis takes further frame-shifted position into consideration by optimally aligning amino acids to create a probabilistic sequence [24, 25]. Other probabilistic methods make use of the Markov model, where the current state depends on a specified set of the past states. One such example is the popular pFam database [26], which builds a profile Hidden Markov Model (HMM) from the multiple sequence alignment of a protein family for classifying proteins and predicting their functionality. In general, the probabilistic models compress the data into probability distributions and express amino acid associations as an ordered set of random variables.

To overcome these limitations, we approached the problem from a data mining perspective where we first considered the occurrences and strength of the sequence patterns. We began by identifying a set of statistically strong sequence patterns and developed an Aligned Pattern (AP) Synthesis Process to align and cluster similar patterns into a reduced set of Aligned Pattern Clusters (APCs) for representing the similar sequence patterns that might be associated with binding segments. These APCs capture both the statistically significant sequence association of amino acids as well as their conservations on each of the aligned columns. More precisely, our APC Process aligns and groups similar sequence patterns with variations to form a cluster of Aligned Patterns called APCs. We then examined whether or not the APCs correspond to the binding segment and binding residues that reflect the protein's functionality. This paper is an expansion of Lee et. al [27] with an expansion upon reduction and ranking of the results. The three ranking presented are coverage, quality, and standard residual.

When our APC Process was applied to the cytochrome c and ubiquitin protein families, we discovered a reduced set of APCs solutions, which corresponds to the functional binding segments and binding residues of both families. Our APC Process obtained a set of solutions smaller when compared to the combinatorial methods, rendering a more compact yet knowledge-rich representation in the form of the APC than the probabilistic method. Having a smaller set of richer representation is crucial in identifying the drug targets for drug discovery.

Methodology

This section introduces the mathematical notations and definitions required to describe the APC Process and the APC as well as the dual composition of amino acids in the original input data space and in the compact pattern space, both of which are used for calculating measures for revealing pattern characteristics. Our Aligned Pattern Clustering Process, as illustrated by the text example, undergoes two steps (Figure 2): (1) the Pattern Discovery Step (PD Step), and (2) the Aligned Pattern Clustering Step (APC Step). The PD Step discovers the most significant and non-redundant amino acid associations as sequence patterns amongst the family of sequences. Next, the APC Step groups and aligns these discovered patterns into APCs, even though the occurrences of the pattern start at different positions in their input sequences, thus consensus regions do not need to be constrained nor specified. A glossary of terms and mathematical notation is available as Additional file 1 to complement the definitions in the Methodology section.

Figure 2
figure 2

A text example using the English alphabet illustrates the problem of sequence patterns with variations. It was created to demonstrate each step of the process succinctly. This text example will be repeated throughout the paper. The overall APC Process contains two steps: the PD Step, and the APC Step. The final result is a list of APCsordered by their ranking.

Figure 2: A text example using the English alphabet illustrates the problem of sequence patterns with variations. It was created to demonstrate each step of the process succinctly. This text example will be repeated throughout the paper. The overall APC Process contains two steps: the PD Step, and the APC Step. The final result is a list of APCsordered by their ranking.

The input sequences

To begin, the input sequence is built from the alphabet Σ contains a set of characters { σ 1 , σ 2 , σ | Σ | - 1 , σ | Σ | } . As an example, the English alphabet contains 26 characters, {'a', 'b', ..., 'y', 'z'} = Σ, mathematically, σ 1 ='a', σ 2 ='b', . . ., σ 25 ='y', σ 26 ='z', and | Σ| = 26.

A single sequence Let sk be a sequence indexed by k composed of consecutive elements taken from the alphabet Σ. s k = s 1 k s 2 k …  s | s k | - 1 k s | s k | k , where each s i k Σ and sk is of length |sk |. For example, aaaaaaaaaaaaHELLOaaaaaaaaaaaa is a sequence of length 29. This sequence can be represented by s 1, where |s1 | = 29, and the character at position 13 is s 13 1 = H .

A set of sequences Let S= { s k | k = 1 , , | S | } = { s 1 , s 2 , s | S | - 1 , s | S | } be the set of sequences that represents the set of the input sequences, also called the data space, where |S| is the total number of input sequences, and each sequence having the length of | s 1 |,| s 2 |,,| s | S | - 1 |,| s | S | | respectively. Let each sequence, say sequence k, be s k = s 1 k s j k s | s k | k , where sk Σ is the elements at position j of sequence k. Together the data space is the set of sequences is

s 1 = s 1 1 s 2 1 s 3 1 …  s | s 1 | 1 ,
(1)
s 2 = s 1 2 s 2 2 s 3 2 …  s | s 2 | 2 ,
(2)
s k = s 1 k …  s j k …  s | s k | k ,
(4)
s | S | = s 1 | S | s 2 | S | s 3 | S | …  s | s | S | | | S | ,
(6)

The pattern discovery step

The PD Step is a previously developed pattern discovery and pruning algorithm [28] that obtains a condennse list of significant patterns from the family of protein sequences.

The pattern In this paper, we consider a pattern as a statistically significant and non-redundant pattern as defined in Wong et. al [28].

Definition 1 A pattern p ¯ i = s j i i s j i + 1 i …  s j i + | p ¯ i | - 1 i is a short sequence over Σ where | p ¯ i | is its order (or length). The sequence association is statistically significant and non-redundant in the sense that it is deltaclosed (i.e. it is not covered by a statistically significant super-pattern) and non-induced, (i.e. its statistical significance is not induced by its statistically strong sub-patterns ). A pattern p ¯ i is discovered by passing four statistical conditions defined in Wong et. al [28].

An UNALIGNED PATTERN p ¯ i is discovered by passes four statistical conditions defined in Wong et. al [28].

An occurrence of the pattern p ¯ i is expressed as occ ( p ¯ i ) = j i such that p ¯ i = s j i i s j i + 1 i …  s j i + | p ¯ i | - 1 i ,

Where i is the index of the sequence in which that pattern occurs, and j i is the starting index in that sequence si where the pattern begins.

s 1 = s 1 1 …  s j 1 + 1 1 s j 1 + 2 1 …  s j 1 + | p ¯ i | - 1 1 s j 1 + | p ¯ i | 1 …  s | s 1 | 1
(7)
s 2 = s 1 2 …  s j 2 + 1 2 s j 2 + 2 2 …  s j 2 + | p ¯ i | - 1 2 s j 2 + | p ¯ i | 2 …  s | s 2 | 2
(8)
s | S | = s 1 | S | …  s j | S | + 1 | S | s j | S | + 2 | S | …  s j | S | + | p ¯ i | - 1 | S | s j | S | + | p ¯ i | | S | …  s m | S |
(10)

The text example (Table 1) displays two patterns corresponding to our definition. The dataset contains two functional patterns, HELLO and MELLOW, are English words embedded in ten input sequences S= { s 1 , …  , s 10 } . The letters outside the patterns are stochastically generated from the 26 characters in the English alphabet that are identically and independently distributed.

Table 1 Example of patterns p ¯ 1 =HELLO and p ¯ 2 =MELLOW.

Data induced by the unaligned pattern Let D ( p ¯ i ) , be each of the unique occurrences of the pattern, p ¯ i , found in the input sequence. We call D ( p ¯ i ) the data induced by p ¯ i or the induced data of p ¯ i . We will return to the concept on the data induced by pattern when we use it to compute the measures for aligned columns within the context of APC.

The aligned pattern clustering step

For the APC Step, we developed an algorithm that gathers a set of similar patterns of different lengths obtained from the PD Step while aligning them into patterns of the same length by inserting gaps and wildcards. Constrained by the statistical sequence association, the corresponding elementNames in this cluster of patterns are lined up into columns, thus reflecting their conservation and variation [27].

In this paper, the APC Step is a single-linkage hierarchical clustering algorithm that takes an input of a list of patterns and synthesizes, or more precisely aligns and groups, the patterns into one or more APC(s) based on a similarity measure between APCs. Using the text example, Figure 3 illustrates one iteration of the hierarchical clustering algorithm. More precisely, it shows the last step of the iterative merge between APC C 1 and APC C 2, thereby creating the new APC C 3.

Figure 3
figure 3

In one iterative step of hierarchical clustering, an existing APC, C 1 with m = 3 and n = 6, is merged with another APC, C 2 with m = 3 and n = 5, to result in the new APC, C 3 , which is extended to m = 6 and n = 6. (a) Binding Segments (b) Binding Residues

Figure 3: In one iterative step of hierarchical clustering, an existing APC, C 1 with m = 3 and n = 6, is merged with another APC, C 2 with m = 3 and n = 5, to result in the new APC, C 3, which is extended to m = 6 and n = 6.

Definition 2 A set of A P C = { C l | l = 1 , …  , | | } = { C 1 , C 2 , …  , C | | - 1 , C | | }

An APC, C l , is a set of similar horizontal sequence patterns that have been optimally grouped and vertically aligned into a set of patterns l = { p 1 , p 2 , …  p m } represented by C l , which is expressed as

C l = A L I G N ( l ) ,
(12)
= s 1 1 s 2 1 …  s n 1 s 1 2 s 2 2 …  s n 2 s 1 m s 2 m …  s n m m × n = p 1 p 2 p m ,
(13)
= c 1 c 2 …  c n .
(14)

where s j i Σ { - } { * } is an amino acid in the pattern, pi , in an aligned column j. Each patterns of Cl is aligned into length |Cl | = n, and there is a set of | l | = m patterns (rows) in Cl.

In the text example in Figure 3, C 1 with m = 3 and n = 6, is merged with another APC, C 2 with m = 3 and n = 5, to result in the new APC, C 3, which is extended to m = 6 and n = 6.

Definition 3 An Aligned Pattern, which will simply be referred to as a pattern from this point forward, is a sequence of order-preserving amino acids maximizing the similarity of the patterns against a set of pattern from an APC, l of size | l | = m with gaps, wildcards, and mismatches. Let p i l be s 1 i s 2 i …  s | p i | i , where s j i Σ { - } { * } is an amino acid in the pattern pi and in the aligned column index c j .

Definition 4 An aligned column cj in Cl represents the jth column of amino acids that have been aligned from the set of patterns contained in the current APC, Cl = ( c 1 c 2 … c n ). A conserved ALIGNED COLUMN is conserved to only one type of amino acid such that c j = [σ ... σ ... σ]T where σ Σ.

For the text example, the APC Step creates an APC containing six patterns with six aligned columns (Table 2). The APC is obtained from the alignment of a set of similar patterns, where each row is a pattern from l and each column is an aligned column of amino acids. Here, the pattern for the third row is p3 = HELLO and the aligned column for the first position is c 1 = [BM HBBH]T

Table 2 Example of an APC for the text example.

Data induced by apc Let D ( C l ) be data induced by the APC Cl, which is the subset of segments from the input sequences, or the data subspace containing all the pattern from the APC, Cl, where its corresponding l = { p 1 , p 2 , …  p m } T . We call D ( C l ) the data induced by Cl or the induced data of Cl. Then D ( C l ) is then the union of the segements from the input sequences induced by all the patterns contained in Cl, D ( C l ) = D ( p 1 ) D ( p 2 ) D ( p m ) = p i l D ( p i )

Measuring and ranking results

The three measures of APCs

In order to rank the set of constructed APCs, , three measures are computed for each APC, Cl. The three measures are Coverage, APC Quality, and Standard Residual.

Coverage The coverage of an APC accounts for the total input sequences that are covered by the APC, Cl, over the entire set of input sequences. Note that this is also counting the number of occurrences in the induced dataspace D ( C l ) .

APC Quality The APC Quality, Q, is the average column entropy subtracted from one, where entropy is computed from the set of Aligned Patterns, l C l . The APC Quality measures the stability or reliability of a APC, whereas the entropy measures the randomness or the degree of variation within an APC. The value of Q approaches one while the resulting APC is more stable. The value of Q approaches zero while the resulting APC is more random. Q is expressed as:

Q = 1 - j = 1 n H ( c j ) n ,
(15)

where cj is the aligned column in the resulting APC.

H ( c j ) = - σ c j P r ( c j = σ ) log P r ( c j = σ ) ,
(16)
P r ( c j = σ ) = i = 1 m 1 ( s i j = σ ) m
(17)

where σ Σ {−} {*} is the amino acid s i j of p i at c j , and the probability Pr(c j = σ) is computed from counting the subset of patterns in l.

Standard Residual The Standard Residual measures the statistical significance of the APC by comparing the actual number of occurrences, o, of all the patterns included in the APC, against the expected number of occurrences, e, which is computed from the default random model of APC. It is written as

StandardResidual  = o - e e ,
(18)

where o is the actual number of occurrences of the pattern in Pl counted from the input data, D ( C l ) and e is the expected number of occurrences computed from the default random model of APC, C, by assuming that each of the aligned columns c j are independent and identically distributed (i.i.d.) shown below:

e = E [ C ] ,
(19)
= N P r ( C ) ,
(20)
= N P r ( c 1 ) P r ( c 2 ) …  P r ( c n ) ,
(21)
= N j = 1 n P r ( c j ) ,
(22)

where N is the length of the input sequence and each of the aligned columns c j C is i.i.d. To compute the default probability of the aligned columns, Pr(cj), sum the probability of all the possible amino acids in the one single aligned columns. P r ( c j ) = P r ( c j = σ 1 ) + P r ( c j = σ 2 ) + + P r ( c j = σ k ) = σ k c j P r ( c j = σ k ) , where Pr ( c j = σ k ) = 1 20 for each σ k is i.i.d. Returning to the text example with 6 patterns and 6 aligned columns and the English alphabet, P r c 1 = P r c 1 = B + P r c 1 = M + P r c 1 = H = 3 26 . Therefore, the final expectation is

e = N i = 1 n σ k c j P r ( c j = σ k .
(23)

The redundancy measure of the aligned columns

The Redundancy Measure [29] indicates the specificity or stability of the amino acids in an aligned column based on the frequency of the occurrences of the amino acids taken from that aligned column of its D ( C l ) . The Redundancy Measure R 1(cj ) for the aligned column cj is

R 1 c j = 1 - H c j .
(24)

where H(c j ) with Pr(c j = σ) being computed from counting of σ in the aligned column, c j , of the entire input sequences, D ( C l ) . Hence, a conserved aligned column has R 1(c j ) = 1 since minimum entropy value of H(c j ) = 0. Similarly a variable aligned column has R 1(c j ) = 0 the maximum entropy value of H(c j ) = 1. If the amino acid occurrences in D ( C l ) are equiprobable.

Note that the entropy of the Redundancy Measure is computed from the entropy of the induced data, D ( C l ) , whereas the entropy of the APC Quality uses the amino acids from the patterns in l . This is because the quality of the APC measures how much variation or stability is in the patterns, whereas the redundancy of the aligned column measures how much the redundancy or consistency is in the induced data.

Results and discussions

We applied our APC Process on the cytochrome c and the ubiquitin protein families in order to examine how the resulting APCs relate to the binding sites, which are the biologically significant regions of the protein. There are three aspects we would like to explore: the reduction of the set of candidate solutions from the discovered patterns to APCs obtained; how each pattern in the APC surrounding the binding site represents a binding segment in a single strand of protein; and how binding residues correlate to their aligned column. Finally, we display our results underneath the pFam multiple sequence alignment to compare the differences in the representations. In the comparison, we demonstrate the overall hierarchical clustering performance of our APC Process as well as the quality of the resulting APCs.

Cytochrome C results

First, we demonstrated that by grouping similar patterns together, the APC reduces the number of candidate solutions to be examined without losing information. Next, we showed that in the binding APCs, each pattern represents a binding segment in the protein sequence and each of the two binding sites is represented by a specific aligned column. The 317 sequences from the cytochrome c protein family were obtained on September 17th, 2012 from Uniprot by searching the following terms: cytochrome c; AND reviewed:yes; AND name:c*; AND mnemonic:c*; AND (name:cytochrome AND name:c); NOT name:type; NOT name:VPR; NOT name:biogenesis; NOT name:*ase; NOT (name:cytochrome AND name:b*); NOT like; NOT proba*; AND fragment:no; AND active:yes. These selected parameters should help to yield a reasonable number of input sequences for the APC Process. From these 317 input sequences, the PD Step was executed with the minimal order of 5, the minimum occurrence of 20, and the delta of 0.9. The PD Step discovered 154 patterns from the cytochrome c protein family, where 28 patterns, or 18.18% of the total patterns, contain the proximal binding site, His18, and 23 patterns, or 14.94% of the total patterns, contain the distal binding site, Met62, resulting in a combined total of 33.12% of the discovered patterns that contains one of the two binding sites. Therefore, the set of patterns redundantly covers the two binding sites. This observation indicates that each individual pattern alone covers only a small fraction of the input sequences in the data space; therefore, a single pattern by itself cannot fully represent the rich variations of all the input sequences within the entire protein family. Hence, the APC, which contains a set of similar patterns that has been grouped and aligned to allow variations, provides a reduced and much richer representation of the binding segments and binding residues.

In the APC Step, we showed that our APC Process reduced the number of candidate solutions without losing any information and richly captured the binding sites in the compact APCs where the binding segments are the patterns therein and the binding sites are the conserved aligned columns. We ensure that all the patterns discovered are strongly statistically significant by starting with a tighter configuration to ensure the quality of the result. From this list of 154 statistically significant and non-redundant patterns obtained from the previous PD Step, the APC Step was executed with the following settings: the Merge Algorithm as Global Alignment, the SIMILARITY Score as Hamming Distance, the TERMINATION Condition Score less than 0.8, the heuristics column distribution score greater than 0.8 and the minimum of three overlapping column matches.

We found the following two results (Table 4): five APCs (13.89% of the total number of APCs) discovered contains the proximal binding site, His18; five APCs (13.89% of the total number of APCs) contains the distal binding site, Met62; and 27.78% of the combined total. This observation indicates that, while retaining the full information, the 154 patterns were reduced to 36 APCs, a total reduction of 76.62% for documentation and visualization.

Table 3 The 36 APCs of the Cytochrome C Family Ranked by Standard Residual (where m = the number of patterns in the APC, and n = length of the APC)).
Table 4 Comparing the Number of APCs and Patternss.

It can be seen in Table 5, the top four resulting APCs correspond to the proximal and distal binding segments of the cytochrome c protein family. More specifically, 26 proximal patterns were reduced to the two top APCs (a 92.31% reduction) and 16 distal patterns are reduced to the two top APCs (a 87.50% reduction), for a combined reduction of 88.10% for these top four APCs.

Table 5 Comparing the Top Four APCs and their Patterns.

Cytochrome C discussion

Biologically, the two binding residues in the cytochrome c protein that bind the heme ligand are the proximal binding residue that binds the heme ligand from the proximal side of the protein [4, 30]; and the distal binding residue that binds the heme from the other side of the protein [31]. The proximal and distal binding sites are located in the protein and bind the heme ligand from above and below the horizontal plane, respectively. Specifically, one particular amino acid from each of the two protein segments binds the iron molecule located in the centre of the heme: the "H" (Histidine) residue at position 18, which is the proximal side of the protein sequence and the "M" (Methionine) residue at position 62, which is the distal side of the protein sequence. These two binding residues, His18 and Met62, are also confirmed by the three-dimensional structure, PDBID 1F1F, of the cytochrome c protein (Figure 4). Our results showed that the set of APCs discovered by our APC Step that contained the protein binding sites - the main biological function of the protein. In fact, the four top resulting APCs precisely correspond to these crucial binding segments that contain conserved aligned columns corresponding to the binding residues.

Figure 4
figure 4

One three-dimensional structure from the cytochrome c protein family, PDB ID 1F1F, is displayed. The top-two statistically significant APCs from the cytochrome c protein are the proximal binding segment (in pink) and the distal binding segment (in blue) that bind the heme from above and below the horizontal plane, respectively. More specifically, one specific amino acid from each of the two segments binds the iron molecule from the centre of the heme: the "H" (Histidine) residue at position 18 of the proximal segment and the "M" (Methionine) residue at position 62 of the distal segment.

Figure 4: One three-dimensional structure from the cytochrome c protein family, PDB ID 1F1F, is displayed. The top-two statistically significant APCs from the cytochrome c protein are the proximal binding segment (in pink) and the distal binding segment (in blue) that bind the heme from above and below the horizontal plane, respectively. More specifically, one specific amino acid from each of the two segments binds the iron molecule from the centre of the heme: the "H" (Histidine) residue at position 18 of the proximal segment and the "M" (Methionine) residue at position 62 of the distal segment.

The ten APCs that correlate to the two binding sites were first clustered based on their horizontal patterns in their rows and are then aligned into their aligned columns that reveal their vertical stability. Firstly, each APC contains a set of conserved patterns that are similar to one another. Although these patterns suggest their horizontal significance in the protein family, individually they do not identify the significance of the amino acid's conservation and variation. Thus, the aligned columns is important for identifying the stability of the binding residue. Secondly, the aligned columns of each binding APC show the conservation of aligned columns in the cluster, which otherwise is not easily seen in the individual non-variable patterns. For example, consider the top two APCs that correspond to each of the proximal (Table 7) and distal binding segments (Table 6). In the Tables, the columns in bold are the conserved aligned columns with R1 = 1.0, where R1 reflects the specificity of the residue of the site in the APC. The aligned columns corresponding to the binding sites of the APCs have an R1 value of 1.0, that is, the amino acid for that aligned column is conserved in the data space. To give a precise example, consider the proximal APC that is ranked second. This APC has three conserved aligned columns with R1 value of 1.0: Gln16, Cys17, and His18. The His18 conserved aligned column is the proximal binding residue, and the Cys17 binds an adjacent corner on the heme ligand. Similarly, the conserved aligned column representing Met62 in the distal APCacts as the distal binding residue. The other conserved aligned columns can be used to identify other important functions in the protein.

Table 6 The Distal APC of the Cytochrome C Family.
Table 7 The Proximal APC of the Cytochrome C Family.

By matching the individual APCs up to the independent HMM alignment of pFam (Figure 5), we confirmed the validity of our set of 36 APCs. In addition, our proximal APC for cytochrome c is consistent with the proximal binding motif: [C]-x(2)-[CH], from PROSITE (PDOC00169) [32, 33] and a strong emission probability in pFam (PF00034) [26, 34]. Moreover, our method strongly identified the distal binding in our APCs where PROSITE does not annotate the binding site and pFam identifies only as a weak emission probability.

Figure 5
figure 5

Ten resulting APCs representing the proximal and distal binding segments of the cytochrome c are compared to the HMM logo from pFam. In the largest APC, Cys17 is identified as one of the conserved aligned columns, where His18 binds to the heme iron. In the second largest APC, Met62 is identified as one of the conserved aligned column of the distal binding segment, where Met62 binds the heme iron.

In conclusion, the APC can represent protein functions such as the binding segments and binding residues and presents a reduced set of candidate solutions and specifies their location in the protein family. In cytochrome c, the prevention of binding can block cancer progression, which is an important drug discovery for cancer treatment.

Ubiquitin results

To further study the APC Step, we closely examined the iterative steps and its resulting APCs using the ubiquitin protein family. The 70 sequences from the ubiquitin protein family used in our experiment were obtained on August 9th, 2012 from Uniprot by searching the following terms: name:ubiquitin; NOT name:*ase; NOT name:like; NOT name:ribosomal; NOT name:modifier; NOT name:factor; NOT name:protein; NOT name:conjugating; NOT name:activating; NOT name:enzyme; AND reviewed:yes; AND mnemonic:UB*.

Figure 5: Ten resulting APCs representing the proximal and distal binding segments of the cytochrome c are compared to the HMM logo from pFam. In the largest APC, Cys17 is identified as one of the conserved aligned columns, where His18 binds to the heme iron. In the second largest APC, Met62 is identified as one of the conserved aligned column of the distal binding segment, where Met62 binds the heme iron.

Figure 6: The seven Lys binding residues of the ubiquitin protein family are highlighted in the APCs: Lys6, Lys11, Lys27, Lys29, Lys33, Lys48, and Lys63. Six of the seven binding sites are discovered, all except Lys29, are conserved aligned column with R1 = 1.0.

Figure 6
figure 6

The seven Lys binding residues of the ubiquitin protein family are highlighted in the APCs: Lys6, Lys11, Lys27, Lys29, Lys33, Lys48, and Lys63. Six of the seven binding sites are discovered, all except Lys29, are conserved aligned column with R1 = 1.0.

These adopted parameters help yield a reasonable number of input sequences for our study. From these 70 input sequences, the PD Step was executed with the minimal order of 10, the minimum occurrence of 20, and the delta of 0.9 to yield a proper size of the results for the study. Table 8 shows the thirty discovered patterns, where all except five of the patterns contained the seven binding residues. Nevertheless, these patterns still corresponded to the conserved amino acids around the binding residues. Therefore, all the discovered patterns indicate important functionality in the ubiquitin protein family, such as the binding site or the areas next to the binding site. Once again, each pattern on its own occurs only a few times, and has only a low frequency count for representing the binding segments of this protein family. Since protein binding segments exhibit considerable variability, APCs represent the protein family's functional binding sites more explicitly and effectively.

Table 8 Statistically Ranked Patterns Discovered from the Sequences of the ubiquitin Family.

From this list of 30 statistically significant patterns obtained from the previous PD Step, the APC Step was executed with the following settings: the MERGE Algorithm as Global Alignment, the SIMILARITY Score as Hamming Distance, the TERMINATION Condition Score less than 0.3, the heuristics column distribution score greater than 0.3 and the minimum of three overlapping column matches. We demonstrated the efficacy of our APC Process by showing the reduced set of 9 APCs and their binding sites (Table 9).

Table 9 The 36 APCs of the ubiquitin Family Ranked by Standard Residual (where m = the number of patterns in the APC, and n = length of the APC)).

Ubiquitin discussion

The ubiquitin protein contains seven lysine residues, Lys6, Lys11, Lys27, Lys29, Lys33, Lys48, and Lys63, that can be linked to another ubiquitin to form a poly-ubiquitin chain [3537]. The seven binding residues are visualized in the three-dimensional structure of the ubiquitin protein (Figure 7). Our resulting APCs

Figure 7
figure 7

The three-dimensional structure of the ubiquitin protein, with PDB ID 1UBQ from the protein data bank, has seven binding residues: Lys6, Lys11, Lys27, Lys29, Lys33, Lys48, and Lys63.

Figure 7: The three-dimensional structure of the ubiquitin protein, with PDB ID 1UBQ from the protein data bank, has seven binding residues: Lys6, Lys11, Lys27, Lys29, Lys33, Lys48, and Lys63.

correspond to six of the seven binding residues ()Lys6, Lys11, Lys27, Lys33, Lys48, and Lys63). The remaining Lys33 is found in an APC with only one pattern and thus stands out as a significant functional group with a distinct pattern discovered with high statistical significance in the PD Step.

For ubiquitin, our APCs are pattern alignments that agree with the emission probabilities of the pFam profile HMM (Figure 6). All eight APCs discovered agreed with the pFam HMM emission probability. Surprisingly, our results differs from PROSITE's consensus motif (PDOC00271), which missed 172 ubiquitin proteins. In drug discovery, preventing the linking of ubiquitin to its binding proteins via its binding site inhibits cancer growth.

Conclusion

Our APC Process greatly reduces the number of APCs in comparison with other methods. This is due to the fact that the APC sstep starts with input patterns from the PD Step rather than the entire input search space. This drastically reduces the search space in a controlled manner. From the application aspect, using data from two Uniprot protein families (cytochrome c and ubiquitin), the majority of top-ranking APCs corresponded to their protein binding segments. The resulting cytochrome c binding APCs agree with the pFam emission probability. An APC represents a set of patterns as the horizontal rows and its aligned columns as the vertical columns, which can be further evaluated for amino acid conservations. In fact, for cytochrome c, the proximal and distal binding residues correspond to conserved aligned columns with R1 of 1.0. In addition, the distal APC identifies one conserved aligned column with R1 of 1.0 as the binding residue, which is not identified in PROSITE or pFam. While the ubiquitin APCs agree with pFam emission probability, six of the seven binding residues are successfully identified in the APC.

In conclusion, APCs can be used to reveal functional domains across different protein families without relying on prior knowledge or clues about the consensus regions. Currently, we are using aligned column variations as amino acid characteristics to classify protein species and gene labels. We are also extending the algorithm to discover interdependencies within APCs and long-distance associations among APCs. In more general cases of protein analysis, the function and the nature of the protein function are not clear; thus, the capability that overcomes such difficulties marks the uniqueness and novelty of our APC Process. In the broader sense, this knowledge is essential for understanding the proteins involved in epigenetics for drug discovery [38]. The development of cancer generally increases with age, and with the ageing baby-boomer population it is crucial for drug companies to find cost-effective and time-saving techniques for drug discovery.

References

  1. Peto J: Cancer epidemiology in the last century and the next decade. Nature 2001,411(6835):390–395. 10.1038/35077256

    Article  CAS  PubMed  Google Scholar 

  2. Forman MS, Trojanowski JQ, Lee VMY: Neurodegenerative diseases: a decade of discoveries paves the way for therapeutic breakthroughs. Nature medicine 2004, (10.10):1055–1063.

  3. Hughes J, Rees S, Kalindjian S, Philpott K: Principles of early drug discovery. Br J Pharmacol 2011,162(6):1239–1249. 10.1111/j.1476-5381.2010.01127.x

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  4. Colon W, Wakem LP, Sherman F, Roder H: Identification of the Predominant Non-Native Histidine Ligand in Unfolded Cytochrome c. Biochemistry 1997, 36: 12535–12541. 10.1021/bi971697c

    Article  CAS  PubMed  Google Scholar 

  5. Martinou JC, Desagher S, Antonsson B: Cytochrome c release from mitochondria: all or nothing. Nature Cell Biology 2000, 2: E41-E43. 10.1038/35004069

    Article  CAS  PubMed  Google Scholar 

  6. Hoeller D, Dikic I: Targeting the ubiquitin system in cancer therapy. Nature 2009,458(7237):438–444. 10.1038/nature07960

    Article  CAS  PubMed  Google Scholar 

  7. Butenko S, Chaovalitwongse WA, Pardalos PM: Clustering Challenges in Biological Networks. World Scientific, illustrated edition 2009;

  8. Brejová B, Vinar T, Li M: Pattern discovery: Methods and software. Introduction to Bioinformatics 2003, 491–522.

    Google Scholar 

  9. Thompson JD, Higgins DG, Gibson TJ: CLUSTAL W: improving the sensitivity of progressive multiple sequence alignment through sequence weighting, position-specific gap penalties and weight matrix choice. Nucleic Acids Res 1994,22(22):4673–80. 10.1093/nar/22.22.4673

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  10. Notredame C, Higgins DG, Heringa J: T-Coffee: A novel method for fast and accurate multiple sequence alignment. J Mol Biol 2000,302(1):205–17. 10.1006/jmbi.2000.4042

    Article  CAS  PubMed  Google Scholar 

  11. Amarendran R Subramanian aMK, Morgenstern B: DIALIGN-TX: greedy and progressive approaches for segment-based multiple sequence alignment. Algorithms Mol Biol 2008.,3(6):

  12. Durbin R, Eddy SR, Krogh A, Mitchison G: Biological Sequence Analysis: Probabilistic models of proteins and nucleic acids. Cambridge University Press; 1998.

    Book  Google Scholar 

  13. Wang L, Jiang T: On the complexity of multiple sequence alignment. Journal of Computational Biology 1994,1(4):337–348. 10.1089/cmb.1994.1.337

    Article  CAS  PubMed  Google Scholar 

  14. Frith MC, Hansen U, Spouge JL, Weng ZP: Finding functional sequence elements by multiple local alignment. Nucleic Acids Res 2004,32(1):189–200. 10.1093/nar/gkh169

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  15. Buhler J, Tompa M: Finding motifs using random projections. J Comput Biol 2002.

    Google Scholar 

  16. Hideya Kawaji YT, Matsuda H: Graph-based clustering for finding distant relationships in a large set of protein sequences. Bioinformatics 2004, 20: 243–252. 10.1093/bioinformatics/btg397

    Article  PubMed  Google Scholar 

  17. Patwardhan R, Tang H, Kim S, Dalkilic M: An Approximate de Bruijn Graph Approach to Multiple Local Alignment and Motif Discovery in Protein Sequences. Data Mining and Bioinformatics 2006, 4316: 158–169. 10.1007/11960669_14

    Article  Google Scholar 

  18. Pevzner P, Sze S: Combinatorial approaches to finding subtle signals in DNA strings. In Proc ISMB 2000, 2000: 269–278.

    Google Scholar 

  19. Mandoiu I, Zelikovsky A: Bioinformatics Algorithms: Techniques and Applications. Wiley Series in Bioinformatics, Wiley; 2008.

    Book  Google Scholar 

  20. Li M, Ma B, Wang L: Finding similar regions in many strings. Journal of Computer and System Sciences 2002, 65: 73–96. 10.1006/jcss.2002.1823

    Article  Google Scholar 

  21. Evans PA, Smith A, Wareham HT: On the complexity of finding common approximate substrings. Theoretical Computer Science 2003,306(3):407–430.

    Article  Google Scholar 

  22. Aleksandrushkina NI, Egorova LA: Nucleotide makeup of the DNA of thermophilic bacteria of the genus Thermus. Mikrobiologiia 1978,47(2):250–252.

    CAS  PubMed  Google Scholar 

  23. Jeong JC, Lin X, Chen XW: On Position-Specific Scoring Matrix for Protein Function Prediction. IEEE/ACM Transactions on Computational Biology and Bioinformatics 2011,8(2):308–315.

    Article  PubMed  Google Scholar 

  24. Chan SC, Wong AKC: Synthesis and Recognition of Sequences. IEEE Trans on PAMI 1991,13(12):1245–1255. 10.1109/34.106998

    Article  Google Scholar 

  25. Wong AKC, Chiu DKY, Chan SC: Pattern Detection in Biomolecules Using Synthesized Random Sequence. Journal of Pattern Recognition 1995,29(9):1581–1586.

    Article  Google Scholar 

  26. Sonnhammer EL, Eddy SR, Durbin R: Pfam: A Comprehensive Database of Protein Domain Families Based on Seed Alignments. PROTEINS: Structure, Function, and Genetics 1997, 28: 405–420. 10.1002/(SICI)1097-0134(199707)28:3<405::AID-PROT10>3.0.CO;2-L

    Article  CAS  Google Scholar 

  27. Lee ESA, Wong AKC: Identifying Protein Binding Functionality of Protein Families by Aligned Pattern Clusters. IEEE International Conference on Bioinformatics and Biomedicine 2012.

    Google Scholar 

  28. Wong AK, Zhuang D, Li GC, Lee ESA: Discovery of Delta Closed Patterns and Non-induced Patterns from Sequences. IEEE Transactions on Knowledge and Data Engineering Journal 2012,24(8):1408–1421.

    Article  Google Scholar 

  29. Wong AKC, Liu TS, Wang CC: Statistical Analysis of Residue Variability in Cytochrome C. Journal of Molecular Biology 1976, 102: 287–295. 10.1016/S0022-2836(76)80054-X

    Article  CAS  PubMed  Google Scholar 

  30. Kranz R, Richard-Fogal C, Taylor J, Frawley E: Cytochrome c biogenesis: mechanisms for covalent modifications and trafficking of heme and for heme-iron redox control. Microbiology and molecular biology reviews 2009,73(3):510–528. 10.1128/MMBR.00001-09

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  31. Stevens J, Daltrop O, Allen J, Ferguson S: C-type cytochrome formation: chemical and biological enigmas. Accounts of chemical research 2004,37(12):999–1007. 10.1021/ar030266l

    Article  CAS  PubMed  Google Scholar 

  32. Bairoch A: PROSITE: a dictionary of sites and patterns in proteins. Nucleic Acids Research 1991, 19: 2241–2245. 10.1093/nar/19.suppl.2241

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  33. Sigrist CJ, Cerutti L, Castro ED, Langendijk-Genevaux PS, Bulliard V, Bairoch A, Hulo N: PROSITE, a protein domain database for functional characterization and annotation. Nucleic acids research 2010,38(suppl 1):D161-D166.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  34. Finn RD, Mistry J, Tate J, Coggill P, Heger A, Pollington JE, Gavin OL, Gunasekaran P, Ceric G, Forslund K, Holm L, Sonnhammer EL, Eddy SR, Bateman A: The Pfam protein families database. Nucleic acids research 2010, 38: D211–22. 10.1093/nar/gkp985

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  35. Peng J, Schwartz D, Elias JE, Thoreen CC, Cheng D, Marsischky G, Roelofs J, Finley D, Gygi SP: A proteomics approach to understanding protein ubiquitination. Nature biotechnology 2003,21(8):921–926. 10.1038/nbt849

    Article  CAS  PubMed  Google Scholar 

  36. Xu PP: Characterization of Polyubiquitin Chain Structure by Middle-down Mass Spectrometry. Analytical chemistry 2008,80(9):3438–44. 10.1021/ac800016w

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  37. Ikeda F, Dikic I: Atypical ubiquitin chains: new molecular signals. EMBO reports 2008,9(6):536–542. 10.1038/embor.2008.93

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  38. Arrowsmith CH, Bountra C, Fish PV, Lee K, Schapira M: Epigenetic protein families: a new frontier for drug discovery. nature Reviews 2012, 11: 384–400. 10.1038/nrd3674

    CAS  PubMed  Google Scholar 

Download references

Acknowledgements

The authors wish to thank their colleagues C. M. Li, D. Yuen, and members of graduate small group for reading this manuscript. This research is supported by an NSERC Post Graduate Scholarship and an NSERC Discovery Grant.

Declarations

The publication costs for this article were funded by the corresponding author

This article has been published as part of Proteome Science Volume 11 Supplement 1, 2013: Selected articles from the IEEE International Conference on Bioinformatics and Biomedicine 2012: Proteome Science. The full contents of the supplement are available online at http://www.proteomesci.com/supplements/11/S1.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to En-Shiun Annie Lee.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

The work presented here was carried out in collaboration between all authors. AKCW defined the research theme. EAL designed methods and experiments, carried out the experiments. Both AKCW and EAL analyzed the data, interpreted the results and wrote the paper. All authors have contributed to, seen and approved the manuscript.

Electronic supplementary material

12953_2013_461_MOESM1_ESM.pdf

Additional file 1: The glossary of terms and mathematical notations to complement the definition in the Methodology section of this paper. (PDF 135 KB)

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. 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

Cite this article

Lee, ES.A., Wong, A.K. Ranking and compacting binding segments of protein families using aligned pattern clusters. Proteome Sci 11 (Suppl 1), S8 (2013). https://doi.org/10.1186/1477-5956-11-S1-S8

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1477-5956-11-S1-S8

Keywords