Skip to main content
Scientific Reports logoLink to Scientific Reports
. 2021 Jun 23;11:13183. doi: 10.1038/s41598-021-88321-5

Genome assembly using quantum and quantum-inspired annealing

A S Boev 1, A S Rakitko 2, S R Usmanov 1, A N Kobzeva 1, I V Popov 2, V V Ilinsky 2, E O Kiktenko 1,3, A K Fedorov 1,3,
PMCID: PMC8222255  PMID: 34162895

Abstract

Recent advances in DNA sequencing open prospects to make whole-genome analysis rapid and reliable, which is promising for various applications including personalized medicine. However, existing techniques for de novo genome assembly, which is used for the analysis of genomic rearrangements, chromosome phasing, and reconstructing genomes without a reference, require solving tasks of high computational complexity. Here we demonstrate a method for solving genome assembly tasks with the use of quantum and quantum-inspired optimization techniques. Within this method, we present experimental results on genome assembly using quantum annealers both for simulated data and the ϕX 174 bacteriophage. Our results pave a way for an increase in the efficiency of solving bioinformatics problems with the use of quantum computing and, in particular, quantum annealing. We expect that the new generation of quantum annealing devices would outperform existing techniques for de novo genome assembly. To the best of our knowledge, this is the first experimental study of de novo genome assembly problems both for real and synthetic data on quantum annealing devices and quantum-inspired techniques.

Subject terms: Quantum physics, Biotechnology


Over the past few decades, an amount of DNA-related data has been increasing exponentially1, and genomics is by now a data-driven science2. More than 40 years ago, the first DNA genome (ϕX 174 bacteriophage) was sequenced3. It took almost 13 years to sequence the whole human genome. Today, public and private facilities offer human genome sequencing that takes days or weeks4. Current technologies sequence whole genomes in an unstructured set of reads with partial overlapping. However, the task of assembling DNA, i.e., aligning and merging reads in order to reconstruct the original genome, which is a required step for most of the applications, still remain challenging5.

Existing approaches in sequencing read analysis are based on de novo assembling or mapping to an established reference. De novo assembly is a method for constructing the original DNA sequence from the unstructured set of reads without any prior knowledge of the source DNA sequence length, layout, or composition6. De novo assembly is then essential for studying new species and structural genomic changes that cannot be detected by reading mapping. The complexity of de novo assembly depends on the genome size, abundance, length of repetitive sequences, and possible polyploidy6. For example, de novo assembly of a tiny ϕX 174 genome (5386 base pairs) on a laptop takes 10 minutes, while for the human genome (3.2×106 base pairs) it takes about 48 hours on a supercomputer7. This time scale is acceptable in research tasks, but it is a limitation for emergency applications (including the clinical use). Read mapping on a backbone of the reference genome is computationally more simple and allows detection of single- and oligonucleotide mutations, which are the major causes of human diseases8. However, the detection of genome rearrangements is a complicated task9. Read mapping algorithms used for the analysis of clinically important samples use local de novo assembly to correct mapping errors and reference mismatches10. De novo assembly is currently used in transcriptome and cancer analysis, as gene fusions and genome rearrangements are common causes of malignant tumours11. Decreasing the costs of sequencing makes whole-genome sequencing an irreplaceable part of personalized medicine and cancer treatment. The utility of sequencing technologies requires improved workflows with de novo assemblers to uncover significant genomic rearrangements in cancer and normal tissues.

Early generations of assembly tools are based on the overlap layout consensus (OLC) algorithm12. Overlap discovery involves all-against-all, pair-wise read comparison, where one sets up the minimal number of shared nucleotides between two reads and an allowed number of mismatches. In the OLC graph, each read is represented by a vertex and an edge between two vertices indicates the overlap between corresponding reads. Then, finding the Hamiltonian path, i.e., the path that goes through all vertices and visits each vertex only once, allows reconstructing the original genome. This approach is widely used in assemblers (e.g., see Ref.13) and becomes suitable for the single-molecule sequencing technologies14,16.

It is well known that finding a Hamiltonian cycle belongs to the class of NP-complete computational problems, for which finding an efficient solution is very hard. That is why the other graph representation is applied to the analysis of the sequencing data. This approach is related to the concept of De Bruijn graphs (DBG)17. The idea is to construct a graph based on the fragmentation of reads down to smaller sequences called k-mers, where k is the length of subsequence. These k-mers are aligned using (k-1) sequence overlaps. Each node in the resulting k-mer graph represents a certain k-mer, while edges correspond to the overlaps between the k-mers. Thus, each read is represented by the sequence of the connected vertices (so-called overlapped k-mers). To obtain the original genome sequence one needs to find the Eulerian path, i.e., the path that visits each edge exactly once, but is allowed to revisit any vertex. The comparison of the OLC and DBG approaches are discussed in more detail in Ref.15. As was mentioned above, the time of de novo assembling may be crucial for many applications. Possible improvements and speed-ups of the DBG approach, employing the Eulerian path, have been considered, whereas methods based on finding the Hamiltonian path in the OLC approach are less studied.

Quantum computers are a new generation of devices that use quantum phenomena, such as superposition and entanglement, for solving computational tasks. It is believed that quantum computers18 have a great potential to outperform existing technologies in various problems19, such as simulating complex systems20, machine learning21, and optimization22. Ongoing research are related to the question how quantum computers could be used for computational biology and bioinformatics23. One of the algorithms that can be realized using quantum computers is Grover’s search24, which can be used as a subroutine for sub-sequence alignment with a quadratic speed-up25. There is increased activity at the interface of machine learning and quantum computing in the computational biology domain23,26,27. Being of extreme interest from the viewpoint of obtaining polynomial and exponential computational speedups, the suggested quantum algorithms2328 require both a significant number of qubits and quite low error rates, which are beyond the capabilities of existing noisy intermediate-scale quantum (NISQ) devices.

Although many different implementations and models of quantum computing are in development, one of the approaches, which is based on quantum annealing, deserves a special attention. This is due to the fact that the hardware for its implementation is available (it is produced by D-Wave System)2931. However, the ability of realistic quantum annealing devices to demonstrate computation speedups is still a subject of ongoing research31,3337. An interesting outcome of these debates is the appearance of a new generation of quantum-inspired (digital annealing) algorithms, which are essentially classical but appear as a result of analysing the role of quantum phenomena in solving computational tasks3840. Results on the comparison between available quantum annealers and quantum-inspired algorithms on realistic optimization problems have been obtained40. We note that quantum annealing has been applied to various real-world tasks, including computational biology41, exploration of the conformational landscape of peptides and proteins42, and genome sequence alignment28.

Here we investigate the de novo genome assembly problem within the framework of quantum annealing. On the one hand, the OLC approach is less sensitive to sequencing errors and repeats than the DBG approach which leads to the higher quality of the assembly. On the other hand, the main disadvantage of the OLC-based algorithms is their computational inefficiency15. Particularly, as we need to solve the NP-hard problem of finding a Hamiltonian path in the graph. Quantum computations have already shown their potential suitability for solving such problems. The above mentioned arguments motivate us to focus on the OLC formulation of the de novo genome assembly problem. The main step in our study is to map the genome assembly problem in the framework of OLC graphs to a quadratic unconstrained binary optimization (QUBO) problem, which can be then efficiently embedded in the quantum annealing architecture (see Fig. 1). We also show that the genome assembly problem can be solved with the use of quantum-inspired optimization algorithms. We note that our idea is to use quantum optimization for de novo sequencing, while other problems related to the analysis of genetic data are beyond the scope of the present work.

Figure 1.

Figure 1

Solving the de novo genome assembly problem using quantum annealers and quantum-inspired (digital) annealing algorithms: (a) raw reads; (b) raw reads are transformed to the overlap-layout-consensus (OLC) graph; (c) finding the Hamiltonian path for the OLC graph is reduced to the QUBO problem; (d) the QUBO problem should be embedded to the architecture of the quantum annealer (D-Wave): for this purpose each logical variable of the the QUBO problem is assigned with several qubits of the quantum annealer; (e) and (f) the Ising problem in QUBO form can be solved using quantum annealers (D-Wave) and quantum-inspired algorithms (SimCIM), correspondingly; (g) the output is the Hamiltonian path; (h) the genome sequence is obtained as the solution.

QUBO reformulation of the genome assembly problem

The growing interest in the use of quantum computing devices (and in particular to quantum annealers) is related to their potential in solving combinatorial optimization problems. It is widely discussed that the potential of quantum annealing is rooted in the quantum effects that allow us to efficiently explore the cost-function landscape in ways unavailable to classical methods. Therefore, the important stage is to map the problem of interest to a Hamiltonian, which maps the binary representation of a graph path into a corresponding energy value. The existing physical implementation of quantum annealing is the D-Wave processor, which can be described as Ising spin Hamiltonian. The Ising Hamiltonian can be transformed into a QUBO problem. Thus, we have to find the mapping to a problem that we would like to solve on the D-Wave quantum processor to the QUBO form. However, establishing correspondence between a problem of interest and the QUBO form may require additional overhead. In particular, in our case the transformation of the OLC graph to a QUBO problem requires the use of additional variables (see below).

In addition, the D-Wave quantum processor has its native structure (the chimera structure). That is why after the formulation of the problem of interest in the QUBO form an additional stage of embedding problem in the native structure of the quantum device is required. So additional overhead in the number of physical qubits, which is related to the representation of logical variables by physical qubits of the processor (that takes into account the native structure), is required (see below).

Formulation of the Hamiltonian path problem

Along the lines of Ref.43, we reformulate the task of finding the Hamiltonian path in the OLC graph as a QUBO problem.

Let a directed OLC graph be given in the form G=(V,E), where V={1,2,,N} is a set of vertices, and E is set of edges consisting of pairs (uv) with u,vV. The solution of the Hamiltonian path problem is represented in the form of N×N permutation matrix X=(xv,i), whose unit elements xv,i represent the path going through the vth node at the ith step. Then, we assign each element xv,i of the matrix X a separate logical variable (spin) within an optimization problem. Note, that this representation results in polynomial overhead in the number of logical variables of the QUBO problem: The solution for N-vertex graph requires N2 logical variables. The resulting Hamiltonian of the corresponding QUBO problem takes the following form:

H=Av=1N1-j=1Nxv,j2+Aj=1N1-v=1Nxv,j2+A(u,v)Ej=1N-1(xu,jxv,j+1), 1

where A>0 is a penalty coefficient. The first two terms in Eq. (1) ensure the fact that each vertex appears only once in the path, and there is a single vertex at each step of the path. The third term provides a penalty for connections within the path that are beyond the allowed ones. With this QUBO formulation, we are able to run the genome assembly task using quantum annealers and quantum-inspired algorithms. We note that the applicability of the method requires the existence of the Hamiltonian path in the corresponding graph, which is not universally the case for arbitrary genetic data given by an OLC-graph.

Formulation of the Hamiltonian path problem for acyclic graphs

In general, Hamiltonian path mapping is suitable both for cyclic and acyclic directed graphs. However, it is often the case that the OLC graph contains no cycles. It is then possible to further simplify transformation and reduce the qubit overhead. Here, we demonstrate more compact mapping that requires only M logical variables, where M=|E|<N2 is the number of edges. For the acyclic OLC graph G=(V,E), let us define a set of binary variables {xu,v}(u,v)E that indicate whether an edge (uv) is included in the Hamiltonian path. Then the corresponding Hamiltonian should include the following two components:

H=AuV1-(u,v)Exu,v2+AvV1-(u,v)Exu,v2. 2

The first and the second terms in Eq. (2) assure that each vertex is incident (if possible) with a single incoming and outgoing path edges correspondingly. Although this realization is helpful and can be used for solving genome assembly problems on quantum annealers without polynomial qubit overhead (the encoding requires M variables, where M is the number of edges in the corresponding OLC-graph), the asymptotic computational speed-up versus classical algorithm is not exponential (since there exist efficient classical algorithms for solving this problem).

Embedding to the processor native structure

As it is mentioned before, the logical variables in Hamiltonians (1) and (2) are not necessarily equivalent to physical qubits of a quantum processor. This is due to the fact that quantum processors have its native structure, i.e. topology of physical qubits and couplers between them. For example, each D-Wave 2000Q QPU is fabricated with 2048 qubits and 6016 couplers in a C16 Chimera topology2931. Within a C16 Chimera graph, physical qubits are logically mapped into a 16×16 matrix of unit cells of 8 qubits, where each qubit is connected with at most 6 other qubits. In order to realize Hamiltonians (1) and (2), whose connections structure may differ from the one of the processor, we employ an additional embedding stage, described in32. It allows obtaining a desired effective Hamiltonian by assigning several physical qubits of the processor to a single logical variable of the original Hamiltonian (see Fig. 1c,d). The embedding to the native structure introduces considerable overhead in qubit number relative to the fully-connected model, yet allows solving problems with existing quantum annealers.

Results

Here we apply our method for the experimental realization of de novo genome assembly using quantum and quantum-inspired annealers. As a figure of merit we use the time-to-solution (TTS), which is the total time required by the solver to find the optimal solution (ground state) at least once with a probability of 0.99. We first define R99 as the number of runs required by the solver to find the ground state at least once with a probability of 0.99. Using binomial distribution one can calculate R99 as follows:

R99=log(1-0.99)log(1-θ), 3

where θ is an estimated success probability of each run.

Then we define TTS it in the following way:

TTS=taR99, 4

where ta for D-Wave is 20μs (default value).

Quantum-inspired optimization algorithms can be also used for solving QUBO problems. In our experiments, we employ SimCIM quantum-inspired optimization algorithm38, which is based on the differential approach to simulating specific quantum processors called Coherent Ising Machine (CIM; see “Methods”). SimCIM runs on conventional hardware and is easily parallelizable on graphical processing units (GPU). This is the time for simulating a single annealing run using our implementation of SimCIM, measured on Intel core i7-6700 Quad-Core, 64GB DDR4, GeForce GTX 1080.

ϕX 174 bacteriophage genome

We start with the paradigmatic example of the ϕX 174 bacteriophage genome3. In order to realize de novo genome assembly, we construct the adjacency matrix for OLC graphs and use pre-processing for packing this graph into D-Wave processor. We then transform each adjacency graph into the QUBO matrix according to Eq. (2). For the case of using the D-Wave system we embed the QUBO problem in the native structure of the annealing device (which naturally adds overhead in the number of qubits; see “Methods”). In order to embed ϕX 174 graph into the D-Wave processor, we have preliminary conducted manual graph partitioning using classical algorithms implemented in the METIS tool44. Then the problem can be solved with the use of quantum annealing hardware by D-Wave and quantum-inspired optimization algorithm.

For each instance, a total of 103 anneals (runs) were collected from the processor, with each run having an annealing time of 20 μs. The total number of instances is 1000 (the process of their generation is described in “Methods”). The results are presented in Table 1. Up to our best knowledge, this is the first realistic-size de novo genome assembly employing the use of quantum computing devices and quantum-inspired algorithms. The presented time is required for finding the optimal solution since only one solution has a right interpretation. We note that the time required for the data pre-processing is not included in Table 1. Details of graph size for each part after manual graph partitioning is presented in Table 2 in “Methods”.

Table 1.

Genome assembly time for ϕX 174 bacteriophage for 1000 instances.

Mean, μs Min, μs Max, μs 90%
Quantum annealer CPU 8483 8314 8619 8579
QPU 535 369 672 600
Quantum-inspired annealer (SimCIM) 262 9.9 7212 1061

For the data based on experiments with quantum annealers we highlight required classical processor unit (CPU) time and quantum processor unit (QPU) time.

Table 2.

Experimental scheme for the synthetic dataset.

Sequence length Graph size Qubo size Physical qubits
5 3 9 36
6 4 16 80
7 5 25 200
8 6 36 360
9 7 49 686
10 8 64 1088

Statistics presented for 1000 simulated Phi-X 174 bacteriophage OLC graphs. We use D-Wave hybrid computing mode, which employs further graph decompositions with parallel computing on both classical and quantum backends. D-Wave gives access to the following timing information in the information system: Trun (run time), Tcharge (charge time), and TQPU (QPU access time). We assume CPU time =Trun-TQPU. We summarize QPU access time and CPU time for obtained OLC graphs. For the case of SimCIM, we use TTS.

Benchmarking quantum-assisted de novo genome assembly using the synthetic dataset

In order to perform a complete analysis of the suggested approach, we realize the quantum-assisted de novo genome assembly for the synthetic dataset. We generate a synthetic dataset, which consists of 60 random reads of length from 5 to 10 (for details, see “Methods”), 10 problems are generated for every sequence length. We then split each read into k-mers of length 3 and compute adjacency matrix for the corresponding OLC graph using Eq. (2). Finally, we transform each adjacency graph into the QUBO matrix according to our algorithm and minimize it using quantum annealing hardware by D-Wave and quantum-inspired optimization algorithms.

Our goal is to check the applicability of existing quantum annealers to the task of genome assembly, evaluate the upper bound on the input problem size (particularly, the length of the original genome), compare the performance of the D-Wave quantum annealer with a software annealing simulator SimCIM. The choice of tools is motivated by their maturity in terms of quantum dimensionality and compatibility with the original formulation in terms of the optimization problem. The similar routine is realized with the use of quantum-inspired annealing. We test the suggested approach with the simulated data first with the D-Wave quantum annealer (see Fig. 2) and compare our results with quantum-inspired optimization algorithm SimCIM.

Figure 2.

Figure 2

Comparison of the performance of quantum and quantum-inspired methods for de novo genome assembly based on synthetic data (10 problems were generated for every sequence length): we compare TTS for quantum device D-Wave and quantum-inspired optimization algorithm SimCIM.

We note that the D-Wave annealer shows an advantage in genome assembly for short-length sequences, while it cannot be applied for sequences of length 6 and more due to the fact that the decoherence time becomes comparable with the annealing time. What we observe is that the performance of the annealing system is dependent on the properties of input data. While the exhaustive investigation of the nature of D-Wave performance with respect to input data goes beyond the scope of our research, we consider the connectivity of the input graph as one of the critical factors. The D-Wave 2000Q processor is based on Chimera Topology with native physical connectivity of 6 basic qubit cells.

During the experiments on the synthetic dataset, we were able to embed the problems with a maximum sequence of up to 10 nucleotides. This length corresponds to the fully connected graph with 8 nodes (K8,8) and this is the maximum possible graph size, which can be embedded to the chimera lattice using clique embedding tool from DWave Ocean SDK. While Ocean SDK allows using other types of embedding (e.g., minor miner) we observed that clique embedding demonstrates more stable results due to the deterministic nature of embedding in comparison to the minor-miner tool, which is intrinsically based on randomized heuristics contributing to larger deviations across experiments. However, no viable solution that could reconstruct the original sequence was found for sequences longer than 6.

Discussions

In our work, we have demonstrated the possibility of solving the simplified bioinformatics problem of reconstructing genome sequences using quantum annealing hardware and quantum-inspired algorithms. We have implemented the experimental quantum-assisted assembly of ϕX 174 bacteriophage genome. On the basis of synthetic data, we have shown that the existing quantum hardware allows reconstructing short sequences of up to 7 nucleotides. In order to use quantum optimization for realistic tasks, the ratio of the decoherence time to the annealing time should be considerably improved. We note that while the decoherence time is not a fundamental limitation of the technology, the realization of quantum annealers with sufficient decoherence time remains a challenge. While D-Wave machines use superconducting quantum circuits, setups based on ultracold Rydberg atom arrays4547 and trapped ions48,49 can be also used for the efficient implementation of quantum annealing and other quantum optimization algorithms. Specifically, the system of Rydberg atom arrays has been studied in the context of solving the maximum independent set problem46,47, which is NP-hard. For longer sequences, as we have demonstrated, it is possible to use quantum-inspired algorithms that are capable of solving more complex problems using classical hardware.

We note that our work is a proof-of-principle demonstration of the possibility to use existing quantum devices for solving the genome assembly problem. The problem scale considered in this paper is still far from real sequences (130 kilo-base pairs for primitive bacterias) and is lacking numerous complications, such as errors in sequence reads and handling repeating sequences. However, the proposed method demonstrates that newly evolving computing techniques based on quantum computers and quantum-inspired algorithms are quickly developing and can be soon applied in new areas of science.

Limitations of existing quantum hardware do not allow universally outperform existing solutions for de novo genome assembling. At the same time, one of the most interesting practical questions is when one can expect computational advantages from the use of quantum computing in genome assembling tasks.

We note that in real-life conditions a number of additional challenges arise. Examples include errors (random insertions and deletions, repeats, etc.), genome contaminants (pieces of the genome not related to the subject of interest), polymer chain reaction artifacts, and others require additional post-processing steps. These problems are beyond the scope of our proof-of-principle demonstration and they should be considered in the future. Another complication comes from the fact that temperature and other noise effects play a significant role in the case of the use of realistic quantum devices. Thermal excitation and relaxation processes affect performance. Our further directions include optimization of the QUBO model for more compact spin representation and integration of error model into our algorithm. Solving these two issues can enable reconstruction of real sequences using the quantum approach.

Methods

Quantum annealing protocol

The beginning Hamiltonian of the D-Wave processor is a transverse magnetic field of the following form:

H0=iVhiσix, 5

where σix is the Pauli x-matrix, which acts on ith qubit. The problem Hamiltonian can be encoded to the following Ising Hamiltonian:

HP=iVhiσiz+(i,j)EJijσizσjz, 6

where hi describe local fields, Jij stands for couplings, σiz are the Pauli z-matrices, and E is the set of edges. One can see that HP is of diagonal form, so σiz can be treated as spin values {σiz=±1}. For a given spin configuration σiz the total energy of the system is given by HP, so by measuring the energy one can find a solution to the problem of interest.

Quantum annealing can be applied to any optimization problem that can be expressed in the QUBO form. The idea is then to reduce the problem of interest to the QUBO form.

QUBO transformation

The Ising Hamiltonian can be directly transformed to a quadratic unconstrained binary optimization (QUBO) problem. The following transformation can be applied for this purpose:

wi=σiz+12{0,1}, 7

where {σiz=±1}. For solving the problem on the D-Wave quantum processor, all hi and Jij values are scaled to lie between -1 and 1. As a result, the processor outputs a set of spin values {σiz=±1} that attempts to minimize the energy, and the lower energy indicates better solution of the optimization problem. We note that Ref.43 provides a method for QUBO/Ising formulations of many NP problems.

Quantum-inspired annealing using SimCIM

SimCIM is an example of a quantum-inspired annealing algorithm, which works in an iterative manner. It can be used for sampling low-energy spin configurations in the classical Ising model. The algorithm treats each spin value si as a continuous variable, which lie in the range [-1,1]. Each iteration of the SimCIM algorithm starts with calculating the mean field

Φi=jiJijsj+bi, 8

which act on each spin by all other spins (bi is an element of the bias vector). Then the gradients for the spin values are calculated according to Δsi=ptsi+ζΦi+N(0,σ), where pt,ζ are the annealing control parameters and N(0,σ) is the noise of the Gaussian form. Then the spin values are updated according to siϕ(si+Δsi), where ϕ(x) is the activation function

ϕ(x)=xfor|x|1;x/|x|otherwise 9

After multiple updates, the spins will tend to either -1 or +1 and the final discrete spin configuration is obtained by taking the sign of each si.

Bacteriophage simulations

We use Grinder50 to simulate raw reads from ϕX 174 bacteriophage complete genome (NCBI Reference Sequence: NC_001422.1). To simplify the task and make it feasible for quantum computing we generate 50 reads in each run of simulations. In our proof-of-concept research, we are focused on finding the Hamiltonian path in OLC graph using quantum and quantum-inspired annealing.

We generate the raw reads with no sequencing errors and the length of each read is equal to 600 base pairs. We build the OLC graph using the pairwise alignment of the raw reads implemented in minimap2 package51. We run minimap2 with the predefined set of parameters ava-ont and k=10. We apply miniasm14 to the same data as the benchmark assembler, which uses OLC graphs.

For experiments with quantum annealing, we use public access to D-Wave 2000Q via Leap SDK. We evaluate the impact of tunable parameters (particularly, annealing time) on the final solution quality; however, no significant improvement was discovered against default values, so annealing time was set to 20 μs (default value). The number of annealing runs is set to 103 (maximum possible value). During our experiments we use mostly the standard configuration of the D-Wave processor, so we do not have any specific requirements on the weights/couplers in the model.

Synthetic dataset graphs, which consist of reads no longer than 7 nucleotides (25 graph nodes), are small enough to fit into quantum annealer, so we can use DW_2000Q_5 backend (pure quantum mode of operation; see the following section). However, the size of the ϕX 174 bacteriophage graph (248 vertices) is too large. In order to embed ϕX 174 graph into the D-Wave processor, we have preliminary conducted manual graph partitioning using classical algorithms implemented in the METIS tool44. It allows splitting the original graph into 3 sub-parts. They are carefully selected so that only a single edge remains between them. The longest path is then calculated separately for each part and concatenated into a single path of the original graph. Each part is still large enough to be computed using the purely quantum mode, so we use the D-Wave hybrid computing mode — hybrid_v1 backend. D-Wave hybrid computing mode employs further graph decompositions with parallel computing on both classical and quantum backends. Specifics of such decomposition are not publicly available and physical qubit count is also not shown to the end-user. Details of graph size for each part after manual graph partitioning is presented in Table 2. According to D-Wave Leap specification, hybrid_v1 backend automatically combines the power of classical and quantum computation.

Simulations with synthetic dataset

In order to evaluate the performance of the algorithm in a controlled setup, we generated several hundreds of random nucleotide sequences with variable length and performed corresponding transformations as shown in Fig. 3. Further, we eliminated graph duplicates or other trivial cases, where graph structure contained no auxiliary edges. Synthetic dataset graphs up to the length of 7 nucleotides (25 graph nodes) are small enough to fit into quantum annealer, so we can use DW_2000Q_5 backend (pure quantum mode of operation). Finally, we selected 60 sequences that produce unique OLC graphs with comparable complexity.

Figure 3.

Figure 3

Experimental scheme for the synthetic dataset.

Note Added. Recently, we became aware of the work reporting studies of the quantum acceleration using gate-based and annealing-based quantum computing52.

Acknowledgements

We are grateful to A.I. Lvovsky for fruitful discussions as well as A.S. Mastiukova and D.V. Kurlov for useful comments. We also thank the anonymos referee for careful reading our manuscript and insightful comments that helped to improve the paper. We thank E.S. Tiunov for providing information about the SimCIM algorithm and A.E. Ulanov for the discussion of various quantum-inspired optimization algorithms. This work is supported by Russian Science Foundation (19-71-10092). We also thank D-Wave Systems (the research is conducted within the program of global response to COVID-19).

Author contributions

All authors contributed to the idea and development of the method. A.S.B., S.R.U., A.N.K., I.V.P., E.O.K., and A.K.F. worked on the quantum part of the project. A.S.R., I.V.P., and V.V.I. worked on the biological part of the work. A.S.B. and S.R.U. developed a method for the transformation of the genome assembly task to the QUBO form. A.K.F., A.S.B., and A.S.R. wrote the manuscript with contributions from other authors. A.K.F. supervised the project.

Competing interests

Owing to the employments and consulting activities of A.S.B., S.R.U., E.O.K., and A.K.F., they have financial interests in the commercial applications of quantum computing. A.S.R., I.V.P., and V.V.I. are employees of Genotek Ltd, they declare that they have no other competing interests. A.N.K. declares no competing interests.

Footnotes

Publisher's note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

References

  • 1.Stephens ZD, Lee SY, Faghri F, Campbell RH, Zhai C, Efron MJ, Iyer R, Schatz MC, Sinha S, Robinson GE. Big data: Astronomical or genomical? PLoS Biol. 2015;13:e1002195. doi: 10.1371/journal.pbio.1002195. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Eraslan G, Avsec Z, Gagneur J, Theis FJ. Deep learning: New computational modelling techniques for genomics. Nat. Rev. Genet. 2019;20:389. doi: 10.1038/s41576-019-0122-6. [DOI] [PubMed] [Google Scholar]
  • 3.Sanger F, Air GM, Barrell BG, Brown NL, Coulson AR, Fiddes JC, Hutchison CA, III, Slocombe PM, Smith M. Nucleotide sequence of bacteriophage φX174 DNA. Nature (London) 1997;265:687. doi: 10.1038/265687a0. [DOI] [PubMed] [Google Scholar]
  • 4.Park S, Kim J. Trends in next-generation sequencing and a new era for whole genome sequencing. Int. Neurourol. J. 2016;20:76. doi: 10.5213/inj.1632742.371. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5.Liao, X., Li, M., Zou, Y., Wu, F.-X., Yi-Pan, & Wang, J., Current challenges and solutions of de novo assembly. Quant. Biol.7, 90 (2019).
  • 6.Chaisson MJP, Wilson RK, Eichler EE. Genetic variation and the de novo assembly of human genomes. Nat. Rev. Genet. 2015;16:627. doi: 10.1038/nrg3933. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Wong, K., Levy-Sakin, M. & Kwok, P. De novo human genome assemblies reveal spectrum of alternative haplotypes in diverse populations. Nat. Commun.9, 3040 (2018). [DOI] [PMC free article] [PubMed]
  • 8.Lee H, Lee K-W, Lee T, Park D, Chung J, Lee C, Park W-Y, Son D-S. Performance evaluation method for read mapping tool in clinical panel sequencing. Genes Genom. 2018;40:189. doi: 10.1007/s13258-017-0621-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Yao R, Yu T, Qing Y, Wang J, Shen Y. Evaluation of copy number variant detection from panel-based next-generation sequencing data. Mol. Genet. Genom. Med. 2019;7:e00513. doi: 10.1002/mgg3.513. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Li Y, Xue D, Zhang B, Liu J. An optimized approach for local de novo assembly of overlapping paired-end RAD reads from multiple individuals. R. Soc. Open. Sci. 2018;5:171589. doi: 10.1098/rsos.171589. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Miller JR, Koren S, Sutton G. Assembly algorithms for next-generation sequencing data. Genomics. 2010;95:315. doi: 10.1016/j.ygeno.2010.03.001. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Myers EW. The fragment assembly string graph. Bioinformatics. 2005;21:ii79. doi: 10.1093/bioinformatics/bti1114. [DOI] [PubMed] [Google Scholar]
  • 13.Myers E, et al. A whole-genome assembly of Drosophila. Science. 2000;287:2196. doi: 10.1126/science.287.5461.2196. [DOI] [PubMed] [Google Scholar]
  • 14.Li H. Minimap and miniasm: Fast mapping and de novo assembly for noisy long sequences. Bioinformatics. 2016;32:2103. doi: 10.1093/bioinformatics/btw152. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Li Z, Chen Y, Mu D, Yuan J, Shi Y, Zhang H, Gan J, Li N, Hu X, Liu B, Yang B, Fan W. Comparison of the two major classes of assembly algorithms: Overlap-layout-consensus and de-Bruijn-graph. Brief. Func. Genom. 2012;11:25. doi: 10.1093/bfgp/elr035. [DOI] [PubMed] [Google Scholar]
  • 16.Koren S, Walenz B, Berlin K, Miller J, Bergman N, Phillippy A. Canu: scalable and accurate long-read assembly via adaptive k-mer weighting and repeat separation. Genome Res. 2017;27:722. doi: 10.1101/gr.215087.116. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17.Compeau PEC, Pevzner PA, Tesler G. How to apply de Bruijn graphs to genome assembly. Nat. Biotechnol. 2011;29:987. doi: 10.1038/nbt.2023. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18.Ladd TD, Jelezko F, Laflamme R, Nakamura Y, Monroe C, O’Brien JL. Quantum computers. Nature (London) 2010;464:45. doi: 10.1038/nature08812. [DOI] [PubMed] [Google Scholar]
  • 19.Harrow AW, Montanaro A. Quantum computational supremacy. Nature (London) 2017;549:203. doi: 10.1038/nature23458. [DOI] [PubMed] [Google Scholar]
  • 20.Lloyd S. Universal quantum simulators. Science. 1996;273:1073. doi: 10.1126/science.273.5278.1073. [DOI] [PubMed] [Google Scholar]
  • 21.Biamonte J, Wittek P, Pancotti N, Rebentrost P, Wiebe N, Lloyd S. Quantum machine learning. Nature (London) 2017;549:195. doi: 10.1038/nature23474. [DOI] [PubMed] [Google Scholar]
  • 22.Farhi, E. & Harrow, A. W. Quantum supremacy through the quantum approximate optimization algorithm. Preprint at arXiv:1602.07674.
  • 23.Emani, P. S. et al. Quantum computing at the frontiers of biological sciences. Preprint at arXiv:1911.07127. [DOI] [PMC free article] [PubMed]
  • 24.Grover, L. K. A fast quantum mechanical algorithm for database search. In Proceedings of 28th Annual ACM Symposium on the Theory of Computing (New York, USA, 1996) 212.
  • 25.Sarkar, A., Al-Ars, Z., Almudever, C. G. & Bertels, K. An algorithm for DNA read alignment on quantum accelerators. Preprint at arXiv:1909.05563.
  • 26.Prousalis K, Konofaos N. A quantum pattern recognition method for improving pairwise sequence alignment. Sci. Rep. 2019;9:7226. doi: 10.1038/s41598-019-43697-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Fedorov, A. K. & Gelfand, M. S. Towards practical applications in quantum computational biology. Nat. Comp. Sci.1, 114 (2021). [DOI] [PubMed]
  • 28.Lindvall, O. B. Quantum Methods for Sequence Alignment and Metagenomics, PhD thesis (2019).
  • 29.Boixo S, Albash T, Spedalieri EM, Chancellor N, Lidar DA. Experimental signature of programmable quantum annealing. Nat. Commun. 2013;4:3067. doi: 10.1038/ncomms3067. [DOI] [PubMed] [Google Scholar]
  • 30.Boixo S, Rønnow TF, Isakov SV, Wang Z, Wecker D, Lidar DA, Martinis JM, Troyer M. Evidence for quantum annealing with more than one hundred qubits. Nat. Phys. 2014;10:218. [Google Scholar]
  • 31.Rønnow TF, Wang Z, Job J, Boixo S, Isakov SV, Wecker D, Martinis JM, Lidar DA, Troyer M. Defining and detecting quantum speedup. Science. 2014;345:420. doi: 10.1126/science.1252319. [DOI] [PubMed] [Google Scholar]
  • 32.Zbinden S, Bärtschi A, Djidjev H, Eidenbenz S. Embedding algorithms for quantum annealers with chimera and pegasus connection topologies. LNCS. 2020;12151:187. [Google Scholar]
  • 33.Woo Shin, S., Smith, G., Smolin, J. A. & Vazirani, U. How ”quantum” is the D-Wave machine? Preprint at arXiv:abs/1401.7087.
  • 34.Katzgraber HG, Hamze F, Andrist RS. Glassy chimeras could be blind to quantum speedup: Designing better benchmarks for quantum annealing machines. Phys. Rev. X. 2015;4:021008. [Google Scholar]
  • 35.Venturelli D, Mandrà S, Knysh S, O’Gorman B, Biswas R, Smelyanskiy V. Quantum optimization of fully connected spin glasses. Phys. Rev. X. 2015;5:031040. [Google Scholar]
  • 36.Hen I, Job J, Albash T, Rønnow TF, Troyer M, Lidar DA. Probing for quantum speedup in spin-glass problems with planted solutions. Phys. Rev. A. 2015;92:042325. [Google Scholar]
  • 37.Amin MH. Searching for quantum speedup in quasistatic quantum annealers. Phys. Rev. A. 2015;92:052323. [Google Scholar]
  • 38.Tiunov ES, Ulanov AE, Lvovsky AI. Annealing by simulating the coherent Ising machine. Opt. Exp. 2019;27:10288. doi: 10.1364/OE.27.010288. [DOI] [PubMed] [Google Scholar]
  • 39.Kalinin KP, Berloff NG. Global optimization of spin Hamiltonians with gain-dissipative systems. Sci. Rep. 2018;8:17791. doi: 10.1038/s41598-018-35416-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40.Arrazola JM, Delgado A, Bardhan BR, Lloyd S. Quantum-inspired algorithms in practice. Quantum. 2020;4:307. [Google Scholar]
  • 41.RY Li, Di Felice R, Rohs R, Lidar DA. Quantum annealing versus classical machine learning applied to a simplified computational biology problem. npj Quantum Inf. 2018;4:14. doi: 10.1038/s41534-018-0060-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42.Perdomo-Ortiz A, Dickson N, Drew-Brook M, Rosem G, Aspuru-Guzik A. Finding low-energy conformations of lattice protein models by quantum annealing. Sci. Rep. 2012;2:571. doi: 10.1038/srep00571. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 43.Lucas A. Ising formulations of many NP problems. Front. Phys. 2014;2:5. [Google Scholar]
  • 44.http://glaros.dtc.umn.edu/gkhome/metis/metis/overview.
  • 45.Bernien H, Schwartz S, Keesling A, Levine H, Omran A, Pichler H, Choi S, Zibrov AS, Endres M, Greiner M, Vuletić V, Lukin MD. Probing many-body dynamics on a 51-atom quantum simulator. Nature (London) 2017;551:579. doi: 10.1038/nature24622. [DOI] [PubMed] [Google Scholar]
  • 46.Henriet L, Beguin L, Signoles A, Lahaye T, Browaeys A, Reymond G-O, Jurczak C. Quantum computing with neutral atoms. Quantum. 2020;4:327. [Google Scholar]
  • 47.Pichler H, Wang S-T, Zhou L, Choi S, Lukin MD. Quantum approximate optimization algorithm: Performance, mechanism, and implementation on near-term devices. Phys. Rev. X. 2020;10:021067. [Google Scholar]
  • 48.Zhang J, Pagano G, Hess PW, Kyprianidis A, Becker P, Kaplan H, Gorshkov AV, Gong Z-X, Monroe C. Observation of a many-body dynamical phase transition with a 53-qubit quantum simulator. Nature (London) 2017;551:601. doi: 10.1038/nature24654. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 49.Friis N, Marty O, Maier C, Hempel C, Holzäpfel M, Jurcevic P, Plenio MB, Huber M, Roos C, Blatt R, Lanyon B. Observation of entangled states of a fully controlled 20-qubit system. Phys. Rev. X. 2018;8:021012. [Google Scholar]
  • 50.Angly F, Willner D, Rohwer F, Hugenholtz P, Tyson G. Grinder: A versatile amplicon and shotgun sequence simulator. Nucleic Acids Res. 2012;20:e94. doi: 10.1093/nar/gks251. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 51.Li H. Minimap2: Pairwise alignment for nucleotide sequences. Bioinformatics. 2018;34:3094. doi: 10.1093/bioinformatics/bty191. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 52.Sarkar, A., Al-Ars, Z., & Bertels, K. QuASeR: Quantum accelerated de novo DNA sequence reconstruction. Preprint at arXiv:2004.05078. [DOI] [PMC free article] [PubMed]

Articles from Scientific Reports are provided here courtesy of Nature Publishing Group

RESOURCES