Skip to main content

METHODS article

Front. Genet., 09 June 2020
Sec. Computational Genomics

Using Cellular Automata to Simulate Domain Evolution in Proteins

  • 1Computer Department, Jing-De-Zhen Ceramic Institute, Jingdezhen, China
  • 2Faculty of Information Systems and Technologies, University of Donja Gorica, Podgorica, Montenegro

Proteins play primary roles in important biological processes such as catalysis, physiological functions, and immune system functions. Thus, the research on how proteins evolved has been a nuclear question in the field of evolutionary biology. General models of protein evolution help to determine the baseline expectations for evolution of sequences, and these models have been extensively useful in sequence analysis as well as for the computer simulation of artificial sequence data sets. We have developed a new method of simulating multi-domain protein evolution, including fusions of domains, insertion, and deletion. It has been observed via the simulation test that the success rates achieved by the proposed predictor are remarkably high. For the convenience of the most experimental scientists, a user-friendly web server has been established at http://jci-bioinfo.cn/domainevo, by which users can easily get their desired results without having to go through the detailed mathematics. Through the simulation results of this website, users can predict the evolution trend of the protein domain architecture.

Introduction

Proteins are the biological macromolecular entities most close-knitly related to organismal functions. Evolution in the sequences of proteins results in the way these proteins function, and protein evolution is a critical component of organismal evolution and a valuable method for generating useful molecules in the laboratory (Leconte et al., 2013). Therefore, the research on protein evolution plays an elementary and central role in computational proteomics. Experimental efforts to understand protein evolution have largely depended on the reconstruction of hypothetic evolutionary intermediates or on experimental evolution over modest numbers of rounds of evolution (Weinreich et al., 2006; Gumulya et al., 2012). Long evolutionary trajectory experiments have met challenges in studying proteins but have been successfully executed only for whole organisms and RNA. Directed evolution has been a powerful technique for generating tailor-made enzymes for a wide range of biocatalytic applications (Zeymer and Hilvert, 2018), but it is both time- and money-consuming to study protein evolution by conducting experiments alone. With the rapid development of computational power, hidden Markov model based on statistics, phylogeny model based on Bayesian statistics, and better prediction method of protein structure, the ability to model evolutionary processes in proteins has improved.

Protein evolution is modeled firstly by considering the amino acid substitution process. Dayhoff et al. (1978) proposed the most influential amino acid substitution model. This simple model supposes that all sites in the protein sequence are independent of each other during protein evolution, and that each site mutation depends on an amino acid replacement matrix. Since then, many protein evolution models based on amino acid substitution matrices have been proposed, such as the JTT model (Jones et al., 1992), the mtREV model (Adachi and Hasegawa, 1996), and the WAG model (Whelan and Goldman, 2001). However, in most cases, the assumption that “the proteins are independent of each other during evolution” is not consistent with the fact that any amino acid residue within the protein interacts with its neighboring amino acids. Yang (1993) has designed an ingenious method that allows variant sites in the amino acid sequence to have variant rates of evolution. This method basically classifies amino acids according to their physicochemical properties, making amino acids with similar properties more likely to be replaced (Yang, 1993). Protein evolution is driven by the sum of variant physiochemical and genetic processes that usually results in strong purifying selection to maintain biochemical functions. However, proteins that are part of systems under arms race dynamics often evolve at unparalleled rates that can produce atypical biochemical properties (Wilburn et al., 2018).

Phylogenetic methods have been widely used to analyze the evolutionary history of protein sequences. The simulation of sequences is one means of investigating phylogenetic hypotheses (Tuffery, 2002). There are many more powerful bioinformatics tools for such simulations (Bakan et al., 2014). Sirakoulis et al. (2003) used a cellular automaton (CA) model for the study of DNA sequence evolution where DNA is modeled as a one-dimensional (1D) CA with four states per cell which correspond to four DNA bases. Moreover, they have developed genetic algorithms in order to determine the rules of CA evolution that simulate the DNA evolution course. Simulation models for protein evolution based on CA have lagged far behind models of DNA evolution because proteins are composed of 20 amino acids, while DNA is composed of only four nucleotides. Many authors developed different simulations of protein evolution, but few of them are operated by non-expert users. They are either very specific for certain needs or distributed as non-interactive command-line programs or require a complex preparation of the input data. This precludes these techniques being used by most molecular biologists.

Proteins are composed of domains, recurrent protein fragments with distinct structure and function, and proteins can be classed as single-domain proteins or multi-domain proteins (Chothia, 1992; Riley and Labedan, 1997). The structural domain databases SCOP and CATH were gathered based on identifying recurring elements in experimentally determined protein three-dimensional (3D) structures (Dawson et al., 2016; Chandonia et al., 2017). In Pfam databases, conserved regains are identified from sequence analysis and background knowledge to make multiple sequence alignments (El-Gebali et al., 2019). Domain definitions form different databased only partially overlap; however, the choice of database appears to have little effect on modeling the evolution of protein domain architectures (Apic et al., 2001). Domain architecture generally refers to the domains in a protein and their order, reported in N- to C-terminal direction along the amino acid chain. The mechanisms for domain architecture change can be classed into new domain, fission, and fusion (Fong et al., 2007). The multi-domain architectures usually evolve from existing architectures because few multi-domain architectures contain all new domain. Fusion class would be partitioned into three sub-cases as fusion of new domains, fusion of parent architectures, and fusion of parent architecture and new domain. Snel et al. (2000) summarized that domain fusions are more common that domain fissions, and the result was subsequently supported by a larger study by Kummerfeld and Teichmann (2005). Buljan and Bateman observed that domain architecture changes primarily take place at the protein termini and it can be explained from that terminal changes to the architecture are less likely to disturb overall protein structure (Buljan and Bateman, 2009), and similar results have been found in several other studies (Buljan et al., 2010). Zhang et al. (2012) and Sharma and Pandey (2016) studied the role of gene duplication in plants protein domain architecture evolution. More recently, Wiedenhoeft et al. (2011) used a network construct named as plexus to reconstruct domain architecture history. Stolzer et al. (2015) present another method for domain architecture history inference, made available through the Notung software.

Multi-domain proteins have evolved by insertions or deletions of distinct protein domains. We have a general understanding of the mechanisms of protein domain architecture evolution based on the aforementioned models. Here we introduce a new protein evolution simulation model to simulate the evolution of protein domains by 1D CA. In the model, the HMMER (Prakash et al., 2017) and Pfam databases are united in the process for annotating the protein domains, and it can be easily to simulate the evolution of the domain architecture in the multi-domain protein family. Furthermore, the model may obtain new domain architecture which may be the potential protein evolution.

Methods And Implementation

Data Preprocessing

After receiving the protein sequence file P (P = {p1, p2, p3, …, pn}, where p1, p2, p3, …, pn represent the protein sequence in the file) in FASTA format, the system annotates the protein domain of each protein sequence pi based on the HMMER and Pfam databases, and each protein pi generates a corresponding annotation file fi. By analyzing the annotation file fi, the domain information of protein pi can be screened out and expressed as a multi-domain sequence:

pi={di,1,di,2,di,3,,di,k}    (1)

where di, 1, di, 2, di, 3, …, di, k represent the homologous domain of the protein pi, k is the number of domains in protein pi. According to the ACC (the average posterior probability of the aligned target sequence residues) value of each domain, we determine the position of these domains in the protein sequence or the order of domains in the sequence. The protein pi is expressed as an ordered multi-domain sequence pi based on the context of these domains:

pi=di,1,di,2,di,3,,di,k    (2)

The protein sequence file P is expressed as a set of multi-domain sequences as file P′:

P=( p1p2...pn)=(d1,1,d2,1,...,d1,wd2,1,d2,2,...,d2,u                    .                    .                             .dn,1,dn,2,...,dn,l)    (3)

where w is the number of domains in protein p1, u is the number of domains in protein p2, and so forth. Therefore, a considerate protein sequence file P in FASTA format is processed by the above methods to form the training data set P′ for the proposed evolutionary simulation model.

Inspired by incorporating the dipeptide position-specific propensity into the general pseudo nucleotide composition (Xiao et al., 2016), here we develop a new method to simulate the protein evolution process by domain position-specific propensity.

If g domain classes appeared in the training data set P′, we added two termination symbols “X-start” and “X-end” in the front and the back of the pi, there are (g2+g × 2) couple: X-startD1, X-startD2,…, D1D1 (where domain D1 and domain D1 are connected together), D1D2, D1D3,…, DgDg, D1X. -ending,…, DgX-ending. Thus, for the training data set P′, its profile (or detailed information) of mmarized by the following two matrices:

F2B=[Xstart D1D1D1D1D2D1DgD1XendXstart D2D2D1D2D2D2DgD2XendXstart DgDgD1DgD2DgDgDgXend]    (4)
B2F=[XstartD1D1D1D1D2...D1DgD1XendXstartD2D2D1D2D2...D2DgD2Xend            .            .            .     .     .     .     .     .     ....    .    .    .          .          .          .XstartDgDgD1DgD2...DgDgDgXend]    (5)

where F2B(from front to back) is matrix of evolution prior probability from front to back and B2F(from back to front) is the matrix of evolution prior probability from back to front. In the matrix F2B, DiDj (1 ≤ ig, 1 ≤ jg) is the occurrence frequency of domainDi attached to Dj, and Dj behind Di. In the matrix B2F, DiDi is the occurrence frequency of domain Di attached to Dj, and Di is followed by Dj.

Simulation Model of Domain Evolution in Proteins Based on Cellular Automaton

Let us give a brief introduction to CA. A CA is a dynamical system in which space, time, and the states are discrete. Each cell, defined by a point in a regular spatial lattice, can be any one of a finite number of states that are updated according to a local rule (Schwartz et al., 1967; Chopard and Droz, 1998). In 1D CA, the lattice consists of identical cells, i-m, …, i-3, i-2, i-1, i, i+1, i+2, i+3, …, i+m, and the corresponding states of these cells are Cim, ⋯ , Ci−2, Ci−1, Ci, Ci+1, Ci+2, ⋯ , Ci+m. The symbol i is the center of initial sequence with length equals to 2m+1. The state of the ith cell takes value from a predefined discrete set: Ci∈{c1, c2, ⋯ , cQ}, where c1, c2, ⋯ , cQ are the elements of the set. The CA evolves in discrete time steps, and its evolution is manifested by the change of its cell states with time. The state of each cell is affected by the states of its neighboring cells. The neighborhood is defined as N(i, r) = {Cir, ⋯ , Ci−1, Ci, Ci+1, ⋯ , Ci+r}, where r is the size of the neighborhood. If r = 1, the neighborhood of the ith cell consists of the same cell and its left and right immediate neighbors N(i, 1) = {Ci−1, Ci, Ci+1}. The state of the ith cell at time step t+1 is affected by the states of its neighbors at the previous time step t, Cit+1=F(Ci-rt,,Ci-1t,Cit,Ci+1t,,Ci+rt). F is the CA evolution rule (Sirakoulis et al., 2003). Figure 1 shows the evolution of a 1D CA. the horizontal axis is space, and the vertical axis is time. Each column represents the state of cell at various time steps.

FIGURE 1
www.frontiersin.org

Figure 1. The evolution of a one-dimensional cellular automaton (CA).

In this study, the non-uniform 1D CA was used to simulate the domain evolution in proteins. The square arrays are a very basic data structure in computers, and it was rational to use a square lattice in our model. If protein pq in the training data set P′ has the most domains, and the number of domains is m, then the spatial dimension of the 1D CA in the model is 1 × (2m+1) and the time step in CA evolution is set as m. The model was a (g+3)-state model in which each cell in the lattice was one of the following (g+3) states: (1) g domain classes appeared in the training data set P′; (2) evolution termination symbols “X-start”; (3) evolution termination symbols “X-end”; (4) an empty state “∅″. The state of the cell at time tcan be expressed as Cjt. The upper index in the state symbol denotes the time step, and the lower index denotes the cell j. When the CA is initialized (t = 0), the state of the cell Ci0 in the middle of the CA is set to the ancestral domain Y, and the state of the other cells is set to the empty state ∅, as shown in Figure 2. The state Cjt+1 of the cell at time t+1 is determined by the state Cit of the cell at time t and the state Cj-1tand Cj+1t of its neighbor cells at time t.

FIGURE 2
www.frontiersin.org

Figure 2. Schematic drawing to show the initial state of one-dimensional cellular automaton (CA) and the course of evolution. Each site of this lattice is called cell. The value of domain is the state of the cell.

The evolution rules of the proposed CA model can be expressed as follows (Figure 3):

• Rule A: Inheritance. If the state of cell Cjt is domain E(E≠∅), it means that the cell has evolved into domain E, so this cell Cjt will inherit the domain at the next time, which means that the state of Cjt+1 is E.

• Rule B: Rules of evolution from front to back. If the state of cells Cjt and Cj+1t is the empty domain ∅, and the state of cell Cj-1t is domain F(F≠∅), the state Cjt+1 will be obtained by the Roulette wheel selection algorithm. According to the matrix F2B (from front to back evolution prior probability matrix), we know that the probability of all domains to appear behind domain F. It is not true that the domain of the biggest probability certainly appears behind domain F in natural evolution course. Hence, we determined the state Cjt+1 into one domain form all domains that appear behind domain F probability is not zero based on Roulette wheel selection algorithm. The probability of selecting a domain G is the same as the probability of domain F appearing after domain G in matrix F2B.

• Rule C: Rules of evolution from back to front. If the state of cells Cj-1t and Cjt is the empty state ∅, and the state of cell Cj+1t is domain V(V≠∅), then the state Cjt+1 will be obtained by the Roulette wheel selection algorithm. The selected course is similar to Rule B except that the matrix B2F (from back to front evolution prior probability matrix) was used instead of the matrix F2B. The probability of selecting a domain H being selected is the same as the probability of domain H appearing before domain V in matrix B2F.

• Rule D: Return inanimateness. If the states of cells Cj-1t, Cjt, and Cj+1t are all equal to the empty state ∅, the state Cjt+1 will remain the empty state ∅.

FIGURE 3
www.frontiersin.org

Figure 3. The evolution of cellular automaton (CA). The state of each cell is affected by the states of its neighboring cells.

Proteins in a family descend from a common ancestor and have similar 3D structures, functions, and sequence similarity. Thus, the model assumes that all of the evolved proteins contain ancestral domains Y(Y∈{D1, D2, D3, …, Dg, X-start, X-end}), and where the common domains in the P′ are considered to be the hypothetical ancestral domain. By running the model once, a new protein will be simulated, and the evolved protein is represented by an ordered sequence of multi-domains.

As shown in Figure 4, when the CA is initialized (t = 0), the state of the cell Ci0 in the middle of the CA is set to the ancestral domain Y, and the state of the other cells is set to the empty state ∅.

FIGURE 4
www.frontiersin.org

Figure 4. An example to show how the model simulated the domain evolution. The model evolved the termination symbols X-start and X-end in advance at time k, so the protein stopped the evolution at time k.

When t = 1, the state of Ci1 is determined by the state of Ci-10,Ci0 and Ci+10. Since the state of Ci0 is the domain Y(Y≠∅), then Ci1 will be domain Y according to rule A inherit the state of Ci0; the state of Ci-11 is determined by the state of Ci-20,Ci-10 and Ci0. Because the state of Ci-10 is the empty domain ∅ and the state of Ci0 is the domain Y, the state of Ci-11 should be selected by the roulette method according to rule C and the matrix B2F to obtain the domain E. The state of Ci+11 is determined by the state of Ci0,Ci+10 and Ci+20 with the reason that the state of Ci0 is the domain Y and the state of Ci+10 is the domain ∅. According to rule B, the state of Ci+11should be selected by the roulette method on the basis of the matrix F2B to obtain the domain F after the domain Y. Keep the rule D in mind, the state of the other cells is the empty domain ∅ because the state of the other cells at the previous moment and the states of their neighbors are the empty domain ∅.

When t = 2, the states of Ci-12,Ci2, and Ci+12 are determined by the states of Ci-11,Ci1,Ci+11and their neighbors with the reason that the states of Ci-11,Ci1 and Ci+11 are not domain ∅. According to the rule A, Ci-12,Ci2, and Ci+12 will inherit the states, respectively, Ci-11,Ci1, and Ci+11 with domains E, Y and domain F; the state of Ci-22 is determined by the state of Ci-31,Ci-21, and Ci-11 at the previous time. Because the states of Ci-31 and Ci-21 are the domain ∅ and the state of Ci-11 is the domain E, according to rule C, the state of Ci-22 will be selected by the roulette method according to the matrix B2F to obtain the domain G in front of the domain E; the state of Ci+22 is determined by the state of Ci+11,Ci+21, and Ci+31. Because the states of Ci+21 and Ci+31 are the domain ∅ and the state of Ci+11 is the domain F, the state of Ci+22will be selected by the roulette method according to rule B and the matrix F2B to obtain the domain H after the domain F. According to rule D, the state of the other cells is the domain ∅ on the basis of that the state of the other cells and the states of their neighbors are the domain ∅.

When t = k(k<m), the cells with the state of termination symbols X-start and X-end are evolved in the cell space, and the simulated evolution of the protein comes to an end. The state of the cell space at time k is taken as an ordered sequence of multi-domain, removing the cells with the empty state ∅. The simulated multi-domain sequence of protein A is expressed as:

{Xstart , ... ,I ,G ,E ,Y ,F ,H , ... ,Xend }(E ,F ,G ,H ,I ,Y {D1,D2,D3,,Dg})    (6)

As shown in Figure 5, when t = m, if termination symbols X-start and X-end have not evolved in the cell space, the simulated evolution of the protein also comes to an end. The state of the cell space at time m is taken as an ordered sequence of multi-domain, removing the cells with the empty state ∅ and adding two termination symbols to the left and right ends of the cell space. The simulated multi-domain sequence of protein B is expressed as:

{Xstart ,L,K, ...,I,G,E,Y,F,H,V, ...,K,M,Xend }(E,F,G,H,I,J,K,L,M,V,Y {D1,D2,D3,,Dg})    (7)
FIGURE 5
www.frontiersin.org

Figure 5. An example to show how to put a termination to domain evolution. When the model is at time m, the termination symbols X-start and X-end have not yet evolved. Since the maximum time step of the cellular automaton is m, the protein stops evolution at time m.

User Interface

In order to facilitate the use of researchers, we have developed a web server, where users can directly submit protein sequence files and select various parameters for protein evolution simulation. The system will send the results to the user's e-mail address. The graphical user interface of the website is shown in Figure 6.

FIGURE 6
www.frontiersin.org

Figure 6. A semi-screenshot to show the top page of the cellular automaton (CA) model web server at http://jci-bioinfo.cn/domainevo.

Input File

The user uploads a protein sequence file in FASTA format by clicking the button “Submit Sequence.”

Ancestral Domain

The ancestral domains are the initial state of the cell in the middle of the CA space. The model uses this parameter as a common ancestor of the protein. Once this parameter is filled in, all evolved proteins will contain this domain.

E-Value

The E-value is a parameter used in the HMMER software; it is the expected number of false positives (non-homologous sequences) that scored this well or better. The E-value is a measure of statistical significance. The lower the E-value, the more significant the hit. Changing the value of E-value will cause the same protein to compare different domain architectures, and the default value is “1e-37.”

Evo-Num

The number of times of model simulation.

Top-Num

The model analyzes automatically the evolved proteins and sends the top top-num frequency of the domain architectures to users.

After submitting the protein sequence file and parameters, the system will compare the uploaded protein sequences based on HMMER. By setting the value of the E-value, each protein will generate a homology domain information file. The domain of each protein is then extracted and sorted according to the position of the domain in the protein sequence, such that each protein can be represented as a multi-domain sequence.

Next, the sliding window processing is performed on each multi-domain sequence (the sliding window size is 2), the matrix of probability from back to front and the matrix of probability from front to back are obtained by counting the frequency of the domain in pairs.

In the evolution process of the CA, the next time state of the cell is obtained according to the CA evolution rule. When evolution is terminated, the system removes the domain ∅ and generates a complete multi-domain protein. The user can control the number of proteins that the system simulates by adjusting the size of Evo-num.

After the evolution of the protein, the system calculates the frequency of each domain architecture based on the multi-domain protein of the original file and the multi-domain protein obtained by the proposed simulation model, sorts the frequency from large to small, and saves it as two files in comma-separated values (CSV) format. Since there are many protein domain architectures obtained by simulation, users can adjust the value of Top-num to preserve the domain architectures with high frequency.

Finally, the system will send the results to the user's e-mail address. The contents of the e-mail are the parameters selected by the user, and in the attachment, there are two data files in CSV format. The CA model can be described by the flowchart in Figure 7.

FIGURE 7
www.frontiersin.org

Figure 7. Data flow diagram of the model. Different types of data are represented by different background colors.

Simulating the Evolution of RhoGEF Domain in Homo Sapiens Proteins

Materials

To evaluate the performance of the model, we used a number of multi-domain proteins associated with the conserved protein family “RhoGEF” to validate the validity of the model. The keyword “RhoGEF” was used to find the protein of the conserved protein family RhoGEF from the NCBI database. We selected the species Homo sapiens to download a multi-sequence file containing 1,597 proteins and used it as a protein sequence file P. In addition to the above methods, researchers can also build data sets by the following methods. The Conservative Domain Database (CDD, https://www.ncbi.nlm.nih.gov/cdd/) collects a large number of protein domains and domain families (Marchler-Bauer et al., 2016). Researchers can search for a conserved protein domain family in the CDD website and then click the “related protein” on the domain family description page to link to the NCBI website to download the related proteins.

Model Performance Evaluation Under Various Parameters

After submitting the protein sequence file, we tested various parameters that may affect the evolution of protein simulation. The protein sequence file P is processed into a training data set P′ of the evolutionary simulation model:

P=( p1p2...p1597)=(d1,1d2,1...d1,wd2,1d2,2...d2,1............p1597,1p1597,2...p1597,l)    (8)

Pevo represents a multi-domain sequence file from the simulation of protein evolution in this model.

Pevo=(D1evoD2evoDEvo_numevo)=(d1,1evod1,2evod1,xevod2,1evod2,2evod2,yevodEvo_num,1evodEvo_num,2evodEvo_num,zevo)    (9)

where Dnevo(1nEvo_num) represents the simulation of the evolution of domain architectures of whole proteins (DAWPs), x is the number of domain in simulation protein D1evo, y is the number of domain in simulation protein D2evo, and so forth. Protein domains are represented by dj,kevo.

In order to examine the performance of a predictor in simulating domain evolution of proteins, Hit-Acc (DAWP), goodness of fit between the simulation proteins and nature protein in P′, used in this literature based on counting the type and number of the DAWPs. Hit-Acc (TAPD), goodness of fit between the triplet domain architectures in P′ and Pevo, Hit-Acc (QAPD), goodness of fit between the quadruple domain architectures in P′ and Pevo as supplementary.

HitAcc (DAWP)=i=1Evo_numfevo(Dievo)Evo_num×100    (10)
fevo(Dievo)={1,if Dievo appeared in P0,otherwise    (11)
HitAcc (TAPD)=i=1mθevo(ti)i=1kθevo(tievo)×100    (12)
{T={t1,t2,,te}Tevo={t1evo,t2evo,,tfevo}T=TTevo={t1,t2,,tr}    (13)

where T′ is the set of triplet domain architectures in P′, Tevo is the set of triplet domain architectures in Pevo, ∩ represents the symbol for “intersection” in the set theory, θevo(ti) represents the count hits of triplet domain architectures ti in Pevo, and θevo(tievo) represents the hits of triplet domain architectures tievo in Pevo.

HitAcc (QAPD)=i=1mφevo(qi)i=1kφevo(qievo)×100    (14)
{Q={q1,q2,,qh}Qevo={q1evo,|q2evo,,qaevo}Q=QQevo={q1,q2,,qs}    (15)

where Q′ is the set of quadruple domain architectures in P′, Qevo is the set of quadruple domain architectures in Pevo, φevo(qi) represents the hits of quadruple domain architectures qi in Pevo, and φevo(qievo) represents the hits of quadruple domain architectures qievo appearing in Pevo.

In the process of testing system performance, we used HMMER to perform multi-domain sequence alignment on Homo sapiens' protein family RhoGEF, and set the value of E-values from 1e-1 to 1e-50, so that the protein domain information file corresponding to E-values would be generated, and 50 simulation training data sets would be obtained after processing the file. The smaller the value of E-value, the higher the accuracy of the aligned homology domain. Changing the value of E-value will cause the same protein match different domain architectures when the value of E-value is 1e-1. A total of 228 domains existed in the simulation data set P, and the number of types of protein domain architectures was 326. When the value of E-value is 1e-37, there are 43 domains in the simulation data set P, the number of types of protein domain architecture is 55, and the most complex protein domain architecture is {′I-set′,′V-set′,′Ig′,′Ig′,′Ig′,′Izumo-Ig′,′Ig′,′Ig′,′Pkinase′,′Pkinase′}. The 10 most frequent protein domains are shown in Table 1.

TABLE 1
www.frontiersin.org

Table 1. The 10 most frequent protein domains when E-values are 1e-1 and 1e-37, respectively.

The model uses RhoGEF, X. -start, and X-end as ancestral protein domains to simulate each training set, and each training set simulates 50,000 proteins represented by multiple domain sequences. In order to eliminate the impact of individual results on the model evaluation, we repeated the simulation of each parameter combination 50 times and then calculated the average value of Hit-Acc. as the evaluation of the model; the obtned results are shown in Figures 810.

FIGURE 8
www.frontiersin.org

Figure 8. Results of the selection of RhoGEF as an ancestral protein domain.

FIGURE 9
www.frontiersin.org

Figure 9. Results of the selection of X-start as an ancestral protein domain.

FIGURE 10
www.frontiersin.org

Figure 10. Results of the selection of X-end as an ancestral protein domain.

When the ancestral protein domain is RhoGEF, the Hit-Acc (TAPD). and Hit-Acc (DAWP) reach the maximum; when the E-value is 1e−43, the Hit-Acc (TAPD) is 90.27%, the Hit-Acc (DAWP) is 89.59%. When the ancestral protein domain is X-start or X-end, the test results are basically the same as the ancestral protein domain RhoGEF. The Hit-Acc (TAPD) and Hit-Acc (DAWP) reach the maximum when the E-value is 1e-37, the Hit-Acc (TAPD) is 91.01%, and the Hit-Acc (DAWP) is 88.26%. These test results show that the model has good simulation characteristics and robustness. The model can also get better results in most cases by using X-start and X-end as the ancestral protein domain for simulated evolution. The reason is that this model uses HMMER for automated annotation of protein domains. The smaller the E-values, the fewer domains are annotated. Some proteins will not annotate the ancestral domain because the set E-value is too small. For example, if the E-value is 1e-1, 1,440 proteins are annotated with the RhoGEF domain; if the E-value is 1e-37, only 619 proteins are annotated with the RhoGEF domain. In order to solve this problem, the model added X-start and X-end to the left and right ends of each protein when composing the protein simulation training data set. If the model uses X-start or X-end as the ancestral protein domain, each protein domain architecture could be simulated, which also allows the system to simulate more protein domain architectures that appear in the original file. This also means that if the user does not know the ancestor domain of the submitted protein sequence file, X-start or X-end can be used as the ancestral domain for protein simulation. It can be seen from the results that the model can effectively simulate the DAWPs under various parameters. It also simulated existing triplet and quadruplet domain architectures successfully. Analysis on the results shows that the model not only has good stability but also has strong robustness.

Although the proposed model simulating the evolution of protein domain architectures only by fusion operation, the obtained results do contain the results of insertion, deletion, and mutation operations. For example, given that the simulation starts with “RhoGEF,” if one result is “RhoGEF-PH-PH-C2” and another is “RhoGEF-PH-C2,” then we can assume that the later one is the result of the fore in which the “PH” was deleted. The operations are shown in Figure 11.

FIGURE 11
www.frontiersin.org

Figure 11. Examples of fission, fusion, deletion, and insertion in the evolution of the model.

Moreover, statistical analysis by the triplet and quadruple domain architectures derived from the evolution of the model shows that only a few domains contain a large number of immediate neighbors, and most of the domains contain only a small number of immediate neighbors, the frequency distribution of each domain neighbor in accordance with a power law (Qian et al., 2001). Although we used domain pair probability matrices to simulate the protein domain architecture, statistical results show that some triplets and quadruped domains are highly repetitive and appear in many sequences. In a statistical sense, these triplet and quadruple protein domain architectures are often over-expressed and highly abundant, which is consistent with the supra-domains concept (Vogel et al., 2004). This further illustrates the effectiveness of this model in simulating the evolution of protein domain architecture.

Conclusions

The goal of this work was to provide a tool that can reveal how domain architectures have evolved in protein sequences. This tool is very important in analyzing orthologous relationships between proteins in different organisms. CA has been applied in many fundamental issues in biology. Some works have already been devoted to providing a framework for simulation evolution of protein and DNA sequences. In this work, 1D probabilistic CA is used to simulate the evolution of protein domain. This model simulates the fission, fusion, deletion, and insertion of the natural evolution processes by randomly appointing transitional rules. This is the reason that our model is more in line with the natural characteristics of protein evolution. Through this website, users can know the domain architecture distribution of the submitted protein sequence and can also view the evolution results of the model to predict the evolution direction of the protein sequence file with the emergence of new and frequent protein domain architecture.

Data Availability Statement

Publicly available datasets were analyzed in this study. This data can be found here: access protein sequence data from NCBI, and searching HMM domains from Pfam with HMMER.

Author Contributions

All authors listed have made a substantial, direct and intellectual contribution to the work, and approved it for publication.

Conflict of Interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

References

Adachi, J., and Hasegawa, M. (1996). Model of amino acid substitution in proteins encoded by mitochondrial DNA. J Mol Evol. 42, 459–468. doi: 10.1007/PL00013324

PubMed Abstract | CrossRef Full Text | Google Scholar

Apic, G., Gough, J., and Teichmann, S. A. (2001). Domain combinations in archaeal, eubacterial and eukaryotic proteomes. J. Mol. Biol. 310, 311–325. doi: 10.1006/jmbi.2001.4776

PubMed Abstract | CrossRef Full Text | Google Scholar

Bakan, A., Dutta, A., Mao, W., Liu, Y., Chennubhotla, C., Lezon, T. R., et al. (2014). Evol and ProDy for bridging protein sequence evolution and structural dynamics. Bioinformatics 30, 2681–2683. doi: 10.1093/bioinformatics/btu336

PubMed Abstract | CrossRef Full Text | Google Scholar

Buljan, M., and Bateman, A. (2009). The evolution of protein domain families. Biochem. Soc. Trans. 37, 751–755. doi: 10.1042/BST0370751

PubMed Abstract | CrossRef Full Text | Google Scholar

Buljan, M., Frankish, A., and Bateman, A. (2010). Quantifying the mechanisms of domain gain in animal proteins. Genome Biol. 11:R74. doi: 10.1186/gb-2010-11-7-r74

PubMed Abstract | CrossRef Full Text | Google Scholar

Chandonia, J.-M., Fox, N. K., and Brenner, S. E. (2017). SCOPe: manual curation and artifact removal in the structural classification of proteins–extended database. J. Mol. Biol. 429, 348–355. doi: 10.1016/j.jmb.2016.11.023

PubMed Abstract | CrossRef Full Text | Google Scholar

Chopard, B., and Droz, M. (1998). Cellular Automata Modeling of Physical Systems (Collection Alea-Saclay: Monographs and Texts in Statistical Physics). (Cambridge: Cambridge University Press), 122–137. doi: 10.1017/CBO9780511549755

CrossRef Full Text | Google Scholar

Chothia, C. (1992). One thousand families for the molecular biologist. Nature 357, 543–544. doi: 10.1038/357543a0

PubMed Abstract | CrossRef Full Text | Google Scholar

Dawson, N. L., Lewis, T. E., Das, S., Lees, J. G., Lee, D., Ashford, P., et al. (2016). CATH: an expanded resource to predict protein function through structure and sequence. Nucleic Acids Res. 45, D289–D295. doi: 10.1093/nar/gkw1098

PubMed Abstract | CrossRef Full Text | Google Scholar

Dayhoff, M. O., Schwartz, R. M., and Orcutt, B. C. (1978). “A model of evolutionary change in proteins. matrices for detecting distant relationships,” in Atlas of Protein Sequence and Structure, Nat. Biomed. Res. Found., ed M. O. Dayhoff (Washington DC), 345–358.

Google Scholar

El-Gebali, S., Mistry, J., Bateman, A., Eddy, S. R., Luciani, A., Potter, S. C., et al. (2019). The Pfam protein families database in 2019. Nucleic Acids Res. 47, D427–D432. doi: 10.1093/nar/gky995

PubMed Abstract | CrossRef Full Text | Google Scholar

Fong, J. H., Geer, L. Y., Panchenko, A. R., and Bryant, S. H. (2007). Modeling the evolution of protein domain architectures using maximum parsimony. J. Mol. Biol. 366, 307–315. doi: 10.1016/j.jmb.2006.11.017

PubMed Abstract | CrossRef Full Text | Google Scholar

Gumulya, Y., Sanchis, J., and Reetz, M. T. (2012). Many pathways in laboratory evolution can lead to improved enzymes: how to escape from local minima. Chembiochem 13, 1060–1066. doi: 10.1002/cbic.201100784

PubMed Abstract | CrossRef Full Text | Google Scholar

Jones, D. T., Taylor, W. R., and Thornton, J. M. (1992). The rapid generation of mutation data matrices from protein sequences. Comput. Appl. Biosci. 8, 275–282. doi: 10.1093/bioinformatics/8.3.275

PubMed Abstract | CrossRef Full Text | Google Scholar

Kummerfeld, S. K., and Teichmann, S. A. (2005). Relative rates of gene fusion and fission in multi-domain proteins. Trends Genet. 21, 25–30. doi: 10.1016/j.tig.2004.11.007

PubMed Abstract | CrossRef Full Text | Google Scholar

Leconte, A. M., Dickinson, B. C., Yang, D. D., Chen, I. A., Allen, B., and Liu, D. R. (2013). A population-based experimental model for protein evolution: effects of mutation rate and selection stringency on evolutionary outcomes. Biochemistry. 52, 1490–1499. doi: 10.1021/bi3016185

PubMed Abstract | CrossRef Full Text | Google Scholar

Marchler-Bauer, A., Bo, Y., Han, L., He, J., Lanczycki, C. J., Lu, S., et al. (2016). CDD/SPARCLE: functional classification of proteins via subfamily domain architectures. Nucleic Acids Res. 45, D200–D203. doi: 10.1093/nar/gkw1129

PubMed Abstract | CrossRef Full Text | Google Scholar

Prakash, A., Jeffryes, M., Bateman, A., and Finn, R. D. (2017). The HMMER web server for protein sequence similarity search. Curr. Protoc. Bioinformatics 60:3 15 1–3 15 23. doi: 10.1002/cpbi.40

PubMed Abstract | CrossRef Full Text | Google Scholar

Qian, J., Luscombe, N. M., and Gerstein, M. (2001). Protein family and fold occurrence in genomes: power-law behaviour and evolutionary model. J. Mol. Biol. 313, 673–681. doi: 10.1006/jmbi.2001.5079

PubMed Abstract | CrossRef Full Text | Google Scholar

Riley, M., and Labedan, B. (1997). Protein evolution viewed through Escherichia coli protein sequences: introducing the notion of a structural segment of homology, the module. J. Mol. Biol. 268, 857–868. doi: 10.1006/jmbi.1997.1003

PubMed Abstract | CrossRef Full Text | Google Scholar

Schwartz, J. T., Neumann, J. V., and Burks, A. W. (1967). Theory of self-reproducing automata. Q. Rev. Biol. 21:745. doi: 10.2307/2005041

CrossRef Full Text | Google Scholar

Sharma, M., and Pandey, G. K. (2016). Expansion and function of repeat domain proteins during stress and development in plants. Front. Plant Sci. 6:1218. doi: 10.3389/fpls.2015.01218

PubMed Abstract | CrossRef Full Text | Google Scholar

Sirakoulis, G., Karafyllidis, I., Mizas, C., Mardiris, V., Thanailakis, A., and Tsalides, P. (2003). A cellular automaton model for the study of DNA sequence evolution. Comput. Biol. Med. 33, 439–453. doi: 10.1016/S0010-4825(03)00017-9

PubMed Abstract | CrossRef Full Text | Google Scholar

Snel, B., Bork, P., and Huynen, M. (2000). Genome evolution: gene fusion versus gene fission. Trends Genet. 16, 9–11. doi: 10.1016/S0168-9525(99)01924-1

PubMed Abstract | CrossRef Full Text | Google Scholar

Stolzer, M., Siewert, K., Lai, H., Xu, M., and Durand, D. (2015). Event inference in multidomain families with phylogenetic reconciliation. BMC Bioinformatics 16:S8. doi: 10.1186/1471-2105-16-S14-S8

PubMed Abstract | CrossRef Full Text | Google Scholar

Tuffery, P. (2002). CS-PSeq-Gen: simulating the evolution of protein sequence under constraints. Bioinformatics 18, 1015–1016. doi: 10.1093/bioinformatics/18.7.1015

PubMed Abstract | CrossRef Full Text | Google Scholar

Vogel, C., Berzuini, C., Bashton, M., Gough, J., and Teichmann, S. A. (2004). Supra-domains: evolutionary units larger than single protein domains. J. Mol. Biol. 336, 809–823. doi: 10.1016/j.jmb.2003.12.026

PubMed Abstract | CrossRef Full Text | Google Scholar

Weinreich, D. M., Delaney, N. F., DePristo, M. A., and Hartl, D. L. (2006). Darwinian evolution can follow only very few mutational paths to fitter proteins. Science 312, 111–114. doi: 10.1126/science.1123539

PubMed Abstract | CrossRef Full Text | Google Scholar

Whelan, S., and Goldman, N. (2001). A general empirical model of protein evolution derived from multiple protein families using a maximum-likelihood approach. Mol. Biol. Evol. 18, 691–699. doi: 10.1093/oxfordjournals.molbev.a003851

PubMed Abstract | CrossRef Full Text | Google Scholar

Wiedenhoeft, J., Krause, R., and Eulenstein, O. (2011). The plexus model for the inference of ancestral multidomain proteins. IEEE/ACM Trans. Comput. Biol. Bioinformatics 8, 890–901. doi: 10.1109/TCBB.2011.22

PubMed Abstract | CrossRef Full Text | Google Scholar

Wilburn, D. B., Tuttle, L. M., Klevit, R. E., and Swanson, W. J. (2018). Solution structure of sperm lysin yields novel insights into molecular dynamics of rapid protein evolution. Proc. Natl. Acad. Sci. U.S.A. 115, 1310–1315. doi: 10.1073/pnas.1709061115

PubMed Abstract | CrossRef Full Text | Google Scholar

Xiao, X., Ye, H.-X., Liu, Z., Jia, J.-H., and Chou, K.-C. (2016). iROS-gPseKNC: predicting replication origin sites in DNA by incorporating dinucleotide position-specific propensity into general pseudo nucleotide composition. Oncotarget 7:34180. doi: 10.18632/oncotarget.9057

PubMed Abstract | CrossRef Full Text | Google Scholar

Yang, Z. (1993). Maximum-likelihood estimation of phylogeny from DNA sequences when substitution rates differ over sites. Mol. Biol. Evol. 10, 1396–1401.

PubMed Abstract | Google Scholar

Zeymer, C., and Hilvert, D. (2018). Directed evolution of protein catalysts. Annu Rev Biochem. 87, 131–157. doi: 10.1146/annurev-biochem-062917-012034

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhang, X.-C., Wang, Z., Zhang, X., Le, M. H., Sun, J., Xu, D., et al. (2012). Evolutionary dynamics of protein domain architecture in plants. BMC Evol. Biol. 12:6. doi: 10.1186/1471-2148-12-6

PubMed Abstract | CrossRef Full Text | Google Scholar

Keywords: simulation, protein evolution, cellular automaton, multi-domain proteins, protein domain architecture

Citation: Xiao X, Xue G-F, Stamatovic B and Qiu W-R (2020) Using Cellular Automata to Simulate Domain Evolution in Proteins. Front. Genet. 11:515. doi: 10.3389/fgene.2020.00515

Received: 24 September 2019; Accepted: 28 April 2020;
Published: 09 June 2020.

Edited by:

Juan Caballero, Universidad Autónoma de Querétaro, Mexico

Reviewed by:

Franco Bagnoli, University of Florence, Italy
Hiep Xuan Huynh, Can Tho University, Vietnam

Copyright © 2020 Xiao, Xue, Stamatovic and Qiu. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Xuan Xiao, jdzxiaoxuan@163.com; Wang-Ren Qiu, qiuone@163.com

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.