Skip to main content
Advertisement
  • Loading metrics

Investigating the mitochondrial genomic landscape of Arabidopsis thaliana by long-read sequencing

Abstract

Plant mitochondrial genomes have distinctive features compared to those of animals; namely, they are large and divergent, with sizes ranging from hundreds of thousands of to a few million bases. Recombination among repetitive regions is thought to produce similar structures that differ slightly, known as “multipartite structures,” which contribute to different phenotypes. Although many reference plant mitochondrial genomes represent almost all the genes in mitochondria, the full spectrum of their structures remains largely unknown. The emergence of long-read sequencing technology is expected to yield this landscape; however, many studies aimed to assemble only one representative circular genome, because properly understanding multipartite structures using existing assemblers is not feasible. To elucidate multipartite structures, we leveraged the information in existing reference genomes and classified long reads according to their corresponding structures. We developed a method that exploits two classic algorithms, partial order alignment (POA) and the hidden Markov model (HMM) to construct a sensitive read classifier. This method enables us to represent a set of reads as a POA graph and analyze it using the HMM. We can then calculate the likelihood of a read occurring in a given cluster, resulting in an iterative clustering algorithm. For synthetic data, our proposed method reliably detected one variation site out of 9,000-bp synthetic long reads with a 15% sequencing-error rate and produced accurate clustering. It was also capable of clustering long reads from six very similar sequences containing only slight differences. For real data, we assembled putative multipartite structures of mitochondrial genomes of Arabidopsis thaliana from nine accessions sequenced using PacBio Sequel. The results indicated that there are recurrent and strain-specific structures in A. thaliana mitochondrial genomes.

Author summary

Plant mitochondria have genes with important functions. For example, some mitochondrial genomes contain a gene responsible for cytoplasmic male sterility, a phenotype that is unable to create mature pollen. However, despite their small sizes, plant mitochondrial genomes can be difficult to assemble even if we use state-of-the-art long-read sequencers. The main obstacle is their high structural diversity and low sequence diversity, which hamper traditional methods to assemble plant mitochondrial genomes. Here, we introduce a new method for grouping long-reads to individual structures. For this purpose, we explored two traditional models in sequence analysis; hidden Markov model and partial order alignment, which enable us to detect a single base variation among several thousand bases and output accurate clusters while managing with observation errors associated with long-read sequencing. Applying this method to nine PacBio Sequel read datasets from Arabidopsis thaliana, we uncovered putative but unknown structures of plant mitochondrial genomes, suggesting that strain-specific structures are present in mitochondrial genomes, and that linear DNA fragments appear repeatedly in several strains.

Introduction

Since Lynn Margulis confirmed with substantial evidence that mitochondria originated from external bacteria [1], genomes of mitochondria, which are called mitogenomes, have been extensively investigated.

We now know that the mitogenomes of plants differ from those of animals. For example, plant mitogenomes comprise hundreds of thousands to millions of nucleotides [2]. Additionally, mitochondria have a gene that is responsible for cytoplasmic male sterility, a phenotype in which the individual cannot produce mature pollen [3]. Because of this unique effect on fertility, plant mitogenomes should be studied independently.

The first complete plant mitogenome came from Arabidopsis thaliana, using traditional Sanger sequencing [4]. Since the emergence of Illumina sequencing technology, the mitogenomes of many species (e.g., rice) have been assembled as circular contigs [5]. Long-read sequencers released by PacBio or Oxford Nanopore Technology have accelerated this process [615]. Consequently, many studies have determined the nucleotide sequences of plant mitogenomes, compared the resulting assemblies, and proposed evolutionary scenarios for current patterns [11], [16].

Nonetheless, there is room for improvement in terms of obtaining a more in-depth understanding of mitogenome assemblies. One area that requires further clarification is the phenomenon of “alternative reality” [13]–i.e., plant mitogenomes are not static but change dynamically, and nucleotide sequences can vary due to recombination among repetitive sequences [2, 1719].

This recombination presumably combines DNA fragments together, leading to the creation of many configurations (multipartite structures) in plant cells. Although this phenomenon was observed in the study that first published a plant mitogenome assembly [4], plant mitogenomes are usually represented as “master circles”–i.e., single circular lists of nucleotides. Assays to reveal these multipartite structures based on polymerase chain reaction (PCR) are also not very useful, as artifacts of PCR-mediated recombination may be created [20].

Importantly, Kozik et al. recently presented pioneering work that accounted for this insufficient representation [13]. They first constructed an initial assembly, then “tiled” long reads along the contigs to find the building blocks of the multipartite structures. Although this approach recovered the putative multipartite conformations, plant mitogenomes may be further elucidated by assembling each structure separately like a pan-genome approach.

To this end, it is necessary to group reads into individual structures by using variations among structures. An algorithm for solving this problem based on the Minimum Error Correction Problem has been reported [21]. This algorithm runs in O(s2k) time, where s and k are the number of variant sites and the maximum coverage of variant sites, respectively. However, this algorithm is not practical because its runtime has an exponential relationship with maximum coverage (k), which is typically more than 600-fold in mitogenomes, and because it does not consider structural variations among multipartite structures. Tools for clustering long reads have been published [22], [23]; however, these programs were generally designed to group cDNA or RNA reads into alternative splicing variants rather than to cluster multipartite structures. Therefore, another highly efficient method is needed.

In this study, we aimed to resolve issues related to the high error rate (≈14%) associated with long reads and the low divergence among mitogenomes, to group reads into individual structures.

Materials and methods

It may be useful to recall K-means clustering. In this method, we iteratively compute the centers of clusters and assign each point to one of the nearest centers, as in Algorithm 1:

Algorithm 1 K-means clustering

Input: A set of real numbers V = {x1, ⋯, xN} and the number of clusters K

Output: Assignment of cluster ID wn ∈ {1, ⋯, K} to ∀xnV

1: Assign each point to a cluster randomly.

2: repeat

3:  Ck ← {xnwn = k} for each k    ⊳ Points in the k-th cluster.

4:   for each k    ⊳ Compute centroid Mk of Ck

5:  wn ← arg maxk − ‖Mkxn2 for each n  ⊳ Assign each point xn to the nearest centroid.

6: until Convergence

7: Return w1, ⋯, wN

To use this algorithm to group long reads into corresponding clusters, we need to define a model to represent a cluster and determine the similarity measure between a read and a cluster to update the assignment. In the case of K-means clustering, we represent a cluster by its center, and the similarity measure is the negative Euclidean norm. In the following section, we first describe the model and then move on to the similarity measure.

POA for representing multipartite structures

As noted in the Introduction, plant mitochondrial assemblies are currently characterized as circular contigs known as “master circles,” which represent the major configuration of the mitogenomes. Thus, we can align reads to the reference while allowing a certain amount of mismatches, deletions, insertions, and structural variations.

From these alignments, we can build a model by integrating reads into the aligned locations in the reference master circle. One approach is to regard the master circle as an initial graph and employ POA [24] to merge reads one by one, resulting in a single POA graph.

However, as shown in the following section, it takes a long time–O(R2N) time–to construct a POA graph from N reads if these reads are sufficiently similar, where R is the length of the longest read. Thus, we want the graph to be as small as possible for computational efficiency.

To this end, we adopted a similar approach as in Racon [25]. Specifically, we split the reference into sections of LU bp (for example, 2K bp) length. We carry out clustering procedure on each of them and merge consecutive sections to obtain final clustering. To this end, for each section, we collected all the read sub-sequences aligned to it and split these sequence into smaller chunks with U-bp (for example, 100 bp) length. Then, these chains of aligned segments were converted into a sequence in a small POA graph to obtain our model. Fig 1A shows the initial steps of the workflow.

thumbnail
Fig 1. Schematic illustrations of the proposed method.

(A): Overview of our workflow. LU is the length of a section, which we split into smaller chunks with U-bp length. There are reads from different multipartite structures, and we represent them by different colors (blue, green, red, and black). (B): An example of dynamic programming matrices for partial order alignments (POA). (C): Two POA graphs with the same structure but with different weights on edges. When aligning AGTG or ACTG, these two graphs display the same alignment unless we consider the weights on the edges. (D): A POA graph with a homopolymer run. Due to sequencing errors, it has two short-circuiting edges. (E): The rule to convert a POA graph into a hidden Markov model (HMM).

https://doi.org/10.1371/journal.pcbi.1008597.g001

Intuitively speaking, a POA is an alignment between a nucleotide sequence and a given directed acyclic graph in which nodes represent nucleotides. The only difference between POA and classical sequence alignment is that a node in a graph may have two or more preceding nodes, making the dependency a little more complicated, as shown in Fig 1B.

Now, we define a POA between a directed acyclic graph G = (V, E) where V = {v1, ⋯, vn} and an m-length sequence x = x1, ⋯, xm in a bottom-up manner. That is, let Gi be a subgraph of G, in which the nodes are Vi = {v1, ⋯, vi}, and x1:j = x1⋯, xj be the j-length prefix of x. Also, let ρdel be a deletion penalty, ρins be an insertion penalty, and s(v, c) be a match/mismatch score between the base of a node v and a nucleotide c for the alignment parameters. A POA score S[i][j] between a subgraph Gi and a prefix x1:j is defined based on smaller subgraphs or prefixes (Eq 1). Apparently, S[n][m] is the POA score between x and G, and it takes O(|E|m) time to compute the POA score. (1)

Due to sequencing errors, POA graphs may have erroneous trailing or leading nodes. Thus, we initialized S[i][0] = 0 for i ∈ {0, ⋯, n} and S[0][j] = ins for j ∈ {0, ⋯, m} to allow one to leave unaligned nodes in the graph.

In the Results section, we set the insertion and deletion penalties to −3, the mismatch penalty to −4, and the match score to 3.

As with classic alignments, we can rebuild one of the alignment paths with the optimal score by back-tracing the computation of S. Specifically, given we follow semi-global alignment approach, we first set i = arg maxi S[i][m], j = m and update i and j to the values giving the maximum value of the right-side of Eq 1.

To merge a read into the graph, we introduce a new node for each mismatch or insertion operation and connect them to the adjacent nodes. For computational efficiency, we removed erroneous edges during construction of POA graph. To this end, we recorded each edge’s occurrence (ei) and removed erroneous edges with weight less than τ × maxi ei (τ = 0.4 by default) when the number of nodes reached a threshold (1.5 × maximum length of the input by default).

Overall, the pseudo-code to construct a model from reads can be found in Algorithm 2. In practice, we ran this procedure on each chunk of the reference for each cluster.

Algorithm 2 The algorithm to construct a POA graph

Input: A set of sequences X = {x1, ⋯, xN}

Output: A POA graph G

1: Randomly shuffle the order of X.

2: G ← regards x1 as a linear graph

3: for i = 2, ⋯, N do

4:  Obtain an alignment between G and xi by Algorithm (1).

5:  Integrate read xi into the graph G.

6:  ifG ∣ > 1.5 × maxixi ∣. then

7:   Remove edges with weight less than 0.4 × the maximum weight of the edges.

8: Return G

PO-HMM to determine similarity

One of the canonical ways to define similarity between two DNA sequences is to use optimal local or global alignment scores. Likewise, one may want to use the optimal POA score to assess the similarity between a model and a read. However, this approach does not work well in practice. One reason is that, during clustering, we may have two POA graphs that differ only in the weights on their edges (as illustrated in Fig 1C), as the clustering is iteratively refined from random clustering in accordance with Line 1 in Algorithm 1.

Another reason is that, in the presence of erroneous runs of homopolymers in long reads, the POA graph will usually contain short-circuiting edges (Fig 1D). In this situation, the alignment between the graph and the query fails to segregate variable-length polymorphisms. One workaround is to assess many possible alignments using all candidate paths.

To resolve these issues and allow ambiguity in choosing nodes, we need to consider the weights on the edges and sub-optimal alignments. To this end, we converted the POA graph to another model, the HMM. Specifically, we encoded the weights of the edges as the alignment score and defined the similarity between a model and a read by summing up the scores of all possible alignments. Although a very similar data structure was introduced in 2010 for multiple sequence alignment [26], it has not been used for clustering of long-reads. Also, while the previous model has only match and insertion states, we introduce deletion state to the HMM to handle deletion errors.

To convert a POA graph into an HMM, we substitute each node in a POA graph with three nodes representing match, deletion, and insertion states. These nodes are connected as in the original POA graph and a loop edge is added for each insertion node to allow multiple insertions. The resulting graph can be regarded as an HMM by defining the transition probability between nodes and the emission probability of each nucleotide. The partial order HMM (PO-HMM) is formally defined below (Definition 1). An example of the conversion can be found in Fig 1E.

Definition 1 (A PO-HMM) Let G = (V, E) be a POA graph. Then, the state and edges of the PO-HMM G′ = (V′, E′) created from G are as follows:

  • States: V′ = ⋃vV{vm, vd, vi}: we denote a match, deletion, and insertion as the suffixes m, d, and i, respectively.
  • Edges: For each edge (u, v) ∈ E, we create edges (uσ, vτ) ∈ E′, where (σ, τ) = (m,m), (m,d), (d,m), (d,d), or (i,m).
  • Edges: For each node uV, we create edges (uσ, ui) ∈ E′, where σ = m, i, or d.

To define the transition probability, let be weights on E. We first normalize the weight of each edge e = (u, v) by dividing the total weight of outgoing edges from the start node–i.e., . The transition probabilities and emission probabilities are then defined based on these normalized weights:

Definition 2 (Transition probability of a PO-HMM) Let G = (V, E) be a POA graph, w: E → [0, 1] be normalized weights on E, and G′ = (V′, E′) be the PO-HMM from G and w. Also, let Pσ,τ(>0) denote the probability of each transition (uσ, vτ) satisfyingτ Pσ,τ = 1 for all σ; the sum of the probabilities of moving from uσ to its subsequent nodes equals to 1. Then, for each edge e = (u, v) ∈ E with normalized weight w = w(e), let (2) Finally, we define the transition probability in Gas (3) In other words, we use transition probability (Pσ,τ) as-is for the transition between u and multiply normalized weights for the transitions between u and v. We used the “LAST-train” package [27] to estimate Pσ,τ for each dataset.

Definition 3 (Emission probability of a PO-HMM) Let G = (V, E) be a POA graph, w: E → [0, 1] be normalized weights, and be the set of directed edges from vG labeled with nucleotide c. Then, the emission probabilities of the match and insertion states of the PO-HMM are as follows: (4) (5) Additionally, we assume Pr{cvd} = 1, as the deletion states never result in any observation outputs.

By using the forward algorithm for a traditional HMM, we can calculate the likelihood of a given sequence. The only difference is that we have to compute the following recurrence (6) along with a topological order of the PO-HMM, as deletion transitions never change the position of the query.

Formally, let x = x1, ⋯, xT be an observed sequence, and G′ = (V′, E′) be a PO-HMM. In addition, let q(σ, t) = t − 1 for σ = i, m and q(σ, t) = t for σ = d. This is the previous position of the query given the current position t and state σ. Then, Fj[vσ], the probability to observe x1xj when the j-th state is vσV′, can be computed as Eq (6). (6)

Hence, given an initial probability F0[v] for each vV′, the likelihood (Pr{xF0, G′}) is ∑v FT[v].

Accurate variant calling for improved clustering

We also propose another technique, variant calling, to boost the accuracy of finding better clusters. To better understand the reasoning behind this idea, suppose we have constructed models for two clusters, each corresponding to a different haplotype. As we split the reference into L chunks, we have two PO-HMM arrays–M1 = M1,1, ⋯, M1,L and M2 = M2,1⋯, M2,L. The two graphs in the l-th chunks should differ only if they contain sites that vary between these two haplotypes. Therefore, M1,l and M2,l should be nearly the same, as the divergence rate between the two haplotypes is extremely low in our application. Nonetheless, due to sequencing errors, M1,l and M2,l may differ at some positions just by chance. Thus, the accuracy would improve if we can select which positions to use.

To this end, we introduce L-dimensional vector β such that βl ∈ [0, 1] is large when the l-th position likely contains variants and small otherwise. It is then straightforward to define the log-likelihood associated with each haplotype as the weighted sum of the log-likelihood values of L sections.

As an example, for the i-th read, let r1, ⋯, rL be the sequence of each segment of the read (i = 1, ⋯, N). If the read does not have any sub-sequences aligned to the l-th section of the reference, let rl be an empty string. Then, let the L-dimensional vectors L1 and L2 be: and the likelihood of this read on the k-th cluster is then defined as βLT, the inner product of β and Lk. We can assess the fit between β and the i-th read by the deviation from the diagonal line. (7)

Thus, we can estimate an optimal value of β that maximizes the sum of variance–i.e., ∑i Vi. Based on a straightforward calculation, we can conclude that it is equivalent to maximizing the quadratic form below: (8) where is the 2 × 2 identity matrix.

Particularly, if we restrict ‖β2 = 1, the optimal β is the eigenvector that corresponds to the maximum eigenvalue of the middle matrix of the righthand side of Eq 8.

Now, we can call the variant site between two clusters. Assume that there are K clusters. Then, by comparing every pair of two clusters, we can obtain L-dimensional vectors such that βk,k[l] is close to 1 when the l-th location contains variants between the k- and k′-th clusters and is small otherwise. We can finally derive the probability that the n-th read Rn is in the k-th cluster by using these β PO-HMMs for each cluster Mk and the fraction of each cluster πk = |{RiRwi = k}|/N (Eq 13).

Overall, all steps can be found in Algorithm (3). (9) (10) (11) (12) (13)

Lastly, we note that reads supporting the same structural variations would remain in the same cluster. Therefore, if the n-th read supports the k-th structural variants, we set wn = k and never update wn in Algorithm 3 to avoid redundant recalculations.

Algorithm 3 Clustering algorithm for a PO-HMM

Input: a set of reads R = {R1, ⋯, RN} and the number of clusters K

Output: the assignment of each read Rn to a cluster wn ∈ {1, ⋯, K}

1: Randomly initialize wn for n = 1, ⋯, N

2: repeat

3:  Mk← Create a PO-HMM from {RiRwi = k}.

4:  Determine variant sites as β by calling variants from Mk and R.

5:  pn,k← calculate (13).

6:  wn ← arg maxk pn,k

7: until the convergence

8: Return w1, ⋯, wN

Results

In the following experiments, we used LAST version 956 [28] and LAST-split [29] for alignment and Flye [30] version 2.8 with the --meta option for assembly and polishing. We used 28 threads Intel Xeon Gold 5117 CPU (2.0 GHz).

Overview of the dataset

We used one whole-genome sequencing (WGS) dataset of A. thaliana Ler strains available at PacBio’s official repository (https://downloads.pacbcloud.com/public/SequelData/ArabidopsisDemoData/). We also downloaded seven WGS datasets of A. thaliana from a previous study [31]. These strains were the Kyoto, Sha, C24, An-1, Ler, Eri-1, and Cvi-0 strains (SRA Accession numbers:ERR3415817-ERR3415831). Additionally, as the current reference genome (master circle) is based on the mitogenomes of the Col-0 strain, we sequenced this strain anew as a control dataset (SRA Accession numbers: DRR234977). These datasets were all sequenced using the PacBio Sequel system.

We mainly used the latest assembly (GenBank ID: BK010421.1) as the reference master circle. For the Ler and C24 strains, we also used the master circles assembled for these strains (GenBank ID: JF729100 and JF729102, respectively).

We filtered out reads from nuclear genomes from these WGS datasets, taking into account that the region from 3245K to 3511K bp in chromosome 2 of A. thaliana exhibits substantial similarity with some parts of the mitogenome. After filtering, we obtained 198 ± 50M bp (SD, n = 9) of long reads for each accession, presumably sequenced from the mitogenome. The average read lengths were 12.8 ± 3.4K bp (SD, n = 9), and we achieved a coverage of approximately 600 relative to the reference genome. The average error rate was approximately 13%, and the mismatch, deletion, and insertion rates were 3.3%, 3.6%, and 6.1%, respectively.

Performance on simulated datasets

To start, we assessed our method’s performance by ground-truthing with simulated datasets. First, we generated two 9K-bp templates and introduced a few (2–4) variants. Then, we made c (40–70) reads from each template with varying error rates from 1% to 15% (substitution:insertion:deletion = 4:7:4) to simulate the error pattern and read length of our datasets. For each parameter, we carried out experiments 40 times with different seeds. Using Algorithm 3, we grouped these reads into two clusters. Our model decomposed the reads into corresponding structures even when there was only one variant site (Fig 2A).

thumbnail
Fig 2. Results using simulated datasets.

(A): Accuracy with respect to coverage and number of variant sites in the templates. Each box plot shows the first, second, and third quantiles of these experiments. (B): Plot of Pr{RiMk}. We sampled 40 reads and 160 reads from the remaining template, respectively; thus, the 200 reads were unevenly distributed in the dataset. The upper figure (“AFTER”) represents Pr{RiMk} after clustering, and the lower figure (“BEFORE”) represents the values calculated based on assignments initialized randomly. (C): Plot of the posterior probabilities for six templates. We sampled 60 reads from each template. To plot the results in two-dimensional space, we used “RtSNE(https://github.com/jkrijthe/Rtsne).” 30 out of 360 reads were mis-classified. (D): Schematic illustration of two synthetic multipartite structures. The blue circle and orange curve represent a master circle and an alternative linear structure, respectively. (E): Comparison of Flye’s contigs produced with (right dot plot) or without (left dot plot) our proposed method. We used Gepard [32] to create these dot plots. Red vertical lines represent the boundaries of the contigs. (F): Circos plot of the mock genome. In the figure, from the outside to the inside, the blue line represents the overall coverage of the reference, the orange line represents the coverage of a minor cluster, the thick blue line represents the coordinate axis of the reference, and the number of reads that stop or start alignment at each position can be found along the inner blue line.

https://doi.org/10.1371/journal.pcbi.1008597.g002

To consider the case where there are more than two clusters (K > 2), we generated two to six templates with a 0.05% divergence rate and created reads with 15% errors from each template. The length of these templates were 9K-bp. Fig 2B and 2C show the normalized value of the left term of Eq 13 for cases with two and six clusters. Reads generated from the same template were correctly aggregated by our PO-HMM clustering.

In addition, we generated two 500K bp artificial genomes with 0.2% divergence and two structural variations that differed by 125K bp (Fig 2D). We then simulated long-read sequences using BadRead [33] with 50, 100, and 150 coverage. By clustering via a PO-HMM with K = 3 and assembling each resulting cluster, these structural variations were merged into the same cluster in all cases, which cannot be achieved by inputting all the reads into current assemblers (Fig 2E and 2F).

Lastly, we compared our method to other existing tools designed to group error-prone long reads using the dataset with 150 coverage used in the Fig 2D. Although we found no tools were designed to work on plant mitochondrial genomes, we selected three tools for clustering long reads; CARNAC-LR [22], isONclust [23], and WhatsHap version 1.0 [21]. CARNAC-LR, a tool for de novo clustering for Oxford Nanopore Technologies (ONT) reads, output 39 clusters. isONclust, a tool for clustering either PacBio Iso-Seq or ONT reads, output 14 clusters as a final result. WhatsHap, a very efficient tool for haplotyping, offered haplotag module to clustering long-reads. It clustered reads into five clusters and there were 166 mis-classified reads out of 8923 reads. On the other hand, our PO-HMM algorithm made two clusters and there were only 112 mis-classified reads out of 8923 reads. Overall, while CARNAC-LR and isONclust output very fragmented clusters, WhatsHap and PO-HMM output higly accurate clusterings.

One downside of our method is that it requires more time than other programs. Specifically, while CARNAC-LR, isONClust, and WhatsHap took 15, 3.4, 11, minutes, respectively, to decompose the dataset, our method took CPU 110 minutes. Thus, although our approach could output accurate clustering for plant mitochondrial genomes in a resonable amount of time, it does not scale to so-called “genome scale” clustering.

Performance on real datasets

After manual investigation of the reads indicating structural variations in the reference genome, we presumed that one minor component was present in each section of the reference in addition to the “master circle.” Therefore, we set the cluster number for each section (K) to 3 and decomposed the reads from nine A. thaliana datasets. Then, we assembled each cluster to obtain putative multipartite structures for each strain.

The results for the two Ler strains and the Kyoto strain are shown in Fig 3A–3D. In each circos plot, even though the master circles were defined as “circular,” we broke the end of the contig to draw ticks.

thumbnail
Fig 3. Results using real datasets.

In (B) and (D), we present the schematic illustration of the largest cluster. (A): Circos plot of the Ler dataset from PacBio’s official repository. (B): Dot plots between the assembled contigs from the Ler dataset from PacBio’s official repository and the reference contig. Colored arrows indicate the correspondences between clusters and contigs. We plotted five assembled contigs from 12 clusters due to space limitations. (C): Circos plot of the Ler dataset from [31]. (D): Circos plot of the Kyoto strain on Col-0’s master circle. (E): Cover rate associated with each pair of accessions. (F): Linear structures observed in the remaining datasets–i.e., An1, C24, Cvi-0, Eri-1, and Sha. Cropped circos plots are displayed here. (G): Schematic illustration of our hypothesis. The mitogenome is cleaved at two specific sites (upper figure), and the resulting linear structure, as represented by red lines in the lower figure, was observed.

https://doi.org/10.1371/journal.pcbi.1008597.g003

We did not observe any apparent deletion or insertion in the master circle of the Col-0 strain, confirming that we correctly filtered out non-mitogenomic sequences from the WGS dataset. The two Ler strains, which were treated as biological replicates in our experiment, independently exhibited a similar pattern of multipartite structures (Fig 3A and 3C), suggesting that these structures are not sequencing artifacts.

In addition to the structural variations observed in a previous study [18], we detected strain-specific multipartite structures using Algorithm 3. We observed complicated recombination patterns in the Kyoto strain (Fig 3D).

Another interesting finding is that of short (10K-bp), isolated linear structures, as indicated by black arrows in Fig 3A and 3D. We detected these linear structures in all datasets except for the Col-0 dataset, and this structure could be detected even when we used another reference master circle of the Ler strain, indicating that this is not an artifact of the current assembly. Specifically, in the Ler dataset from PacBio’s repository, this linear structure consisted of 281 reads, and only 53 met both of the boundaries. Thus, the remaining 228 reads started from either one of the two boundaries or between boundaries. We estimated the coverage of this linear structure as 220-fold, which was 30% of the total coverage. Also, the “T-like” mark around these structures indicates that there were other structures extending in outward directions (Fig 3G).

In summary, an average of 13 clusters were obtained, ranging from 11 clusters in the Sha strain to 15 structures in the Ler strain. Nonetheless, this may be an overestimate, as there may be clusters that do not contain any variants and are merged only with longer reads. For example, as previously reported, there were signatures of repeat-mediated recombination as shown in Fig 3A. However, we could not perfectly reconstruct these clusters, resulting in short contigs.

To assess the variation among strains, we calculated the cover rate of every pair of multipartite structures. We aligned one contig onto the other and examined the length at which the reference contig was covered. We used lastal -R00 after tuning the parameters with last-train to tune alignment parameters. The cover rate was 98.1 ± 1.8%(SD, n = 56), suggesting that the sequence content may be conserved despite the diverse structural variations. However, these results could be affected by the errors remaining from sequencing long reads; hence, the values may be underestimated.

Discussion

About our proposed method

Our proposed method, the PO-HMM, can segregate error-prone long reads from similar but slightly different genomes. Particularly, our method can be used to detect a few variant sites in error-prone long reads comprising several thousand base pairs. In other words, supporting information such as variant calling data from Illumina’s short reads is not needed.

Another possible application of our algorithm is polyploid phasing of long reads [34]. However, the current implementation is not designed for genome-scale datasets and runs too slowly for use with such large datasets. We suspect that using multiple sequence alignment methods in place of the POA approach may provide much faster performance.

About mitochondrial genomes

By applying our method, we were able to identify putative multipartite structures in nine datasets of A. thaliana mitochondrial genomes. The strain-specific structure found in the Kyoto strain appears to have been obtained at some point in this strain’s history and then maintained within the strain. We also found a 10K-bp linear segment in all but one dataset, which we believe is a recurrent and shared structure among A. thaliana.

The latter finding is interesting, as there seems to be a so-called “mitochondrial-bottleneck” between each generation. As these linear structures coincided with the complementary linear structures extending in outward directions, we speculate that this structure is created de novo at each generation by processes such as DNA cleavage by regulatory enzymes.

As shown in the results, we failed to rebuild a few structures. This is because there were, presumably, few variations in the sequence even in the repetitive regions. Thus, some structures may differ from those in the major genome only at the structural level, which is consistent with a hypothesis stated in a previous review [19].

Conclusion

In this paper, we introduced a new method for clustering long reads derived from very similar regions. We validated our method using simulated datasets and applied it to nine real datasets, predicting a multipartite structure for each strain. Our result not only confirmed the structural variations reported previously but also suggested co-occurrence among these structural variations.

Our suggested method can be improved further. First, The structure found, e.g. linear structure, needs to be confirmed by lab experiments. Also, it is still misleading to compare each assembled contig in a base-to-base manner, as these contigs are not completely accurate after polishing by Flye’s polishing module.

Future research will focus on finding sequence features enriched in the boundaries of the detected multipartite structures. For example, as repeats are thought to mediate recombination events, we expect to find a positive relationship between the fraction of a structure and the length of nearby repeats, as implied by a previous study [35, 36].

Our PO-HMM currently does not scale to the size of genomes larger than several mega base pairs. This is because we create PO-HMMs from the reads at each loop in Algorithm 3. By solving this issue, our method would find a broader application. For example, it could be used to resolve segmental duplications in the assembly (like SDA [37]) and to distinguish haplotypes in diploid genome assembly.

Acknowledgments

We thank for technical assistance by Yoshiko Tamura and Yu Tsuruta. Yuta Suzuki and Yoshihiko Suzuki gave us insightful comments.

References

  1. 1. Sagan L. On the origin of mitosing cells. Journal of theoretical biology. 1967;14(3):225–IN6. pmid:11541392
  2. 2. Gualberto JM, Newton KJ. Plant mitochondrial genomes: dynamics and mechanisms of mutation. Annual Review of Plant Biology. 2017;68:225–252. pmid:28226235
  3. 3. Hanson M. Plant Mitochondrial Mutations And Male Sterility. Annual Review of Genetics. 2002;25(1):461–486.
  4. 4. Unseld M, Marienfeld JR, Brandt P, Brennicke A. The mitochondrial genome of Arabidopsis thaliana contains 57 genes in 366,924 nucleotides. Nature Genetics. 1997;15(1):57–61. pmid:8988169
  5. 5. Notsu Y, Masood S, Nishikawa T, Kubo N, Akiduki G, Nakazono M, et al. The complete sequence of the rice (Oryza sativa L.) mitochondrial genome: frequent DNA sequence acquisition and loss during the evolution of flowering plants. Molecular Genetics and Genomics. 2002;268(4):434–445. pmid:12471441
  6. 6. Shearman JR, Sonthirod C, Naktang C, Pootakham W, Yoocha T, Sangsrakru D, et al. The two chromosomes of the mitochondrial genome of a sugarcane cultivar: assembly and recombination analysis using long PacBio reads. Scientific Reports. 2016;6(1):31533. pmid:27530092
  7. 7. Shi Y, Liu Y, Zhang S, Zou R, Tang J, Mu W, et al. Assembly and comparative analysis of the complete mitochondrial genome sequence of Sophora japonica ‘JinhuaiJ2’. PloS one. 2018;13(8).
  8. 8. Wang S, Song Q, Li S, Hu Z, Dong G, Song C, et al. Assembly of a complete mitogenome of Chrysanthemum nankingense using Oxford Nanopore long reads and the diversity and evolution of Asteraceae mitogenomes. Genes. 2018;9(11):547. pmid:30424578
  9. 9. Dong S, Zhao C, Chen F, Liu Y, Zhang S, Wu H, et al. The complete mitochondrial genome of the early flowering plant Nymphaea colorata is highly repetitive with low recombination. BMC Genomics. 2018;19(1):1–12. pmid:30107780
  10. 10. Kovar L, Nageswara-Rao M, Ortega-Rodriguez S, Dugas DV, Straub S, Cronn R, et al. PacBio-based mitochondrial genome assembly of Leucaena trichandra (Leguminosae) and an intrageneric assessment of mitochondrial RNA editing. Genome biology and evolution. 2018;10(9):2501–2517. pmid:30137422
  11. 11. Wu Z, Hu K, Yan M, Song L, Wen J, Ma C, et al. Mitochondrial genome and transcriptome analysis of five alloplasmic male-sterile lines in Brassica juncea. BMC genomics. 2019;20(1):348. pmid:31068124
  12. 12. Diaz-Garcia L, Rodriguez-Bonilla L, Smith T, Zalapa J. Pacbio sequencing reveals identical organelle genomes between american cranberry (Vaccinium macrocarpon ait.) and awild relative. Genes. 2019;10(4):1–15.
  13. 13. Kozik A, Rowan BA, Lavelle D, Berke L, Schranz ME, Michelmore RW, et al. The alternative reality of plant mitochondrial DNA: One ring does not rule them all. PLoS genetics. 2019;15(8):e1008373. pmid:31469821
  14. 14. Omelchenko DO, Makarenko MS, Kasianov AS, Schelkunov MI, Logacheva MD, Penin AA. Assembly and Analysis of the Complete Mitochondrial Genome of Capsella bursa-pastoris. Plants. 2020;9(4):469. pmid:32276324
  15. 15. Logacheva MD, Schelkunov MI, Fesenko AN, Kasianov AS, Penin AA. Mitochondrial Genome of Fagopyrum esculentum and the Genetic Diversity of Extranuclear Genomes in Buckwheat. Plants. 2020;9(5):618. pmid:32408719
  16. 16. Davila JI, Arrieta-Montiel MP, Wamboldt Y, Cao J, Hagmann J, Shedge V, et al. Double-strand break repair processes drive evolution of the mitochondrial genome in Arabidopsis. BMC Biology. 2011; pmid:21951689
  17. 17. Kmiec B, Woloszynska M, Janska H. Heteroplasmy as a common state of mitochondrial genetic information in plants and animals. Current genetics. 2006;50(3):149–159. pmid:16763846
  18. 18. Arrieta-Montiel MP, Shedge V, Davila J, Christensen AC, Mackenzie SA. Diversity of the Arabidopsis mitochondrial genome occurs via nuclear-controlled recombination activity. Genetics. 2009;183(4):1261–1268. pmid:19822729
  19. 19. Woloszynska M. Heteroplasmy and stoichiometric complexity of plant mitochondrial genomes?though this be madness, yet there’s method in’t. Journal of experimental botany. 2010;61(3):657–671. pmid:19995826
  20. 20. Alverson AJ, Rice DW, Dickinson S, Barry K, Palmer JD. Origins and Recombination of the Bacterial-Sized Multichromosomal Mitochondrial Genome of Cucumber. The Plant Cell. 2011;23(7):2499–2513. pmid:21742987
  21. 21. Patterson M, Marschall T, Pisanti N, Van Iersel L, Stougie L, Klau GW, et al. WhatsHap: weighted haplotype assembly for future-generation sequencing reads. Journal of Computational Biology. 2015;22(6):498–509. pmid:25658651
  22. 22. Marchet C, Lecompte L, Silva CD, Cruaud C, Aury JM, Nicolas J, et al. De novo clustering of long reads by gene from transcriptomics data. Nucleic Acids Research. 2018;47(1):e2–e2.
  23. 23. Sahlin K, Medvedev P. De Novo Clustering of Long-Read Transcriptome Data Using a Greedy, Quality Value-Based Algorithm. Journal of Computational Biology. 2020;27(4):472–484. pmid:32181688
  24. 24. Lee C, Grasso C, Sharlow MF. Multiple sequence alignment using partial order graphs. Bioinformatics. 2002;18(3):452–464. pmid:11934745
  25. 25. Vaser R, Sović I, Nagarajan N, Šikić M. Fast and accurate de novo genome assembly from long uncorrected reads. Genome research. 2017;27(5):737–746. pmid:28100585
  26. 26. Biegert A. Context-specific methods for sequence homology searching and alignment. Ludwig Maximilian University of Munich. Available from:https://edoc.ub.uni-muenchen.de/16691/; 2010.
  27. 27. Hamada M, Ono Y, Asai K, Frith MC. Training alignment parameters for arbitrary sequencers with LAST-TRAIN. Bioinformatics. 2017;33(6):926–928. pmid:28039163
  28. 28. Kiełbasa SM, Wan R, Sato K, Horton P, Frith MC. Adaptive seeds tame genomic sequence comparison. Genome research. 2011;21(3):487–493. pmid:21209072
  29. 29. Frith MC, Kawaguchi R. Split-alignment of genomes finds orthologies more accurately. Genome Biology. 2015;16(1):1–17. pmid:25994148
  30. 30. Kolmogorov M, Yuan J, Lin Y, Pevzner PA. Assembly of long, error-prone reads using repeat graphs. Nature biotechnology. 2019;37(5):540–546. pmid:30936562
  31. 31. Jiao WB, Schneeberger K. Chromosome-level assemblies of multiple Arabidopsis genomes reveal hotspots of rearrangements with altered evolutionary dynamics. Nature Communications. 2020;11(1):1–10. pmid:32080174
  32. 32. Krumsiek J, Arnold R, Rattei T. Gepard: a rapid and sensitive tool for creating dotplots on genome scale. Bioinformatics. 2007;23(8):1026–1028. pmid:17309896
  33. 33. Wick R. Badread: simulation of error-prone long reads. Journal of Open Source Software. 2019;4(36):1316.
  34. 34. Schrinner SD, Mari RS, Ebler J, Rautiainen M, Seillier L, Reimer JJ, et al. Haplotype threading: accurate polyploid phasing from long reads. Genome Biology. 2020;21(252). pmid:32951599
  35. 35. Sloan DB, Wu Z, Sharbrough J. Correction of persistent errors in Arabidopsis reference mitochondrial genomes. The Plant Cell. 2018;30(3):525–527. pmid:29519893
  36. 36. Sullivan AR, Eldfjell Y, Schiffthaler B, Delhomme N, Asp T, Hebelstrup KH, et al. The mitogenome of Norway spruce and a reappraisal of mitochondrial recombination in plants. Genome biology and evolution. 2020;12(1):3586–3598. pmid:31774499
  37. 37. Vollger MR, Dishuck PC, Sorensen M, Welch AE, Dang V, Dougherty ML, et al. Long-read sequence and assembly of segmental duplications. Nature methods. 2019;16(1):88–94. pmid:30559433