Skip to main content
Research logoLink to Research
. 2020 Mar 23;2020:1486935. doi: 10.34133/2020/1486935

A Full Quantum Eigensolver for Quantum Chemistry Simulations

Shijie Wei 1,2, Hang Li 2, GuiLu Long 1,2,3,4,
PMCID: PMC7125455  PMID: 32274468

Abstract

Quantum simulation of quantum chemistry is one of the most compelling applications of quantum computing. It is of particular importance in areas ranging from materials science, biochemistry, and condensed matter physics. Here, we propose a full quantum eigensolver (FQE) algorithm to calculate the molecular ground energies and electronic structures using quantum gradient descent. Compared to existing classical-quantum hybrid methods such as variational quantum eigensolver (VQE), our method removes the classical optimizer and performs all the calculations on a quantum computer with faster convergence. The gradient descent iteration depth has a favorable complexity that is logarithmically dependent on the system size and inverse of the precision. Moreover, the FQE can be further simplified by exploiting a perturbation theory for the calculations of intermediate matrix elements and obtaining results with a precision that satisfies the requirement of chemistry application. The full quantum eigensolver can be implemented on a near-term quantum computer. With the rapid development of quantum computing hardware, the FQE provides an efficient and powerful tool to solve quantum chemistry problems.

1. Introduction

Quantum chemistry studies chemical systems using quantum mechanics. One primary focus of quantum chemistry is the calculation of molecular energies and electronic structures of a chemical system which determine its chemical properties. Molecular energies and electronic structures are calculated by solving the Schrodinger equation within chemical precision. However, the computational resources needed scale exponentially with the system size on a classical computer, making the calculations in quantum chemistry intractable in high dimension.

Quantum computers, originally envisioned by Benioff, Manin, and Feynman [13], have emerged as promising tools for tackling this challenge with polynomial overhead of computational resources. Efficient quantum simulations of chemistry systems promise breakthroughs in our knowledge for basic chemistry and revolutionize research in new materials, pharmaceuticals, and industrial catalysts.

The universal quantum simulation method [4] and the first quantum algorithm for simulating fermions [5] have laid down the fundamental block of quantum chemistry simulation. Based on these techniques and quantum phase estimation algorithm [6], Aspuru-Guzik et al. presented a quantum algorithm for preparing ground states undergoing an adiabatic evolution [7], and many theoretical and experimental works [824] have been developed since then. In 2002, Somma et al. proposed a scalable quantum algorithm for the simulation of molecular electron dynamics via Jordan-Wigner transformation [25]. The Jordan-Wigner transformation directly maps the fermionic occupation state of a particular atomic orbital to a state of qubits, which enables the quantum simulation of chemical systems on a quantum computer. Then, the Bravyi-Kitaev transformation [2630] encodes both locality of occupation and parity information onto the qubits, which is more efficient in operation complexity. In 2014, Peruzzo et al. developed the variational quantum eigensolver (VQE) [18, 31], which finds a good variational approximation to the ground state of a given Hamiltonian for a particular choice of ansatz. Compared to quantum phase estimation and Trotterization of the molecular Hamiltonian, the VQE requires a lower number of controlled operations and shorter coherence time. However, the VQE is a classical and quantum hybrid algorithm; the optimizer is performed on a classical machine.

Meanwhile, implementations of quantum chemistry simulation have been developing steadily. Studies in present-day quantum computing hardware have been carried out, such as nuclear magnetic resonance system [32, 33], photonic system [3436], nitrogen-vacancy center system [37], trapped ion [38, 39], and superconducting system [4042]. Rapid development in quantum computer hardware with even the claims of quantum supremacy greatly stimulates the expectation of its real applications. Quantum chemistry simulation is considered a real application in Noisy Intermediate-Scale Quantum (NISQ) computers [22, 43, 44]. The FQE is an effort on this background. In the FQE, not only calculation of Hamiltonian matrix part is done on quantum computer, but also the optimization by gradient descent is performed on quantum computer. FQE can be used in near-term NISQ computers and in future fault-tolerant large quantum computers.

2. Method

2.1. Preparing the Hamiltonian for Quantum Chemistry Simulation

A molecular system contains a collection of nuclear charges Zi and electrons. The fundamental task of quantum chemistry is to solve the eigenvalue problem of the molecular Hamiltonian. The eigenstates of the many-body Hamiltonian determine the dynamics of the electrons as well as the properties of the molecule. The corresponding Hamiltonian of the system includes kinetic energies of nuclei and electrons and the Coulomb potentials of nuclei-electron, nuclei-nuclei, and electron-electron, and it can be expressed in first quantization as

Ho=iRi22Miiri22i,jZiRirj+i,j>iZiZjRiRj+i,j>i1rirj, (1)

in atomic units ( = 1), where Ri, Zi, Mi and ri are the positions, charges, and masses of the nuclei and the positions of the electrons, respectively. Under the Born-Oppenheimer approximation which assumes the nuclei as a fixed classical point, this Hamiltonian is usually rewritten in the particle number representation in a chosen basis:

H=ijhijaiaj+12ijklhijklaiajakal+, (2)

where ⋯ denotes higher-order interactions and ai and aj are the creation and annihilation operators of particle in orbital i and j, respectively. The parameters hij and hijkl are the one-body and two-body integrations in the chosen basis functions {ψi}. In Galerkin formulation, the scalar coefficients in Equation (2) can be calculated by

hij=ψii22AZAriRAψj,hijkl=ψiψj1rirjψkψl, (3)

In order to perform calculations on a quantum computer, we need to map fermionic operators to qubit operators. We choose the Jordan-Wigner transformation to achieve this task due to its straightforward expression.

The Jordan-Wigner transformation maps Equation (2) into a qubit Hamiltonian form:

H=i,αhαiσαi+i,j,α,βhαβijσαiσβj+, (4)

where Roman indices i and j denote the qubit on which the operator acts and Greek indices α and β refer to the type of Pauli operators; i.e., σxi means Pauli matrix σx acting on a qubit at site i. Apparently, H in Equation (2) is a linear combination of unitary Pauli matrices. The methods used in this paper finding the molecular ground state and its energy are all based on it.

In this work, we present the FQE to find the molecular ground-state energy by gradient descent iterations. Gradient descent is one of the most fundamental ways for optimization that looks for the target energy value along the direction of the steepest descent. Here, it is performed in a quantum computer with the help of linear combination of unitary operators. We analyze the relationships between the gradient descent iteration depth and the precision of the ground-state energy. The explicit quantum circuit to implement the algorithm is constructed. As illustrative examples, the ground-state energies and electronic structures of four molecules, H2, LiH, H2O, and NH3 are presented. Taking H2O and NH3 as examples, a comparison between the FQE and VQE, a representative hybrid method, is given. FQE can be accelerated further by harnessing a perturbation theory in chemical precision. Finally, we analyze the computation complexity of FQE and summarize the results.

2.2. Quantum Gradient Descent Iteration

The classical gradient descent algorithm is usually employed to obtain the minimum of an target function f(X). One starts from an initial point X(0) = (x10, x20, ⋯, xN0) ∈ ℝN, then moves to the next point along the direction of the gradient of the target function, namely,

Xt+1=Xtγ0fXt, (5)

where γ0 is a positive learning rate that determines the step size of the iteration. In searching the minimum energy of a Hamiltonian, the target function can be expressed as a quadratic optimization problem in the form f(X) = XTHX. At point X, the gradient operator of the objective function can be expressed as

fX=2HX. (6)

Then, the gradient descent iteration can be regarded as an evolution of X under operator H,

Xt+1=XtγHXt, (7)

where γ0 is redefined as γ = 2γ0. In the quantum gradient descent, vector X is replaced by quantum state |X〉 = ∑jxj|j〉/‖X‖, where xj is the jth elements of the vector, |j〉 is the N-dimensional computational basis, and ‖X‖ is the modulus of vector X. Denote Hg = Iγ H and it can be expressed as

Hg=i=1MβiHig, (8)

where M is the number of Pauli product terms in Hg. Then, the gradient descent process can be rewritten as

Xt+1=HgXt=i=1MβiHigXt, (9)

where Hg is a linear combination of unitary operators (LCU) which was proposed in [45] in designing quantum algorithms and studied extensively [4652]. This nonunitary evolution can be implemented in a unitary quantum circuit by adding ancillary qubits that transform it into unitary evolution in a larger space [53]. The realization of LCU can be viewed as a quantum computer wave function passing through M-slits and operated by a unitary operation in each slit, and then, the wave functions are combined and the result of the calculation is read out by a measurement [49]. As shown in Figure 1, we perform the evolution described by Equation (9) with the following four steps.

Figure 1.

Figure 1

Quantum circuit for gradient descent. |x〉 and |ψs〉 denote the initial state of the work system and ancilla syetem, respectively. The controlled operations that acted on the work system are ∑i=0M−1|i〉〈i| ⊗ Hig. HM denotes m = log2M number Hadamard gates. At the end of the circuit, we measure the final state of the ancilla registers. If all ancilla qubits are |0〉, the work systerm collapses into state |x(t + 1)〉.

Wave division: the register is a composite system which contains a work system and an ancillary register. Firstly, the initial point X = (x1, ⋯,xN)T is efficiently mapped as an initial state |X(t)〉 of the work system. In quantum chemistry, Hartree-Fock (HF) product state is usually used as an initial state. And the ancillary register is initialized from |0〉m, where m = log2M, to a specific superposition state |ψs〉,

ψs=1i=0M1βii, (10)

where =i=0M1βi2 is a normalization constant and |i〉 is the computational basis. This is equivalent to let the state |x(t)〉 pass through M-slits. βi is a factor describing the properties of the slit, which is determined by the forms of the Hamiltonian in Equation (8). This can be done by the initialization algorithm in [54]. Moreover, the quantum random access memory (qRAM) approach can be used to prepare |x(t)〉 and |ψs〉, which consume O(logN) and O(logM) basic steps or gates, respectively, after qRAM cell is established. We denote the whole state of the composite system as |Φ〉 = |ψs〉|x(t)〉.

Entanglement: then, a series of ancillary system-controlled operations ∑i=0M−1|i〉〈i| ⊗ Hig are implemented on the work qubits. The work qubits and the ancilla register are now entangled, and the state is transformed into

Φ1i=0M1βiiHigxt. (11)

The corresponding physical picture is that different unitary operations are implemented simultaneously in different subspaces, corresponding to different slits.

Wave combination: we perform m Hadamad gates on ancillary register to combine all the wave functions from the M different subspaces. We merely focus on the component in a subspace where the ancillary system is in state |0〉. The state of the whole system in this subspace is

Φ012m0i=0M1βiHigxt. (12)

Measurement: then, we measure the ancillary register. If we obtain |0〉, our algorithm succeeds and we obtain the state 1/2m0i=0M1βiHigxt, where the work system is in |x(t + 1)〉 = Hg|x(t)〉. And then, this will be used as input for the next iteration in the quantum gradient descent process. The probability of obtaining |0〉 for the state is

Ps=Hgxt2/2M. (13)

The successful probability after n measurements is 1 − (1 − ‖Hg|x(t)〉‖2/2M)n, which is an exponential function of n. The number of measurements is 2M/‖Hg|x(t)〉‖2. The measurement complexity will grow exponentially with respect to the number of iteration steps [55]. Alternatively, one can use the oblivious amplitude amplification [51] to amplify the amplitude of the desired term (ancillary qubits in state |0〉) up to a deterministic order with OM repetitions before the measurement. Then, the measurement complexity will be the product of iteration depth k and OM, linearly dependent on the number of iteration steps. After obtaining |0〉, we can continue the gradient descent process by repeating the above four steps, with |x(t)〉 replaced by |x(t + 1)〉 in a wave-division step. We can preset a threshold defined as ε = |〈xt | H | xt〉 − 〈xt+1 | H | xt+1〉|/〈xt | H | xt〉 as criterion for stopping the iteration. Thus, we judge if the iterated state satisfies the criterion by measuring the expectation value of Hamiltonian around the expected number of iteration, which is easier than constructing the tomography. If the next iterative state |x(t + 1)〉 does not hit our preset threshold, this output |x(t + 1)〉 will be regarded as the new input state |x(t)〉 and run the next iteration. Otherwise, the iteration can be terminated and the state |x(t + 1)〉 is the final result |xf〉, as one good approximation of the ground state. The ground-state energy can be calculated by 〈xf | H | xf〉.

Measuring the expectation values during the iteration procedure will destroy the state of the work system, stopping the quantum gradient descent process. So, determining the iteration depth k in advance is essential. After k times iterations, the approximation error is limited to (ignoring constants)

εO1γλ21γλ1kN, (14)

where λ1 and λ2 are the two largest absolute values of the eigenvalues of Hamiltonian H (see Supplemental Material () for proof). The iteration depth

k=OlogNε (15)

is logarithmically dependent on the system size and the inverse of precision. The algorithm may be terminated at a point with a preset precision ε. It can be seen that the choise of γ has little impact on converge rate when γ is large. This makes this algorithm very robust to this parameter. The rate of convergence primarily depends upon the ratio of λ1 and λ2. The gap between the iterative result and the ground state depends on the choice of initial point. If we choose an ansatz state with a large overlap with the exact ground state, the iterative process will converge to the ground state in fewer iterations. Usually, the mean-field state which represents a good classical approximation to the ground state of Hamiltonian H, such as a Hartree-Fock (HF) product state, is chosen as an initial state. Compared to the VQE, the FQE does not need to make measurements of the expectation values of Hamiltonian during each iteration procedure and this substantially reduces the computation resources.

2.3. Perturbation Theory

The FQE involves multitime iterations to obtain an accurate result, which is difficult to implement in the present-day quantum computer hardware. Here, we present an approximate method to find the ground state and its energy by using the gradient descent algorithm and perturbation theory. The perturbation theory is widely used and plays an important role in describing real quantum systems, because it is impossible to find exact solutions to the Schrodinger equation for Hamiltonians even with moderate complexity. The Hamiltonian described by Equation (4) can be divided into two classes, H0 and H′. H0 consists of a set of Pauli terms containing only σα=zi and the identity matrices, and Pauli terms σα=x,yi belong to H′. H0 is a diagonal matrix with exact solutions that can be regarded as a simple system. H′ usually is smaller compared to H0 and is treated as a “perturbing” Hamiltonian. The energy levels and eigenstates associated with the perturbed system can be expressed as “corrections” to those of the unperturbed system. We begin with the time-independent Schrodinger equation:

Hψn=H0+Hψn=Enψn, (16)

where En and |ψn〉 are the nth energy and eigenstate, respectively. Unperturbed Hamiltonian H0 satisfies the time-independent Schrodinger equation: H0|n〉 = En(0)|n〉. Our goal is to express En and |ψn〉 in terms of En0 and |n〉. Denote the expectation value of H′ as Hnn = 〈n | H′ | n〉, and it is easy to see that 〈n | H′ | n〉 is zero because H′ only contains Pauli terms σα=x,yi. In the first-order approximation, the energies and eigenstates are expressed as

En=En0,ψn=nmnHmnEm0En0m. (17)

In the second-order approximation, they are

En=En0+mnHmn2Em0En0,ψn=nmnHmnEm0En0m12mnHmn2Em0En02n,+mnknHmnHknEm0En0Ek0En0m. (18)

The matrix elements in the first- and second-order approximations can be obtained by one iteration of the quantum circuit in Figure 1. Here, we let H′ be equal to Hg. Explicitly, the first-order approximation only involves Hmn, a series of transition probabilities of the state after H′ implemented on state |ni, and they can be obtained by performing the quantum circuit of Figure 1 directly. For the second-order approximation, matrix elements such as value |Hmn|2 and HmnHkn can be calculated by Hmn. Then, the approximate ground energy and ground state up to the second order are obtained. We will show the performance of the FQE and perturbation theory in the next section.

3. Results

3.1. Calculations of Four Molecules

To demonstrate the feasibility of this FQE with gradient descent iteration, we carried out calculations on the ground-state energy of H2, LiH diatomic molecules, and two relatively complex molecules H2O and NH3. We used a common molecular basis set, the minimal STO-3G basis. Via the Jordan-Wigner transformation, the qubit Hamiltonians of these molecules are obtained. The Hamiltonians of H2, LiH, H2O, and NH3 contain 15, 118, 252, and 3382 Pauli matrix product terms, respectively. The dimensions of the Hamiltonians of H2, LiH, H2O, and NH3 are 16, 64, 4096, and 16384, respectively, which correspond to 4, 6, 12, and 14 numbers of qubits, respectively. In all four simulations, the work system was initialized to the HF state |xh〉 and the learning rate is chosen as γ = 1. As shown in Figure 2, after about 120 iterations, the molecular energy of H2O converges to -74.94 a.u., only 0.0013346% discrepancy with respect to the exact value of -74.93 a.u. obtained via Hamiltonian diagonalization. The NH3 calculation yields (-55.525 a.u.) after 80 iterations matched very well with the diagonalization (-55.526 a.u.). For the study of atomic molecular structures and chemical reactions, these results are sufficiently accurate. For more complex basis set STO-6G, the results are about the same (see Figure 3), and the details are given in Supplemental Material. The converge rates of the four molecules depend on the system size and the ratio of the two largest absolute eigenvalues of the Hamiltonian H, which are consistent with the theoretical analysis above.

Figure 2.

Figure 2

(a), (b), (c), and (d) show the convergence to ground-state energies by the FQE for H2, LiH, H2O, and NH3 molecules, respectively. The numerical simulations are carried out with fixed interatomic distance. The exact value corresponding to Hamiltonian diagonalization energy (red line). The initial state is chosen as the Hartree-Fock product state in all four cases. The final values of the lines for exact ground-state energy (red line) and for the three iteration results, noiseless case (blue line), random noisy case (green line), and Gaussian noisy case (orange line).

Figure 3.

Figure 3

(a), (b), (c), and (d) show the gradient descent iteration process for convergence of ground-state energy of H2, LiH, H2O, and NH3, respectively. The qubit Hamiltonians of the four molecules are obtained by STO-6G basis, which is more accurate than STO-3G basis.

We also studied the influence of noises which is also shown in Figure 2. The noise term is chosen in the form of ∑i=1Nδαiσz added to the Hamiltonian to simulate decoherence. Then, we add a term δx on the iterative state |xk〉 to simulate measurement error and renormalize the iterative state as xkxk+δx/xk+δx. We set a random noise (amplitude 0.01) and a Gaussian noise (μ = 0, σ = 0.01/3) for H2 and LiH. For H2O and NH3, we choose a random noise (amplitude 0.02) and a Gaussian noise (μ = 0, σ = 0.02/3). The results still converge to the exact values in chemical precision (1.6 × 10 − 3 a.u). This indicates that our method is robust to a certain type of noise, which is important in the implementation of quantum simulation on near-term quantum devices. For more noisy situations, see Supplemental Material for details, where the parameters of noise are 10 times the above values (see Figure 4). The convergence deteriorates and some oscillations occur as the number of iterations increases.

Figure 4.

Figure 4

Influence of large noise on the FQE in (a) H2, (b) LiH, (c) H2O, and (d) NH3 molecules, respectively. The amplitude of the random noise is 0.1, and the Gaussian noise parameters are μ = 0 and σ = 0.1/3.

In Figure 5, a comparison with the VQE is shown for H2O and NH3. In VQE calculation, the initial state |x0〉 is mapped to an ansatz state by a parameterized unitary operation xθ=Uθx0. The VQE solves for the parameter vector θ with a classical optimization routine. Here, we adopt the standard gradient descent method as the classical optimizer in the VQE. The parameter is updated by θθγfθ+Δθfθ/Δθ. We performed numerical simulations of the VQE for the two molecules. When the learning rate γ ≥ 10−3, the VQE does not converge to the ground state. So, in order to compare with each other, we choose the proper learning rates in two methods separately. In both cases, the initial ansatz state is prepared as the HF product state. In H2O and NH3, the VQE converges the fastest with the learning rate γ = 10−3. The FQE converges faster with larger and larger learning rate until a fixed speed is reached. As shown in Figure 5, the FQE generally converges faster than the VQE and the advantage will be more obvious in complex molecules.

Figure 5.

Figure 5

The exact comparison of the FQE and VQE for searching ground-state energy of H2O and NH3 molecules, respectively. The red color lines labeled as “Theory value” are the exact values of ground-state energy. The labels of the right symbols denote different learning rates.

The above examples are calculated in fixed interatomic distance of the molecules. If we want to calculate the interatomic distance corresponding to the most stable structure, the variation of interatomic distances is necessary. In Figure 6, four examples are given to illustrate the performance of the perturbation theory. To obtain the potential-energy surfaces for H2, LiH, H2O, and NH3 molecules, we studied the dependence of ground-state energy of their molecules on the variating interatomic distances, between the two atoms in H2 and LiH, the distance between the oxygen atom and one hydrogen atom (the two hydrogen atoms are symmetric with respect to the oxygen atom) in H2O, and the distance between the nitrogen atom and the plane formed by the three hydrogen atoms in NH3. The lowest energy in potential-energy surfaces corresponds to the most stable structure of the molecules. As shown in the picture, the ground-state energy of each molecule calculated under the second-order approximation is already quite close to its exact value, which is obtained from Hamiltonian diagonalizations. The energy values up to the second-order correction are compared with their exact values at the most stable interatomic distance corresponding to the lowest energy in Table 1. It can be seen that the second-order approximation has already given results in chemical precision.

Figure 6.

Figure 6

Theory results (blue lines) and zero-order (orange lines), first-order (green lines), and second-order (red lines) energy plots of outcomes from numerical simulations, for several interatomic distances for H2, LiH, H2O (between the oxygen atom and one hydrogen atom), and NH3 (between the nitrogen atom and the plane formed by the three hydrogen atoms).

Table 1.

Energy values calculated by a perturbation method and the exact values in the most stable distance corresponding to the lowest ground energy.

Energy value (au) Exact value Zero-order value First-order value Second-order value
Distance (Å)
H2 (0.7314) -1.1373 -1.1171 -1.1372 -1.1372
LiH (1.5065) -7.8637 -7.8634 -7.8637 -7.8637
H2O (1.0812) -75.0038 -74.9622 75.0013 75.0032
NH3 (0.4033) -55.5247 -55.4530 -55.5193 -55.5237

3.2. Analysis of Computational Complexity

Here, we analyze the complexity of our algorithm. Usually, a quantum algorithm complexity involves two aspects: qubit resources and gate complexity. For qubit resources, the number of ancilla qubits is logM, where M is the number of Pauli terms in qubit from the Hamiltonian. For gate complexity, the “Wave division” part needs 𝒪(logN + logM) basic steps for state preparation. The dominant factor is the number of controlled operations in the “Entanglement” part in Figure 1. Controlled Hig can be decomposed into 𝒪(MlogMlogN) basic gates [56, 57]. The “Wave combination” part just comprises logM Hadamard gates. Totally, the FQE requires in each iteration about 𝒪(MlogMlogN) basic gates for implementation. If the wave function is expressed by O(N) Gaussian orbitals, fermion Hamiltonians contain O(N4) second-quantized terms; consequently, the qubit Hamiltonians have M = O(N4) Pauli terms. The qubit resource and gate complexity can be reduced to O(N) and O(N4), respectively. In some applications, the perturbation theory only requires one iteration, and an approximate result in chemical precision can be obtained.

4. Summary

An efficient quantum algorithm, full quantum eigensolver (FQE), for calculating the ground-state wave function and the ground energy using gradient descent (FQE) was proposed, and numerical simulations are performed for four molecules. In the FQE, the complexity of basic gate operations is polylogarithmical to the number of single-electron atomic orbitals. It achieves an exponential speedup compared with its classical counterparts. It has been shown that the FQE is robust against noises of reasonable strengths. For very noisy situations that do not allow many iterations, the FQE can be combined with the perturbation theory that gives the ground state and its energy in chemical precision with one-time iteration. The FQE is exceptionally useful in quantum chemistry simulation, especially for the near-term NISQ applications. The FQE is a full quantum algorithm, not only applicable for NISQ computers but also directly applicable for future large-scale fault-tolerant quantum computers.

Acknowledgments

This research was supported by the National Basic Research Program of China. We gratefully acknowledges support from the National Natural Science Foundation of China under Grant No. 11974205 and No. 11774197, the National Key Research and Development Program of China (2017YFA0303700), the Key Research and Development Program of Guangdong Province (2018B030325002); and Beijing Advanced Innovation Center for Future Chip (ICFC).

Data Availability

The data that support the findings of this study are available from the corresponding authors on reasonable request.

Conflicts of Interest

The authors declare no competing interests.

Authors' Contributions

S.J.W. conceived the algorithm. H.L. performed classical simulations. G.L.L. initialized LCU scheme. All authors contributed to the discussion of results and writing of the manuscript.

Supplementary Materials

Supplementary Materials

Section A: error estimation and iteration complexity of FQE. Section B: FQE with STO-6G basis as input. Section C: performance of FQE with large noise. Figure S1: the gradient descent iteration process for convergence of ground-state energy of H2, LiH, H2O, and NH3, respectively, with STO-6G basis. Figure S2: influence of large noise on FQE in H2, LiH, H2O, and NH3 molecules, respectively [58].

References

  • 1.Benioff P. The computer as a physical system: a microscopic quantum mechanical Hamiltonian model of computers as represented by Turing machines. Journal of Statistical Physics. 1980;22(5):563–591. doi: 10.1007/BF01011339. [DOI] [Google Scholar]
  • 2.Manin I. Vychislimoe i nevychislimoe. Sov. Radio; 1980. [Google Scholar]
  • 3.Feynman R. P. Simulating physics with computers. International Journal of Theoretical Physics. 1982;21(6-7):467–488. doi: 10.1007/BF02650179. [DOI] [Google Scholar]
  • 4.Lloyd S. Universal quantum simulators. Science. 1996;273(5278):1073–1078. doi: 10.1126/science.273.5278.1073. [DOI] [PubMed] [Google Scholar]
  • 5.Abrams D. S., Lloyd S. Simulation of many-body Fermi systems on a universal quantum computer. Physical Review Letters. 1997;79(13):2586–2589. doi: 10.1103/PhysRevLett.79.2586. [DOI] [Google Scholar]
  • 6.Kitaev A. Y. Quantum measurements and the abelian stabilizer problem. 1995. http://arxiv.org/abs/9511026.
  • 7.Aspuru-Guzik A., Dutoi A. D., Love P. J., Head-Gordon M. Simulated quantum computation of molecular energies. Science. 2005;309(5741):1704–1707. doi: 10.1126/science.1113479. [DOI] [PubMed] [Google Scholar]
  • 8.Babbush R., Love P. J., Aspuru-Guzik A. Adiabatic quantum simulation of quantum chemistry. Scientific Reports. 2015;4(1, article 6603) doi: 10.1038/srep06603. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Feng G.-R., Lu Y., Hao L., Zhang F.-H., Long G. L. Experimental simulation of quantum tunneling in small systems. Scientific Reports. 2013;3(1, article 2232) doi: 10.1038/srep02232. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Lu Y., Feng G.-R., Li Y.-S., Long G.-L. Experimental digital quantum simulation of temporal-spatial dynamics of interacting fermion system. Science Bulletin. 2015;60(2):241–248. doi: 10.1007/s11434-014-0712-9. [DOI] [Google Scholar]
  • 11.Babbush R., McClean J., Wecker D., Aspuru-Guzik A., Wiebe N. Chemical basis of Trotter-Suzuki errors in quantum chemistry simulation. Physical Review A. 2015;91(2, article 022311) doi: 10.1103/PhysRevA.91.022311. [DOI] [Google Scholar]
  • 12.Wei S.-J., Ruan D., Long G.-L. Duality quantum algorithm efficiently simulates open quantum systems. Scientific Reports. 2016;6(1, article 30727) doi: 10.1038/srep30727. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Babbush R., Berry D. W., Kivlichan I. D., Wei A. Y., Love P. J., Aspuru-Guzik A. Exponentially more precise quantum simulation of fermions in second quantization. New Journal of Physics. 2016;18(3, article 033032) doi: 10.1088/1367-2630/18/3/033032. [DOI] [Google Scholar]
  • 14.Babbush R., Berry D. W., Sanders Y. R., et al. Exponentially more precise quantum simulation of fermions in the configuration interaction representation. Quantum Science and Technology. 2018;3(1, article 015006) doi: 10.1088/2058-9565/aa9463. [DOI] [Google Scholar]
  • 15.Kassal I., Jordan S. P., Love P. J., Mohseni M., Aspuru-Guzik A. Polynomial-time quantum algorithm for the simulation of chemical dynamics. Proceedings of the National Academy of Sciences of the United States of America. 2008;105(48):18681–18686. doi: 10.1073/pnas.0808245105. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Kivlichan I. D., Wiebe N., Babbush R., Aspuru-Guzik A. Bounding the costs of quantum simulation of many-body physics in real space. Journal of Physics A: Mathematical and Theoretical. 2017;50(30):p. 305301. doi: 10.1088/1751-8121/aa77b8. [DOI] [Google Scholar]
  • 17.Toloui B., Love P. J. Quantum algorithms for quantum chemistry based on the sparsity of the CI-matrix. 2013. http://arxiv.org/abs/1312.2579.
  • 18.Peruzzo A., McClean J., Shadbolt P., et al. A variational eigenvalue solver on a photonic quantum processor. Nature Communications. 2014;5(1, article 4213) doi: 10.1038/ncomms5213. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.McClean J. R., Romero J., Babbush R., Aspuru-Guzik A. The theory of variational hybrid quantum-classical algorithms. New Journal of Physics. 2016;18(2, article 023023) doi: 10.1088/1367-2630/18/2/023023. [DOI] [Google Scholar]
  • 20.McClean J. R., Babbush R., Love P. J., Aspuru-Guzik A. Exploiting locality in quantum computation for quantum chemistry. The Journal of Physical Chemistry Letters. 2014;5(24):4368–4380. doi: 10.1021/jz501649m. [DOI] [PubMed] [Google Scholar]
  • 21.Whitfield J. D., Biamonte J., Aspuru-Guzik A. Simulation of electronic structure hamiltonians using quantum computers. Molecular Physics. 2011;109(5):735–750. doi: 10.1080/00268976.2011.552441. [DOI] [Google Scholar]
  • 22.Wecker D., Hastings M. B., Troyer M. Progress towards practical quantum variational algorithms. Physical Review A. 2015;92(4, article 042303) doi: 10.1103/PhysRevA.92.042303. [DOI] [Google Scholar]
  • 23.Hastings M. B., Wecker D., Bauer B., Troyer M. Improving quantum algorithms for quantum chemistry. Quantum Information & Computation. 2015;15(1-2):1–21. [Google Scholar]
  • 24.Kyriienko O. Quantum inverse iteration algorithm for near-term quantum devices. 2019. http://arxiv.org/abs/1901.09988.
  • 25.Jordan P., Wigner E. Über das Paulische Äquivalenzverbot. Zeitschrift für Physik. 1928;47(9-10):631–651. doi: 10.1007/BF01331938. [DOI] [Google Scholar]
  • 26.Bravyi S. B., Kitaev A. Y. Fermionic quantum computation. Annals of Physics. 2002;298(1):210–226. doi: 10.1006/aphy.2002.6254. [DOI] [Google Scholar]
  • 27.Seeley J. T., Richard M. J., Love P. J. The Bravyi-Kitaev transformation for quantum computation of electronic structure. The Journal of Chemical Physics. 2012;137(22):p. 224109. doi: 10.1063/1.4768229. [DOI] [PubMed] [Google Scholar]
  • 28.Tranter A., Sofia S., Seeley J., et al. The Bravyi-Kitaev transformation: properties and applications. International Journal of Quantum Chemistry. 2015;115(19):1431–1441. doi: 10.1002/qua.24969. [DOI] [Google Scholar]
  • 29.Bravyi S., Gambetta J. M., Mezzacapo A., Temme K. Tapering off qubits to simulate fermionic Hamiltonians. 2017. http://arxiv.org/abs/1701.08213.
  • 30.Babbush R., Wiebe N., McClean J., McClain J., Neven H., Chan G. K.-L. Low-depth quantum simulation of materials. Physical Review X. 2018;8(1, article 011044) doi: 10.1103/PhysRevX.8.011044. [DOI] [Google Scholar]
  • 31.Yung M.-H., Casanova J., Mezzacapo A., et al. From transistor to trapped-ion computers for quantum chemistry. Scientific Reports. 2015;4(1, article 3589) doi: 10.1038/srep03589. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32.Du J., Xu N., Peng X., Wang P., Wu S., Lu D. Nmr implementation of a molecular hydrogen quantum simulation with adiabatic state preparation. Physical Review Letters. 2010;104(3, article 030502) doi: 10.1103/PhysRevLett.104.030502. [DOI] [PubMed] [Google Scholar]
  • 33.Li Z., Liu X., Wang H., et al. Quantum simulation of resonant transitions for solving the eigenproblem of an effective water Hamiltonian. Physical Review Letters. 2019;122(9, article 090504) doi: 10.1103/PhysRevLett.122.090504. [DOI] [PubMed] [Google Scholar]
  • 34.Roushan P., Neill C., Megrant A., et al. Chiral ground-state currents of interacting photons in a synthetic magnetic field. Nature Physics. 2017;13(2):146–151. doi: 10.1038/nphys3930. [DOI] [Google Scholar]
  • 35.Lanyon B. P., Whitfield J. D., Gillett G. G., et al. Towards quantum chemistry on a quantum computer. Nature Chemistry. 2010;2(2):106–111. doi: 10.1038/nchem.483. [DOI] [PubMed] [Google Scholar]
  • 36.Paesani S., Gentile A. A., Santagati R., et al. Experimental Bayesian quantum phase estimation on a silicon photonic chip. Physical Review Letters. 2017;118(10, article 100503) doi: 10.1103/PhysRevLett.118.100503. [DOI] [PubMed] [Google Scholar]
  • 37.Wang Y., Dolde F., Biamonte J., et al. Quantum simulation of helium hydride cation in a solid-state spin register. ACS Nano. 2015;9(8):7769–7774. doi: 10.1021/acsnano.5b01651. [DOI] [PubMed] [Google Scholar]
  • 38.Shen Y., Zhang X., Zhang S., Zhang J.-N., Yung M.-H., Kim K. Quantum implementation of the unitary coupled cluster for simulating molecular electronic structure. Physical Review A. 2017;95(2, article 020501) doi: 10.1103/PhysRevA.95.020501. [DOI] [Google Scholar]
  • 39.Hempel C., Maier C., Romero J., et al. Quantum chemistry calculations on a trapped-ion quantum simulator. Physical Review X. 2018;8(3, article 031022) doi: 10.1103/PhysRevX.8.031022. [DOI] [Google Scholar]
  • 40.O’Malley P. J. J., Babbush R., Kivlichan I. D., et al. Scalable quantum simulation of molecular energies. Physical Review X. 2016;6(3, article 031007) doi: 10.1103/PhysRevX.6.031007. [DOI] [Google Scholar]
  • 41.Kandala A., Mezzacapo A., Temme K., et al. Hardware-efficient variational quantum eigensolver for small molecules and quantum magnets. Nature. 2017;549(7671):242–246. doi: 10.1038/nature23879. [DOI] [PubMed] [Google Scholar]
  • 42.Ganzhorn M., Egger D. J., Barkoutsos P., et al. Gate-efficient simulation of molecular eigenstates on a quantum computer. Physical Review Applied. 2019;11(4, article 044092) doi: 10.1103/PhysRevApplied.11.044092. [DOI] [Google Scholar]
  • 43.Mohseni M., Read P., Neven H., et al. Commercialize quantum technologies in five years. Nature. 2017;543(7644):171–174. doi: 10.1038/543171a. [DOI] [PubMed] [Google Scholar]
  • 44.Mueck L. Quantum reform. Nature Chemistry. 2015;7(5):361–363. doi: 10.1038/nchem.2248. [DOI] [PubMed] [Google Scholar]
  • 45.Gui-Lu L. General quantum interference principle and duality computer. Communications in Theoretical Physics. 2006;45(5):825–844. doi: 10.1088/0253-6102/45/5/013. [DOI] [Google Scholar]
  • 46.Gudder S. Mathematical theory of duality quantum computers. Quantum Information Processing. 2007;6(1):37–48. doi: 10.1007/s11128-006-0040-3. [DOI] [Google Scholar]
  • 47.Gui-Lu L., Yang L. Duality computing in quantum computers. Communications in Theoretical Physics. 2008;50(6):1303–1306. doi: 10.1088/0253-6102/50/6/11. [DOI] [Google Scholar]
  • 48.Gui-Lu L., Yang L., Chuan W. Allowable generalized quantum gates. Communications in Theoretical Physics. 2009;51(1):65–67. doi: 10.1088/0253-6102/51/1/13. [DOI] [Google Scholar]
  • 49.Long G. L. Duality quantum computing and duality quantum information processing. International Journal of Theoretical Physics. 2011;50(4):1305–1318. doi: 10.1007/s10773-010-0603-z. [DOI] [Google Scholar]
  • 50.Childs A. M., Wiebe N. Hamiltonian simulation using linear combinations of unitary operations. 2012. http://arxiv.org/abs/1202.5822.
  • 51.Berry D. W., Childs A. M., Cleve R., Kothari R., Somma R. D. Simulating Hamiltonian dynamics with a truncated Taylor series. Physical Review Letters. 2015;114(9, article 090502) doi: 10.1103/PhysRevLett.114.090502. [DOI] [PubMed] [Google Scholar]
  • 52.Wei S.-J., Long G.-L. Duality quantum computer and the efficient quantum simulations. Quantum Information Processing. 2016;15(3):1189–1212. doi: 10.1007/s11128-016-1263-6. [DOI] [Google Scholar]
  • 53.Cao H. X., Li L., Chen Z. L., Zhang Y., Guo Z. H. Restricted allowable generalized quantum gates. Chinese Science Bulletin. 2010;55(20):2122–2125. doi: 10.1007/s11434-010-3221-5. [DOI] [Google Scholar]
  • 54.Long G.-L., Sun Y. Efficient scheme for initializing a quantum register with an arbitrary superposed state. Physical Review A. 2001;64(1, article 014303) doi: 10.1103/PhysRevA.64.014303. [DOI] [Google Scholar]
  • 55.Rebentrost P., Schuld M., Wossnig L., Petruccione F., Lloyd S. Quantum gradient descent and Newton’s method for constrained polynomial optimization. New Journal of Physics. 2019;21(7, article 073023) doi: 10.1088/1367-2630/ab2a9e. [DOI] [Google Scholar]
  • 56.Xin T., Wei S.-J., Pedernales J. S., Solano E., Long G.-L. Quantum simulation of quantum channels in nuclear magnetic resonance. Physical Review A. 2017;96(6, article 062303) doi: 10.1103/PhysRevA.96.062303. [DOI] [Google Scholar]
  • 57.Wei S.-J., Xin T., Long G.-L. Efficient universal quantum channel simulation in ibm’s cloud quantum computer. Science China Physics, Mechanics & Astronomy. 2018;61(7, article 70311) doi: 10.1007/s11433-017-9181-9. [DOI] [Google Scholar]
  • 58.Panju M. Iterative methods for computing eigenvalues and eigenvectors. 2011. http://arxiv.org/abs/1105.1185.

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

Supplementary Materials

Section A: error estimation and iteration complexity of FQE. Section B: FQE with STO-6G basis as input. Section C: performance of FQE with large noise. Figure S1: the gradient descent iteration process for convergence of ground-state energy of H2, LiH, H2O, and NH3, respectively, with STO-6G basis. Figure S2: influence of large noise on FQE in H2, LiH, H2O, and NH3 molecules, respectively [58].

Data Availability Statement

The data that support the findings of this study are available from the corresponding authors on reasonable request.


Articles from Research are provided here courtesy of American Association for the Advancement of Science (AAAS) and Science and Technology Review Publishing House

RESOURCES