Yi Fan received his B.S. degree in Chemistry from the University of Science and Technology of China (USTC) in 2017 and is currently a Ph.D. candidate at USTC. His research interests include quantum chemistry methods and quantum computing algorithms for solid materials
Zhenyu Li is a Professor of chemistry at the University of Science and Technology of China (USTC). He received his Ph.D. degree in Physical Chemistry from USTC in 2004. Since then, he worked as a postdoctoral researcher at the University of Maryland, College Park, and the University of California, Irvine. In 2007, he joined USTC as a faculty member. His research interests focus on using or developing electronic structure and molecular simulation methods to study chemical systems
Quantum computers provide new opportunities for quantum chemistry. In this article,we present a versatile, extensible, and efficient software package, named Q2Chemistry, for developing quantum algorithms and quantum inspired classical algorithms in the field of quantum chemistry. In Q2Chemistry, the wave function and Hamiltonian can be conveniently mapped into the qubit space, then quantum circuits can be generated corresponding to a specific quantum algorithm already implemented in the package or newly developed by the users. The generated circuits can be dispatched to either a physical quantum computer, if available, or to the internal virtual quantum computer realized by simulating quantum circuits on classical computers. As demonstrated by our benchmark simulations, Q2Chemistry achieves excellent performance in simulating medium scale quantum circuits using the matrix product state algorithm. Applications of Q2Chemistry to simulate molecules and periodic systems are given with performance analysis.
Graphical Abstract
The main framework of our newly developed quantum computation software package.
Abstract
Quantum computers provide new opportunities for quantum chemistry. In this article,we present a versatile, extensible, and efficient software package, named Q2Chemistry, for developing quantum algorithms and quantum inspired classical algorithms in the field of quantum chemistry. In Q2Chemistry, the wave function and Hamiltonian can be conveniently mapped into the qubit space, then quantum circuits can be generated corresponding to a specific quantum algorithm already implemented in the package or newly developed by the users. The generated circuits can be dispatched to either a physical quantum computer, if available, or to the internal virtual quantum computer realized by simulating quantum circuits on classical computers. As demonstrated by our benchmark simulations, Q2Chemistry achieves excellent performance in simulating medium scale quantum circuits using the matrix product state algorithm. Applications of Q2Chemistry to simulate molecules and periodic systems are given with performance analysis.
Public Summary
We developed a quantum computation platform for quantum chemistry applications.
A modular structure was implemented with a mixed-language programming model for easy extension and high performance.
Excellent performance is achieved as demonstrated by simulating medium-scale quantum circuits up to 72 qubits.
As the application of accurate classical methods is severely limited by the fast growing computational cost, quantum computation provides a promising pathway to solve quantum chemistry problems[1-3]. By encoding wave functions into the Hilbert space of qubits, the Schrödinger equation for molecular systems can be solved on a quantum computer. In recent years, various quantum algorithms, such as quantum phase estimation (QPE) and variational quantum eigensolver (VQE)[2-19], are developed for quantum chemistry. There are some important issues that should be studied for these algorithms. For example, the basis set used to construct the electronic Hamiltonian and the fermion-to-qubit encoding technique may lead to significant gate complexity and measurement overhead in QPE[20]. The optimization of a typical wave function ansatzes using VQE can suffer from “barren plateaus”[21,22] or local minimum traps[23]. A quantum computation platform that can provide extensive functionalities and step-by-step cross verification is therefore desirable for designing novel quantum algorithms for chemistry applications.
Noisy intermediate quantum (NISQ) devices have been used to demonstrate the possibility of studying the ground and excited states of molecular systems using currently available algorithms[10-15,24,25]. However, such experimental demonstrations are limited to tiny molecules with an artificially small basis set. This is because NISQ experiments are limited by the available quantum resources and the error associated with each quantum gate. Therefore, low gate fidelity, short coherence time, and insufficient qubit resource prohibit a systematic study of quantum chemistry oriented quantum algorithms on NISQ devices. The largest quantum computation experiment for chemistry to date uses 16 qubits with 160 two-qubit gates[25], while a simple VQE circuit of the commonly used unitary coupled-cluster (UCC)[26,27] ansatz for a small molecule has millions of CNOT gates (Table 1), which is far beyond the capability of NISQ devices. Therefore, it is important to have the capability to simulate the quantum circuit on a classical computer at this stage. Even beyond the NISQ era, such a capability can help us to develop quantum-inspired classical algorithms.
Table
1.
Computational resources required to perform VQE simulations for a number of molecules using the unitary coupled-cluster ansatz truncated up to double excitations (UCCSD) and the minimum basis set STO-3G. UCCGSD means that generalized excitation operators (not distinguishing occupied and virtual orbitals) are used. The way to count CNOT gates is described in the supporting information.
Several quantum computation packages have been reported, for example, C++ based ProjectQ[28] and Qiskit[29], GPU-enabled Qulacs[30], and the differentiable simulator Yao[31] implemented in Julia. Most of these codes are developed as standalone quantum circuit simulators or compilers, which are not dedicated to quantum chemistry applications. At the same time, the performance of simulating the quantum circuit is not very satisfactory in these packages. Most of these packages only implement the brute-force simulating method, which leads to an exponential computational cost. Tensor-based methods have been implemented in packages such as Qiskit and PennyLane[32], however, without an efficient distributed parallelization algorithm. As a reference, the largest simulated quantum circuit to date contains 28 qubits, which is used to study the ground state of ethylene molecules using VQE[33].
Based on the above considerations, we develop a versatile and extensible quantum computation platform for quantum chemistry, named Q2Chemistry (pronounced as “Q squared chemistry”) to highlight the two quantum dimensions (the systems to be studied and the tools used to study them). Q2Chemistry adopt a modular design and a mixed-language programming model to achieve versatility together with high performance, where Python is used as its application program interface (API) while C++ and Julia[34] are used for computationally intensive tasks such as quantum circuit simulators. Q2Chemistry provides interfaces to quantum chemistry packages such as PySCF[35] to generate the required parameters for the qubit Hamiltonian. The quantum algorithms for solving the eigenstates of the electronic Hamiltonian are programmable at a high level of abstraction by adopting internal templates and/or defining custom circuit generation procedures. Some popular VQE and post-VQE algorithms have already been implemented for ground and excited states of molecular and periodic systems. Q2Chemistry provides native modules to run the circuit generated by a specific quantum algorithm, either via various high performance classical circuit simulation algorithms for simulating the circuit on a classical computer or via extensible interfaces reserved for the upcoming actual quantum processors. An efficient matrix product state (MPS)[36,37] based circuit simulation engine is implemented to perform quantum simulations for systems with 50–100 qubits.
The remainder of this article is organized as follows. After introducing the framework of Q2Chemistry in Section 2, we present functionalities for handling ab-initio chemistry quantities in Section 3. In Section 4 we explain the implementation of the circuit simulation on a classical computer or running on the upcoming quantum hardware. Section 5 provides a general introduction to the natively implemented VQE-based algorithms. Finally, in Section 6, we provide some examples to demonstrate the power of Q2Chemistry in chemistry applications, and provide the road map for further extensions including the support for more quantum algorithms, classical circuit simulation backends, and circuit optimization algorithms.
2.
The framework of Q2Chemistry
As shown in Fig. 1a, Q2Chemistry contains three modules. (ⅰ) q2chem.qchem: the quantum chemistry module that defines quantum chemistry problems in the qubit space typically with the help of external classical quantum chemistry packages; (ⅱ) q2chem.qcirc: the quantum circuit module that provides the quantum circuit related functionalities, including circuit construction, visualization, optimization, and execution on a virtual or real quantum computer; (ⅲ) q2chem.qalgo: the quantum algorithm module, which includes native quantum algorithms and provides tools to implement new algorithms to solve chemistry problems.
Figure
1.
(a) The framework of Q2Chemistry. (b) A typical workflow of solving a chemical problem using a quantum algorithm.
High-level modules in Q2Chemistry are implemented using the scripting language Python and provide base implementations for classes in submodules. Benefiting from the modular design and Python’s extensibility, extending existing submodules are easily achieved by constructing derived classes and implementing only a small number of virtual functions, which requires no modifications to higher level modules. Core functions in the backends are implemented using programming languages including C++ and Julia. These functions are integrated into the Python interfaces using just-in-time (JIT) technology, which compiles the code at runtime to provide machine-specific optimizations and deliver outstanding performance. Most of the low-level data structures accessible from Python are stored using NumPy’s[38]ndarray. Therefore, auxiliary operations, such as exact diagonalization for the qubit Hamiltonian, can be realized by using NumPy-compatible packages such as SciPy[39] or PyTorch[40].
Using such a modular framework, a general workflow to solve a quantum chemistry problem on a quantum computer is briefly illustrated in Fig. 1b. (ⅰ) Collect classical data such as electron integrals and mean-field orbital coefficients to generate Hamiltonian and an initial quantum state. (ⅱ) Choose or develop a suitable quantum algorithm and generate corresponding quantum circuits, which may depend on the Hamiltonian, such as in the QPE algorithm, or be system independent, such as in some VQE algorithms. (ⅲ) Perform lower-level circuit optimizations, including eliminating redundant quantum gates to reduce circuit depth or reconstructing the circuit to fit a specific quantum processor. (ⅳ) Execute the quantum circuits and perform some measurements to extract necessary information, using either a virtual or real quantum computer.
Currently, Q2Chemistry can be routinely used for performing VQE simulations on a classical computer, which is powered by Hamiltonian generation for molecular and periodic systems, hardware-efficient and UCC-based ansatzes for parametric circuit construction, and a scalable noise-free tensor network backend for classical simulations of large quantum circuits.
3.
The quantum chemistry module
The q2chem.qchem module mainly handles the system Hamiltonian and wave function mapping. The second-quantized Hamiltonian is constructed from classically calculated quantities such as molecular orbital coefficients. Wave function mapping determines how the orbitals of the simulated wave function are mapped onto qubits therefore influences the measurement strategy.
3.1
Hamiltonian
For a Hamiltonian that is expressed as the linear combination of Pauli strings
ˆH=∑iciˆPi,
(1)
where ˆPi is the product of Pauli operators {ˆσx,ˆσy,ˆσz}⊗, and the expectation value E can be obtained through quantum measurement techniques such as the Hadamard test as
E=⟨Ψ|ˆH|Ψ⟩=⟨Ψ|∑iciˆPi|Ψ⟩=∑ici⟨Ψ|ˆPi|Ψ⟩.
(2)
Given the Hartree-Fock orbitals, the second-quantized electronic Hamiltonian can be written as
ˆH=∑p,qhpqˆTpq+∑p,qr,sgpqrsˆTpqrs,
(3)
with
ˆTpq=a†paq,ˆTpqrs=a†pa†qaras.
(4)
hpq and gpqrs are one- and two-electron integrals. To convert the second-quantized Hamiltonian Eq. (3) into the qubit form as given in Eq. (1), a fermion-to-qubit mapping such as the Jordan-Wigner or Bravyi-Kitaev mapping is required[41-43].
In Q2Chemistry, an interface with the PySCF package is provided to calculate one- and two-electron integrals for molecular and periodic systems[44,45]. Orbital optimization is also supported by linking to the pyscf.lo module or using a custom cost function. A unitary matrix is then obtained to transform the integrals as follows:
where U∗ is the elementwise complex conjugate of U. This step is carried out efficiently by calling the optimized tensor contraction package opt_einsum[46]. For fermion-to-qubit mapping, Q2Chemistry implements an efficient Jordan-Wigner transformation written in pure Julia. Other methods, such as Bravyi-Kitaev, are currently provided through the interface of OpenFermion[47]. The qubit Hamiltonian can then be used to construct quantum gates for measurement in quantum algorithms such as VQE or QPE.
3.2
Wave function
To represent a many-electron quantum state on a quantum computer, the most commonly used strategy is to map its molecular orbitals onto qubits, which can span the Fock space. Such a straightforward orbital-to-qubit approach can be written as
|ΨHF⟩=|i0i1⋯⟩,|ΨCI⟩=∑i0,i1,⋯ci0i1⋯|i0i1⋯⟩,
(6)
where ij∈{0,1} represents both the occupation of orbitals and the quantum state |0⟩ or |1⟩ of the corresponding qubit. Eq. (6) actually describes the quantum state corresponding to the eigenstates of a qubit Hamiltonian obtained from the Jordan-Wigner transformation. If other fermion-to-qubit mapping algorithms such as Bravyi-Kitaev are used for the Hamiltonian, such a correspondence does not necessarily exist. With a quantum state mapped to qubits, Q2Chemistry can provide a Hadamard test to evaluate the expectation value of the quantum state with respect to an operator.
In simple orbital-to-qubit mapping, the number of qubits required to simulate the wave function has a linear dependence on the number of basis functions, which prohibits the use of a large basis set on NISQ devices. Q2Chemistry provides another strategy that maps a classical tensor network (TN) state onto quantum circuits[48,49]. In this way, the qubits determine the classical bond dimension of the tensor network. For chemical systems that contain weak electron correlations or have a special symmetry, such a TN-based strategy provides a possible solution to effectively reduce the number of qubits at the expense of performing more measurements. Generally, different wave function mapping strategy leads to distinctive structures of the quantum circuits, therefore, may bring special restrictions to subsequent quantum algorithms and measurement protocols. The q2chem.qchem module passes the mapping strategy to quantum algorithms in q2chem.qalgo to generate an abstract circuit class for initialization. The abstract circuits are then extended according to the adopted quantum algorithm and instantiated to a common readable quantum circuit that can be used in q2chem.qcirc.
4.
The quantum circuit module
The q2chem.qcirc module provides quantum circuit execution functionalities. It mainly contains two parts: an interface reserved for quantum computer manufacturers and a classical simulator that simulates state evolution determined by quantum circuits on a classical computer.
4.1
Interfaces with quantum devices
Functionalities in q2chem.qcirc are inherited from the _Base class. High-level Python APIs enable efficient extensions of Q2Chemistry, which can be used to interface with different quantum device operation systems. Currently, there are multiple competing technical routes of quantum computers, e.g., photonic qubits have long coherence time, while superconducting platforms have good scalability. To efficiently and accurately study quantum chemical problems, various quantum hardwares may be required depending on the characteristics of the quantum algorithm. Therefore, we provide a flexible interface for connecting to different quantum hardware platforms as illustrated in Code Example 1. In a general _BaseHardware, the circuit generated by Q2Chemistry is first represented by quantum assembly language such as OpenQASM via _compile_circuit(). This step generally should include circuit optimization and reconstruction to fit the architecture of specific hardware. Then, the sequence of gates is converted into signals or pulses and sent to the quantum devices through _quantum_hardware_evolution() using a compiler provided by the vendor of the hardware system. Finally, the results such as measurement statistics or bit strings are collected and postprocessed in Q2Chemistry to obtain the required quantities.
4.2
Classical quantum circuit simulator
Q2Chemistry implements several simulators to run quantum circuits on a classical computer. The quantum state of multiple qubits can be expanded using a certain basis set
|Ψ⟩=∑i1i2…iNci1i2…iN|i1i2…iN⟩,
(7)
where N is the number of qubits, and |i1i2…iN⟩ is the basis state. The coefficients ci1i2…iN form an N-dimensional tensor that contains 2N amplitudes. Eq. (7) is similar to the correlated wave function in quantum chemistry represented by a configuration interaction (CI) expansion.
Currently, there are two strategies to simulate the evolution of the quantum state on a classical computer. One is brute-force simulation which uses a (2N×1) state vector (SV) or a (2N×2N) density matrix (DM) to represent the quantum state. The other is tensor network methods which approximate the quantum state by a set of low-rank tensors. The brute-force methods are supported by most of the existing packages (Table 2). Q2Chemistry also supports the state vector and density matrix methods. These brute-force methods implemented in the q2chem.qcirc module use the compressed sparse row (CSR) format for sparse matrix storage and OpenMP for multithreaded calculation. OpenACC-enabled C++ code is also implemented and can be selected at compile time to utilize GPU, which can provide 2−10 times speed-up over the multithreaded CPU version.
Table
2.
Backends for circuit simulations in present open-source quantum computation softwares. External indicates that one or more third-party packages are required to enable the functionality. SA stands for single-amplitude simulation.
A typical drawback of brute-force simulation is that the memory usage and computational complexity both scale as O(cN), where c is a constant between 2 and 4 and N is the number of qubits. This exponential scaling prevents quantum simulations for larger molecules with more than ~30 qubits. Recently, matrix product states (MPS) and projected entangled pair states (PEPS) have been used to simulate large scale random quantum circuits[58-61]. Since the tensor contraction pattern is mostly fixed and does not have NP-hard path optimization problems[62], the one-dimensional MPS is preferable as a high-performance tensor network backend for a general quantum circuit simulator.
The MPS ansatz factorizes the rank-N coefficients into lower rank tensors, which can be written as
ci1i2…iN=∑u0…uN1Ti1u0u12Ti2u1u2…NTiNuN−1uN,
(8)
where kTikuk−1uk is a rank-3 tensor with ik called the physical index and uk the auxiliary index. The maximum size of the auxiliary indices is defined as the bonddimension of the MPS, which is denoted as D=max0≤k≤N{uk}. Algorithms based on MPS generally have a complexity of O(ND3). If the bond dimension D is allowed to grow exponentially, the MPS can exactly represent any quantum state using Eq. (8).
The q2chem.qcirc module implements the MPS simulation algorithm on top of the machine learning framework PyTorch[40] based on the algorithm proposed by Vidal etal.[63,64]. A demonstrative procedure for simulating quantum circuits using the MPS algorithm is presented in Fig. 2. Different from common classical MPS-based methods such as the density matrix renormalization group (DMRG)[37], a set of auxiliary matrices are inserted between the rank-3 tensors and stored to maintain a normalized quantum state after truncated SVD.
Figure
2.
(a) Applying a single qubit gate on the MPS quantum state is simulated by simply a local contraction. (b) Applying a two-qubit gate on neighboring qubits generally has 2 steps: (i) reshape the two-qubit gate into a 4-dimensional tensor and contract with the qubits to form a two-qubit tensor; (ii) perform a singular value decomposition to restore the two-qubit tensor back to the MPS formulation. Postprocessing is usually required to maintain normalization or canonicalization of MPS tensors. (c) Auxiliary matrices that contain truncated and normalized singular values are used to normalize the quantum state.
Classical quantum simulator backends can also be extended within the framework of Q2Chemistry in a similar style as the interfaces for hardware. It requires only a minimum effort to implement functions _quantum_gate_evolution() and _measure_qubit() for a derived class of _BaseSimulator and, if necessary, a custom data structure to store the quantum state. No modification to the upper level modules such as expectation value evaluation or higher level quantum algorithms is needed. In Section 6.2, we show the application of Q2Chemistry interfaced with an external MPS simulator QuantumSpins[59,65], which efficiently simulated a 40-qubit molecule with a high accuracy.
4.3
Reversible automatic differentiation
In many quantum algorithms, a parametric quantum circuit is constructed, and optimization of the circuit parameters is carried out iteratively. On a quantum computer, the gradients of energy or another target function with respect to circuit parameters can be calculated through the parameter-shift rule or finite difference steps, which will introduce an additional complexity factor of O(Np), where Np is the number of parameters. Nevertheless, using a classical quantum circuit simulator the gradients can be evaluated efficiently with an approximately O(1) complexity, which is extremely helpful just as the reverse-mode automatic differentiation (AD) algorithm used in classical machine learning if a large number of parameters are involved. Different from conventional machine learning, the computation graph of a quantum expectation value with respect to variational parameters is reversible:
|Ψ⟩n=Un|Ψ⟩n−1⇔|Ψ⟩n−1=U†n|Ψ⟩n,
(9)
which indicates that the intermediate quantum states {|Ψ⟩n−1,|Ψ⟩n−2,⋯} can be calculated iteratively and thus do not need to be stored explicitly in memory, enabling a significant reduction in memory consumption during the reverse-mode gradient evaluations[66-68]. This classical algorithm, which is termed reversible AD, is first implemented in the Julia package Yao.jl, and a detailed description is given in Algorithm 1.
Algorithm 1: Reversible AD algorithm to calculate gi=∂E∂θi.
Data:ˆH, {U0(θ0),U0(θ0),…}, |Ψ⟩
Result:g: gradients of energy w.r.t. parameters {θ0,θ1,…}
Np← number of parameters, g←empty array of length Np;
Q2Chemistry implements reversible AD for brute-force backends. It should be noted that the reversible AD algorithm is invalid on real quantum devices even if the original equation is used:
since the derivative gates {∂Ui(θi)∂θi} are generally nonunitary. At the same time, using reversible AD with the MPS simulator requires careful modifications to the algorithm and specially designed techniques due to SVD truncation during the simulation. A naive implementation of Algorithm 1 probably leads to suboptimal performance and numerical errors.
5.
Quantum algorithms
In the current release, Q2Chemistry provides a couple of VQE-based algorithms. The module q2chem.qalgo adopted several variational wave function ansatzes that can be used individually or collectively to solve for the eigenstates of the given chemical system. New quantum algorithms can also be conveniently implemented by users.
5.1
Variational quantum circuit ansatz
Introducing a parametric wave function |Ψ(θ)⟩, the lowest eigenvalue E0 can be obtained variationally:
E0=minθ⟨Ψ(θ)|ˆH|Ψ(θ)⟩.
(10)
Such a protocol is implemented in the q2chem.qalgo module to obtain the eigenstates of a given Hamiltonian. Properly constructing a parametric quantum circuit, the wave function ansatz |Ψ(θ)⟩ is encoded into the quantum state of qubits. Combining the measurements for expectation value evaluation on a quantum computer and a numerical optimization algorithm on a classical computer, the variational procedure can then be performed in a hybrid quantum-classical way.
Generally, two broad types of variational quantum circuit ansatzes exist[8]. They are physically motivated ansatz (PMA), which is inspired by classical wave function methods that systematically approach the exact electronic wave function, and hardware heuristic ansatz (HHA), which considers specific hardware structures and employs entangling blocks. Both types are currently integrated into the q2chem.qalgo module.
Unitary coupled-cluster is one of the most commonly used PMAs for quantum computing. Generally, the UCC wave function is defined as
|Ψ(θ)UCC⟩=exp(ˆT(θ)−ˆT†(θ))|ΨHF⟩.
(11)
In Q2Chemistry, the spin-adapt CCD0 cluster operators[69] are used to construct the UCCSD and UCCGSD wave functions. A fermion-to-qubit mapping is performed, and first-order Trotter-Suzuki decomposition[70,71] is implemented to convert Eq. (11) into the product of Pauli strings:
|Ψ(θ)UCC⟩=∏i∏jexp(iθicijˆPij)|ΨHF⟩,
(12)
where θi is the variational parameter corresponding to the i-th anti-Hermitian fermion excitation operator ˆTi−ˆT†i, which is transformed into qubit form ∑jicijˆPij. Each exponential term is mapped to the quantum circuit following Algorithm 2. An example of the mapped circuit is presented in Fig. 3a.
Figure
3.
(a) The quantum circuit corresponding to the operator exp(iθ^σx^σy^σz^σx) and (b) the two-layer HEA circuit that entangles all neighboring qubits using the controlled-U gate. Blue squares represent nonparametric gates, while green squares represent parametric quantum gates such as Rz and the three-parameter (controlled-)U gate.
The hardware efficient ansatz (HEA) circuit[14] is implemented as an HHA ansatz. If the type of entanglement gates, the ordering of entanglement qubits and the number of layers are set, Q2Chemistry automatically generates the parametric hardware efficient circuit for simulation. Fig. 3b shows an example of a two-layer HEA circuit with all neighboring qubits entangled by the three-parameter controlled-U gate.
Algorithm 2: Map exp(iθˆP) to circuit. HY is the Hadamard-Y gate defined as HY=√2/2×(Z+Y)
Several techniques are implemented in Q2Chemistry to reduce the computational overhead, including qubit tapering for Hamiltonian[72], qubit excitation based (QEB) operator[73], Pauli entangler[74,75], symmetry-based operator selection[33] and the ADAPT-VQE algorithm[76]. Q2Chemistry supports combination of above methods, for example, using Pauli entanglers that entangle at most 4 qubits together with ADAPT-VQE leads to an iterative-qubit-coupled-cluster (iQCC)[75] like algorithm.
In addition to ground state methods, the q2chem.qalgo module offers a couple of post-VQE algorithms for calculating excited states, including the variational quantum deflation (VQD)[18], quantum subspace expansion (QSE)[19] and equation-of-motion (EOM)[45,77,78] theory. VQD consecutively constructs an effective Hamiltonian, the lowest eigenvalue of which corresponds to the 1st, 2nd, 3rd, … excited state energy:
ˆHieff=ˆHi−1eff+αi|Ψi−1⟩⟨Ψi−1|,
(13)
where ˆH0eff is the original second-quantized electronic Hamiltonian. QSE and EOM use a set of fermion excitation operators or a state-transfer operator to construct and solve a generalized eigenvalue problem MC=SCE by additional quantum measurements on the top of the ground state circuit. These methods are implemented in Q2Chemistry for calculating electron excitations, ionization potentials and electron affinity energies for both molecules and periodic systems.
5.2
Parallel evaluation of an expectation value
As shown in Eq. (2), the Hamiltonian is expressed as the summation of a polynomial number of mutually uncorrelated Pauli strings. The expectation values of each Pauli string can thus be calculated independently. Fig. 4 gives an example of circuits used for evaluating the expectation value ∑ici⟨Ψ|ˆPi|Ψ⟩ for a given Hamiltonian containing a number of Pauli strings under some fermion-to-qubit transformation. For each of the circuits, the ansatz parts are the same while the measurement parts are constructed according to the specific form of the Pauli string. During the calculation of the expectation value, Q2Chemistry automatically distributes these circuits to different quantum devices or simulator processes. On each device, a subset of circuits are executed and then measured. The measurement outcomes are then postprocessed to calculate expectation values locally. Finally, the results are reduced across all the devices to obtain the total energy.
Figure
4.
Evaluating the expectation value of a linear combination of Pauli strings using multiple quantum devices or simulator processes. |0N⟩ represents an N-qubit quantum register with all qubits initialized to |0⟩. In this example, the measurement parts are the Hadamard test circuits.
It should be noted that on real quantum devices, since the quantum states are nonreplicable, all the circuits should be executed. However, on a classical simulator, the memory data of quantum states can be reused. Therefore, using a quantum circuit simulator, the ansatz part only needs to be executed once, and the simulated quantum state can then be copied to each process for later measurements. This strategy is used in the simulations of Section 6.
6.
Applications
We present several simulations to show the power of Q2Chemistry, including a scalability test for the MPS-based quantum circuit simulator and the numerical simulation results for ground- and excited-state calculations.
6.1
Scalability benchmark
The parallel measurement for the expectation value introduced in Section 5.2 is extended to a two-level parallelism for the MPS simulator:
(I) The first level parallelization over Hamiltonian. Subsets of Pauli strings from the Hamiltonian in Eq. (1) are distributed to each process. The expectation values of Pauli strings are calculated independently, and a reduce-sum is performed across all processes to obtain the final energy.
(II) The second low-level parallelization using multithread parallelism on CPU or GPU, to accelerate the calculations of linear algebra routines such as matrix multiplication and singular value decomposition.
The two-level strategy enables good parallel scalability if the adapted dynamical distribution algorithm is used to achieve load balance. To reduce memory usage, in the first level, the quantum circuit is stored and evolved only on the 0th process. Although for small molecules such as H2 (4 qubits), the circuit evolution may contribute over 80% to the total execution time, the number of Pauli strings in the Hamiltonian will quickly go beyond 105 due to the O(N4) scaling, and the time cost of circuit simulation will become negligible if larger systems with more than 12 qubits are involved. The scaling benchmark of Q2Chemistry simulating a Cr2 molecule (STO-3G basis set) using the MPS backend is given in Fig. 5. Q2Chemistry achieves good parallel performance up to 768 CPU cores for this 72-qubit system. Note that the main purpose of this test is for parallelization scaling instead of obtaining reliable results. Therefore, only 51 of the 3131 variational parameters are considered, leading to a quantum circuit with 119884 gates. The upper bound for the bond dimension is also set to a relatively low value of 64.
Figure
5.
Simulating the Cr2 molecule using the MPS backend. The STO-3G basis set and the symmetry-reduced UCCSD ansatz are used, where the qubit Hamiltonian contains 305041 Pauli strings. The time cost refers to one VQE iteration (including evolution of the quantum circuit and calculation of energy) being tested. The distributed parallelization is implemented using OpenMPI and Python’s mpi4py package.
Fig. 6a shows the potential energy curve of the H2 molecule. The calculation is carried out by extending the simulators in the q2chem.qcirc module to an external MPS circuit simulator written in Julia[59,65]. Benefiting from the high-level modular structure introduced in Section 2, this external simulator and the parallelization techniques introduced in Section 5.2 can be easily implemented within the framework of Q2Chemistry by adding a few lines of code. The ground-state energies are variationally optimized using the ccJ-pVDZ basis set[79] and the symmetry-reduced UCCSD[33] circuit (leading to 40 qubits and 53 variational parameters). The BOBYQA optimizer is used to perform gradient-free optimizations. For each geometry, 2000 optimization steps are performed within 24 h using 560 CPU cores.
Figure
6.
(a) The VQE optimized potential energy curve of H2 calculated by the MPS backend using the ccJ-pVDZ basis set. The VQE results are calculated by interfacing with the external Julia-implemented MPS simulator. (b) Energy difference between EOM-ADAPT-C and classical EOM-CCSD band structures for Si. Inset gives the EOM-ADAPT-C band structure calculated using Q2Chemistry. The FCI and EOM-CCSD energies are obtained using the PySCF code.
Fig. 6b calculates the quasi-particle band structures for silicon. For such periodic systems, the Hamiltonian and UCC-based wave function ansatz need to include the constraint of crystal momentum conservation[44], which is automatically handled by the q2chem.qchem module. The simulation uses the GTH-SVZ basis set with a GTH-PADE pseudopotential. A UCCGSD operator pool with complementary operators [45] is employed together with the ADAPT algorithm for the ground state ADAPT-C wave function. With a 1×1×1k-point grid, 16 qubits are simulated using the state vector backend. The EOM-ADAPT-C method[45] is used for band structure calculation, which achieves a mean absolute difference of 0.047 eV from EOM-CCSD and the deviation is as small as ∼10−3 eV at the Γ point (Fig. 6b).
7.
Conclusions
In this study, we demonstrate that the Q2Chemistry package is suitable for simulating and developing quantum algorithms for quantum chemistry applications. Q2Chemistry provides versatile functionalities for simulating ground- and excited-state properties. The simulator backend, including the parallelized MPS algorithm, achieves high performance for large-scale simulations using a moderate amount of computational resources. Directions for future development include more classical simulation methods, including high-dimensional tensor network based methods, more integrated quantum algorithms, and high-performance quantum circuit optimization algorithms. With the flexibility to link to different quantum devices, Q2Chemistry can be used as a useful platform in pursuing a practical quantum advantage.
Supporting information
The supporting information for this article can be found online at https://doi.org/10.52396/JUSTC-2022-0118. The supporting information includes one figure. The way to count CNOT gates is described in the supporting information.
Acknowledgements
This work was partially supported by the National Natural Science Foundation of China (21825302), the Fundamental Research Funds for the Central Universities (WK2060000018), the National Supercomputing Center in Jinan, and the USTC Supercomputing Center.
Conflict of interest
The authors declare that they have no conflict of interest.
Preprint statement
Research presented in this article was posted on a preprint server prior to publication in JUSTC. The corresponding preprint article can be found here: arXiv: 2208.10978. https://arxiv.org/abs/2208.10978.
Conflict of Interest
The authors declare that they have no conflict of interest.
We developed a quantum computation platform for quantum chemistry applications.
A modular structure was implemented with a mixed-language programming model for easy extension and high performance.
Excellent performance is achieved as demonstrated by simulating medium-scale quantum circuits up to 72 qubits.
Preskill J. Quantum Computing in the NISQ era and beyond. Quantum,2018, 2: 79. DOI: 10.22331/q-2018-08-06-79
[2]
McArdle S, Endo S, Aspuru-Guzik A, et al. Quantum computational chemistry. Rev. Mod. Phys.,2020, 92: 015003. DOI: 10.1103/RevModPhys.92.015003
[3]
Yung M H, Casanova J, Mezzacapo A, et al. From transistor to trapped-ion computers for quantum chemistry. Sci. Rep.,2014, 4 (1): 3589. DOI: 10.1038/srep03589
[4]
Tilly J, Chen H, Cao S, et al. The Variational Quantum Eigensolver: a review of methods and best practices. 2021. https://arxiv.org/abs/2111.05176. Accessed August 1, 2022.
[5]
Cerezo M, Arrasmith A, Babbush R, et al. Variational quantum algorithms. Nat. Rev. Phys.,2021, 3 (9): 625–644. DOI: 10.1038/s42254-021-00348-9
[6]
Magann A B, Arenz C, Grace M D, et al. From pulses to circuits and back again: A quantum optimal control perspective on variational quantum algorithms. PRX Quantum,2021, 2: 010101. DOI: 10.1103/PRXQuantum.2.010101
[7]
Fedorov D A, Peng B, Govind N, et al. VQE method: a short survey and recent developments. Mater. Theory,2022, 6: 2. DOI: 10.1186/s41313-021-00032-6
[8]
Cao Y, Romero J, Olson J P, et al. Quantum chemistry in the age of quantum computing. Chem. Rev.,2019, 119: 10856–10915. DOI: 10.1021/acs.chemrev.8b00803
[9]
Aspuru-Guzik A, Dutoi A D, Love P J, et al. Simulated quantum computation of molecular energies. Science,2005, 309: 1704–1707. DOI: 10.1126/science.1113479
[10]
Peruzzo A, McClean J, Shadbolt P, et al. A variational eigenvalue solver on a photonic quantum processor. Nat. Commun.,2014, 5: 4213. DOI: 10.1038/ncomms5213
[11]
Hempel C, Maier C, Romero J, et al. Quantum chemistry calculations on a trapped-ion quantum simulator. Phys. Rev. X,2018, 8: 031022. DOI: 10.1103/PhysRevX.8.031022
[12]
Nam Y, Chen J S, Pisenti N C, et al. Ground-state energy estimation of the water molecule on a trapped-ion quantum computer. npj Quantum Inf.,2020, 6: 33. DOI: 10.1038/s41534-020-0259-3
[13]
O’Malley P J J, Babbush R, Kivlichan I D, et al. Scalable quantum simulation of molecular energies. Phys. Rev. X,2016, 6: 031007. DOI: 10.1103/PhysRevX.6.031007
[14]
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
[15]
Colless J I, Ramasesh V V, Dahlen D, et al. Computation of molecular spectra on a quantum processor with an error-resilient algorithm. Phys. Rev. X,2018, 8: 011021. DOI: 10.1103/PhysRevX.8.011021
[16]
McClean J R, Romero J, Babbush R, et al. The theory of variational hybrid quantum-classical algorithms. New J. Phys.,2016, 18: 023023. DOI: 10.1088/1367-2630/18/2/023023
[17]
Lanyon B P, Whitfield J D, Gillett G G, et al. Towards quantum chemistry on a quantum computer. Nat. Chem.,2010, 2: 106–111. DOI: 10.1038/nchem.483
[18]
Higgott O, Wang D, Brierley S. Variational quantum computation of excited states. Quantum,2019, 3: 156. DOI: 10.22331/q-2019-07-01-156
[19]
McClean J R, Kimchi-Schwartz M E, Carter J, et al. Hybrid quantum-classical hierarchy for mitigation of decoherence and determination of excited states. Phys. Rev. A,2017, 95: 042308. DOI: 10.1103/PhysRevA.95.042308
[20]
Liu J, Fan Y, Li Z, et al. Quantum algorithms for electronic structures: basis sets and boundary conditions. Chem. Soc. Rev.,2022, 51: 3263–3279. DOI: 10.1039/D1CS01184G
[21]
McClean J R, Boixo S, Smelyanskiy V N, et al. Barren plateaus in quantum neural network training landscapes. Nat. Commun.,2018, 9 (1): 4812. DOI: 10.1038/s41467-018-07090-4
[22]
Napp J. Quantifying the barren plateau phenomenon for a model of unstructured variational ansätze. 2022. https://arxiv.org/abs/2203.06174. Accessed August 1, 2022.
[23]
Anschuetz E R, Kiani B T. Beyond barren plateaus: Quantum variational algorithms are swamped with traps. 2022. https://arxiv.org/abs/2205.05786. Accessed August 1, 2022.
[24]
Arute F, Arya K, Babbush R, et al. Hartree-Fock on a superconducting qubit quantum computer. Science,2020, 369 (6507): 1084–1089. DOI: 10.1126/science.abb9811
[25]
Huggins W J, O’Gorman B A, Rubin N C, et al. Unbiasing fermionic quantum Monte Carlo with a quantum computer. Nature,2022, 603 (7901): 416–420. DOI: 10.1038/s41586-021-04351-z
[26]
Bartlett R J, Kucharski S A, Noga J. Alternative coupled-cluster ansätze Ⅱ. The unitary coupled-cluster method. Chem. Phys. Lett.,1989, 155: 133–140. DOI: 10.1016/S0009-2614(89)87372-5
[27]
Taube A G, Bartlett R J. New perspectives on unitary coupled-cluster theory. Int. J. Quantum Chem.,2006, 106: 3393–3401. DOI: 10.1002/qua.21198
[28]
Steiger D S, Häner T, Troyer M. ProjectQ: an open source software framework for quantum computing. Quantum,2018, 2: 49. DOI: 10.22331/q-2018-01-31-49
Suzuki Y, Kawase Y, Masumura Y, et al. Qulacs: a fast and versatile quantum circuit simulator for research purpose. Quantum,2021, 5: 559. DOI: 10.22331/q-2021-10-06-559
[31]
Luo X Z, Liu J G, Zhang P, et al. Yao.jl: Extensible, efficient framework for quantum algorithm design. Quantum,2020, 4: 341. DOI: 10.22331/q-2020-10-11-341
[32]
Bergholm V, Izaac J, Schuld M, et al. PennyLane: Automatic differentiation of hybrid quantum-classical computations. 2018. https://arxiv.org/abs/1811.04968. Accessed August 1, 2022.
[33]
Cao C, Hu J, Zhang W, et al. Progress toward larger molecular simulation on a quantum computer: Simulating a system with up to 28 qubits accelerated by point-group symmetry. Phys. Rev. A,2022, 105: 062452. DOI: 10.1103/PhysRevA.105.062452
[34]
Bezanson J, Edelman A, Karpinski S, et al. Julia: A fresh approach to numerical computing. SIAM Review,2017, 59 (1): 65–98. DOI: 10.1137/141000671
[35]
Sun Q, Berkelbach T C, Blunt N S, et al. PySCF: the Python-based simulations of chemistry framework. WIREs Comput. Mol. Sci.,2018, 8: e1340. DOI: 10.1002/wcms.1340
[36]
Orús R. A practical introduction to tensor networks: Matrix product states and projected entangled pair states. Ann. Phys.,2014, 349: 117–158. DOI: 10.1016/j.aop.2014.06.013
[37]
Schollwöck U. The density-matrix renormalization group in the age of matrix product states. Ann. Phys.,2011, 326 (1): 96–192. DOI: 10.1016/j.aop.2010.09.012
[38]
Harris C R, Millman K J, van der Walt S J, et al. Array programming with NumPy. Nature,2020, 585 (7825): 357–362. DOI: 10.1038/s41586-020-2649-2
[39]
Virtanen P, Gommers R, Oliphant T E, et al. SciPy 1.0: fundamental algorithms for scientific computing in Python. Nat. Methods,2020, 17: 261–272. DOI: 10.1038/s41592-019-0686-2
[40]
Paszke A, Gross S, Massa F, et al. PyTorch: An imperative style, high-performance deep learning library. In: Wallach H, Larochelle H, Beygelzimer A, editors. Advances in Neural Information Processing Systems 32. New York: Curran Associates, Inc., 2019: 8024–8035.
[41]
Jordan P, Wigner E. Über das paulische äquivalenzverbot. Z. Physik,1928, 47: 631–651. DOI: 10.1007/BF01331938
[42]
Seeley J T, Richard M J, Love P J. The Bravyi-Kitaev transformation for quantum computation of electronic structure. J. Chem. Phys.,2012, 137: 224109. DOI: 10.1063/1.4768229
[43]
Tranter A, Love P J, Mintert F, et al. A comparison of the Bravyi-Kitaev and Jordan-Wigner transformations for the quantum simulation of quantum chemistry. J. Chem. Theory Comput.,2018, 14: 5617–5630. DOI: 10.1021/acs.jctc.8b00450
[44]
Liu J, Wan L Y, Li Z Y, et al. Simulating periodic systems on a quantum computer using molecular orbitals. J. Chem. Theory Comput.,2020, 16: 6904–6914. DOI: 10.1021/acs.jctc.0c00881
[45]
Fan Y, Liu J, Li Z Y, et al. Equation-of-motion theory to calculate accurate band structures with a quantum computer. J. Phys. Chem. Lett.,2021, 12 (36): 8833–8840. DOI: 10.1021/acs.jpclett.1c02153
[46]
Smith D G A, Gray J. opt_einsum - A Python package for optimizing contraction order for einsum-like expressions. J. Open Source Softw.,2018, 3 (26): 753. DOI: 10.21105/joss.00753
[47]
McClean J R, Sung K J, Kivlichan I D, et al. OpenFermion: The electronic structure package for quantum computers. 2017. https://arxiv.org/abs/1710.07629. Accessed August 1, 2022.
[48]
Liu J G, Zhang Y H, Wan Y, et al. Variational quantum eigensolver with fewer qubits. Phys. Rev. Res.,2019, 1: 023025. DOI: 10.1103/PhysRevResearch.1.023025
[49]
Haghshenas R, Gray J, Potter A C, et al. Variational power of quantum circuit tensor networks. Phys. Rev. X,2022, 12: 011047. DOI: 10.1103/PhysRevX.12.011047
[50]
Nguyen D, Mikushin D, Man-Hong Y. HiQ-ProjectQ: Towards user-friendly and high-performance quantum computing on GPUs. In: 2021 Design, Automation & Test in Europe Conference & Exhibition (DATE). IEEE, 2021: 1056–1061.
Jones T, Brown A, Bush I, et al. QuEST and high performance simulation of quantum computers. Sci. Rep.,2019, 9 (1): 10736. DOI: 10.1038/s41598-019-47174-9
[55]
Kottmann J S, Alperin-Lea S, Tamayo-Mendoza T, et al. TEQUILA: a platform for rapid development of quantum algorithms. Quantum Sci. Technol.,2021, 6 (2): 024009. DOI: 10.1088/2058-9565/abe567
[56]
Stair N H, Evangelista F A. QForte: An efficient state-vector emulator and quantum algorithms library for molecular electronic structure. J. Chem. Theory Comput.,2022, 18 (3): 1555–1568. DOI: 10.1021/acs.jctc.1c01155
[57]
McCaskey A J, Lyakh D I, Dumitrescu E F, et al. XACC: a system-level software infrastructure for heterogeneous quantum-classical computing. Quantum Sci. Technol.,2020, 5 (2): 024002. DOI: 10.1088/2058-9565/ab6bf6
[58]
Guo C, Liu Y, Xiong M, et al. General-purpose quantum circuit simulator with projected entangled-pair states and the quantum supremacy frontier. Phys. Rev. Lett.,2019, 123: 190501. DOI: 10.1103/PhysRevLett.123.190501
[59]
Guo C, Zhao Y, Huang H L. Verifying random quantum circuits with arbitrary geometry using tensor network states algorithm. Phys. Rev. Lett.,2021, 126: 070502. DOI: 10.1103/PhysRevLett.126.070502
[60]
Liu X, Guo C, Liu Y, et al. Redefining the quantum supremacy baseline with a new generation sunway supercomputer. 2021. https://arxiv.org/abs/2111.01066. Accessed August 1, 2022.
[61]
McCaskey A, Dumitrescu E, Chen M, et al. Validating quantum-classical programming models with tensor network simulations. PLoS ONE,2018, 13 (12): e0206704. DOI: 10.1371/journal.pone.0206704
[62]
Pfeifer R N C, Haegeman J, Verstraete F. Faster identification of optimal contraction sequences for tensor networks. Phys. Rev. E,2014, 90: 033315. DOI: 10.1103/PhysRevE.90.033315
[63]
Vidal G. Efficient classical simulation of slightly entangled quantum computations. Phys. Rev. Lett.,2003, 91: 147902. DOI: 10.1103/PhysRevLett.91.147902
[64]
Vidal G. Classical simulation of infinite-size quantum lattice systems in one spatial dimension. Phys. Rev. Lett.,2007, 98: 070201. DOI: 10.1103/PhysRevLett.98.070201
Gomez A N, Ren M, Urtasun R, et al. The reversible residual network: Backpropagation without storing activations. 2017. https://arxiv.org/abs/1707.04585. Accessed October 21, 2022.
[67]
Chen R T Q, Rubanova Y, Bettencourt J, et al. Neural ordinary differential equations. 2019. https://arxiv.org/abs/1806.07366. Accessed October 21, 2022.
[68]
Jones T, Gacon J. Efficient calculation of gradients in classical simulations of variational quantum algorithms. 2020. https://arxiv.org/abs/2009.02823. Accessed August 1, 2022.
[69]
Bulik I W, Henderson T M, Scuseria G E. Can single-reference coupled cluster theory describe static correlation? J. Chem. Theory Comput.,2015, 11 (7): 3171–3179. DOI: 10.1021/acs.jctc.5b00422
[70]
Grimsley H R, Claudino D, Economou S E, et al. Is the Trotterized UCCSD ansatz chemically well-defined? J. Chem. Theory Comput.,2020, 16: 1–6. DOI: 10.1021/acs.jctc.9b01083
[71]
Babbush R, McClean J, Wecker D, et al. Chemical basis of Trotter-Suzuki errors in quantum chemistry simulation. Phys. Rev. A,2015, 91: 022311. DOI: 10.1103/PhysRevA.91.022311
[72]
Bravyi S, Gambetta J M, Mezzacapo A, et al. Tapering off qubits to simulate fermionic Hamiltonians. 2017. https://arxiv.org/abs/1701.08213. Accessed August 1, 2022.
[73]
Yordanov Y S, Armaos V, Barnes C H W, et al. Qubit-excitation-based adaptive variational quantum eigensolver. Commun. Phys.,2021, 4 (1): 228. DOI: 10.1038/s42005-021-00730-0
[74]
Ryabinkin I G, Yen T C, Genin S N, et al. Qubit coupled cluster method: A systematic approach to quantum chemistry on a quantum computer. J. Chem. Theory Comput.,2018, 14 (12): 6317–6326. DOI: 10.1021/acs.jctc.8b00932
[75]
Ryabinkin I G, Lang R A, Genin S N, et al. Iterative qubit coupled cluster approach with efficient screening of generators. J. Chem. Theory Comput.,2020, 16 (2): 1055–1063. DOI: 10.1021/acs.jctc.9b01084
[76]
Grimsley H R, Economou S E, Barnes E, et al. An adaptive variational algorithm for exact molecular simulations on a quantum computer. Nat. Commun.,2019, 10: 3007. DOI: 10.1038/s41467-019-10988-2
[77]
Krylov A I. Equation-of-motion coupled-cluster methods for open-shell and electronically excited species: The hitchhiker’s guide to Fock space. Annu. Rev. Phys. Chem.,2008, 59: 433–462. DOI: 10.1146/annurev.physchem.59.032607.093602
[78]
Ollitrault P J, Kandala A, Chen C F, et al. Quantum equation of motion for computing molecular excitation energies on a noisy quantum processor. Phys. Rev. Res.,2020, 2: 043140. DOI: 10.1103/PhysRevResearch.2.043140
[79]
Benedikt U, Auer A A, Jensen F. Optimization of augmentation functions for correlated calculations of spin-spin coupling constants and related properties. J. Chem. Phys.,2008, 129 (6): 064111. DOI: 10.1063/1.2962973
Wan, L., Liu, J., Li, Z. et al. Hybrid Hamiltonian Simulation for Excitation Dynamics. Journal of Physical Chemistry Letters, 2024, 15(45): 11234-11243.
DOI:10.1021/acs.jpclett.4c02624
2.
Yao, Q., Ji, Q., Li, X. et al. Machine Learning Accelerates Precise Excited-State Potential Energy Surface Calculations on a Quantum Computer. Journal of Physical Chemistry Letters, 2024, 15(27): 7061-7068.
DOI:10.1021/acs.jpclett.4c01445
3.
Liu, J., Ma, H., Shang, H. et al. Quantum-centric high performance computing for quantum chemistry. Physical Chemistry Chemical Physics, 2024, 26(22): 15831-15843.
DOI:10.1039/d4cp00436a
4.
Liu, J., Li, Z., Yang, J. Perturbative variational quantum algorithms for material simulations. Electronic Structure, 2024, 6(1): 015007.
DOI:10.1088/2516-1075/ad2277
5.
Zeng, X., Fan, Y., Liu, J. et al. Quantum Neural Network Inspired Hardware Adaptable Ansatz for Efficient Quantum Simulation of Chemical Systems. Journal of Chemical Theory and Computation, 2023, 19(23): 8587-8597.
DOI:10.1021/acs.jctc.3c00527
6.
Shang, H., Fan, Y., Shen, L. et al. Towards practical and massively parallel quantum computing emulation for quantum chemistry. npj Quantum Information, 2023, 9(1): 33.
DOI:10.1038/s41534-023-00696-7
7.
Lai, J., Fan, Y., Fu, Q. et al. Accurate and efficient calculations of Hellmann-Feynman forces for quantum computation. Journal of Chemical Physics, 2023, 159(11): 114113.
DOI:10.1063/5.0167444
Figure
1.
(a) The framework of Q2Chemistry. (b) A typical workflow of solving a chemical problem using a quantum algorithm.
Figure
2.
(a) Applying a single qubit gate on the MPS quantum state is simulated by simply a local contraction. (b) Applying a two-qubit gate on neighboring qubits generally has 2 steps: (i) reshape the two-qubit gate into a 4-dimensional tensor and contract with the qubits to form a two-qubit tensor; (ii) perform a singular value decomposition to restore the two-qubit tensor back to the MPS formulation. Postprocessing is usually required to maintain normalization or canonicalization of MPS tensors. (c) Auxiliary matrices that contain truncated and normalized singular values are used to normalize the quantum state.
Figure
3.
(a) The quantum circuit corresponding to the operator exp(iθ^σx^σy^σz^σx) and (b) the two-layer HEA circuit that entangles all neighboring qubits using the controlled-U gate. Blue squares represent nonparametric gates, while green squares represent parametric quantum gates such as Rz and the three-parameter (controlled-)U gate.
Figure
4.
Evaluating the expectation value of a linear combination of Pauli strings using multiple quantum devices or simulator processes. |0N⟩ represents an N-qubit quantum register with all qubits initialized to |0⟩. In this example, the measurement parts are the Hadamard test circuits.
Figure
5.
Simulating the Cr2 molecule using the MPS backend. The STO-3G basis set and the symmetry-reduced UCCSD ansatz are used, where the qubit Hamiltonian contains 305041 Pauli strings. The time cost refers to one VQE iteration (including evolution of the quantum circuit and calculation of energy) being tested. The distributed parallelization is implemented using OpenMPI and Python’s mpi4py package.
Figure
6.
(a) The VQE optimized potential energy curve of H2 calculated by the MPS backend using the ccJ-pVDZ basis set. The VQE results are calculated by interfacing with the external Julia-implemented MPS simulator. (b) Energy difference between EOM-ADAPT-C and classical EOM-CCSD band structures for Si. Inset gives the EOM-ADAPT-C band structure calculated using Q2Chemistry. The FCI and EOM-CCSD energies are obtained using the PySCF code.
Figure
Code Example 1. Interface to quantum devices in the qcircuit module.
References
[1]
Preskill J. Quantum Computing in the NISQ era and beyond. Quantum,2018, 2: 79. DOI: 10.22331/q-2018-08-06-79
[2]
McArdle S, Endo S, Aspuru-Guzik A, et al. Quantum computational chemistry. Rev. Mod. Phys.,2020, 92: 015003. DOI: 10.1103/RevModPhys.92.015003
[3]
Yung M H, Casanova J, Mezzacapo A, et al. From transistor to trapped-ion computers for quantum chemistry. Sci. Rep.,2014, 4 (1): 3589. DOI: 10.1038/srep03589
[4]
Tilly J, Chen H, Cao S, et al. The Variational Quantum Eigensolver: a review of methods and best practices. 2021. https://arxiv.org/abs/2111.05176. Accessed August 1, 2022.
[5]
Cerezo M, Arrasmith A, Babbush R, et al. Variational quantum algorithms. Nat. Rev. Phys.,2021, 3 (9): 625–644. DOI: 10.1038/s42254-021-00348-9
[6]
Magann A B, Arenz C, Grace M D, et al. From pulses to circuits and back again: A quantum optimal control perspective on variational quantum algorithms. PRX Quantum,2021, 2: 010101. DOI: 10.1103/PRXQuantum.2.010101
[7]
Fedorov D A, Peng B, Govind N, et al. VQE method: a short survey and recent developments. Mater. Theory,2022, 6: 2. DOI: 10.1186/s41313-021-00032-6
[8]
Cao Y, Romero J, Olson J P, et al. Quantum chemistry in the age of quantum computing. Chem. Rev.,2019, 119: 10856–10915. DOI: 10.1021/acs.chemrev.8b00803
[9]
Aspuru-Guzik A, Dutoi A D, Love P J, et al. Simulated quantum computation of molecular energies. Science,2005, 309: 1704–1707. DOI: 10.1126/science.1113479
[10]
Peruzzo A, McClean J, Shadbolt P, et al. A variational eigenvalue solver on a photonic quantum processor. Nat. Commun.,2014, 5: 4213. DOI: 10.1038/ncomms5213
[11]
Hempel C, Maier C, Romero J, et al. Quantum chemistry calculations on a trapped-ion quantum simulator. Phys. Rev. X,2018, 8: 031022. DOI: 10.1103/PhysRevX.8.031022
[12]
Nam Y, Chen J S, Pisenti N C, et al. Ground-state energy estimation of the water molecule on a trapped-ion quantum computer. npj Quantum Inf.,2020, 6: 33. DOI: 10.1038/s41534-020-0259-3
[13]
O’Malley P J J, Babbush R, Kivlichan I D, et al. Scalable quantum simulation of molecular energies. Phys. Rev. X,2016, 6: 031007. DOI: 10.1103/PhysRevX.6.031007
[14]
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
[15]
Colless J I, Ramasesh V V, Dahlen D, et al. Computation of molecular spectra on a quantum processor with an error-resilient algorithm. Phys. Rev. X,2018, 8: 011021. DOI: 10.1103/PhysRevX.8.011021
[16]
McClean J R, Romero J, Babbush R, et al. The theory of variational hybrid quantum-classical algorithms. New J. Phys.,2016, 18: 023023. DOI: 10.1088/1367-2630/18/2/023023
[17]
Lanyon B P, Whitfield J D, Gillett G G, et al. Towards quantum chemistry on a quantum computer. Nat. Chem.,2010, 2: 106–111. DOI: 10.1038/nchem.483
[18]
Higgott O, Wang D, Brierley S. Variational quantum computation of excited states. Quantum,2019, 3: 156. DOI: 10.22331/q-2019-07-01-156
[19]
McClean J R, Kimchi-Schwartz M E, Carter J, et al. Hybrid quantum-classical hierarchy for mitigation of decoherence and determination of excited states. Phys. Rev. A,2017, 95: 042308. DOI: 10.1103/PhysRevA.95.042308
[20]
Liu J, Fan Y, Li Z, et al. Quantum algorithms for electronic structures: basis sets and boundary conditions. Chem. Soc. Rev.,2022, 51: 3263–3279. DOI: 10.1039/D1CS01184G
[21]
McClean J R, Boixo S, Smelyanskiy V N, et al. Barren plateaus in quantum neural network training landscapes. Nat. Commun.,2018, 9 (1): 4812. DOI: 10.1038/s41467-018-07090-4
[22]
Napp J. Quantifying the barren plateau phenomenon for a model of unstructured variational ansätze. 2022. https://arxiv.org/abs/2203.06174. Accessed August 1, 2022.
[23]
Anschuetz E R, Kiani B T. Beyond barren plateaus: Quantum variational algorithms are swamped with traps. 2022. https://arxiv.org/abs/2205.05786. Accessed August 1, 2022.
[24]
Arute F, Arya K, Babbush R, et al. Hartree-Fock on a superconducting qubit quantum computer. Science,2020, 369 (6507): 1084–1089. DOI: 10.1126/science.abb9811
[25]
Huggins W J, O’Gorman B A, Rubin N C, et al. Unbiasing fermionic quantum Monte Carlo with a quantum computer. Nature,2022, 603 (7901): 416–420. DOI: 10.1038/s41586-021-04351-z
[26]
Bartlett R J, Kucharski S A, Noga J. Alternative coupled-cluster ansätze Ⅱ. The unitary coupled-cluster method. Chem. Phys. Lett.,1989, 155: 133–140. DOI: 10.1016/S0009-2614(89)87372-5
[27]
Taube A G, Bartlett R J. New perspectives on unitary coupled-cluster theory. Int. J. Quantum Chem.,2006, 106: 3393–3401. DOI: 10.1002/qua.21198
[28]
Steiger D S, Häner T, Troyer M. ProjectQ: an open source software framework for quantum computing. Quantum,2018, 2: 49. DOI: 10.22331/q-2018-01-31-49
Suzuki Y, Kawase Y, Masumura Y, et al. Qulacs: a fast and versatile quantum circuit simulator for research purpose. Quantum,2021, 5: 559. DOI: 10.22331/q-2021-10-06-559
[31]
Luo X Z, Liu J G, Zhang P, et al. Yao.jl: Extensible, efficient framework for quantum algorithm design. Quantum,2020, 4: 341. DOI: 10.22331/q-2020-10-11-341
[32]
Bergholm V, Izaac J, Schuld M, et al. PennyLane: Automatic differentiation of hybrid quantum-classical computations. 2018. https://arxiv.org/abs/1811.04968. Accessed August 1, 2022.
[33]
Cao C, Hu J, Zhang W, et al. Progress toward larger molecular simulation on a quantum computer: Simulating a system with up to 28 qubits accelerated by point-group symmetry. Phys. Rev. A,2022, 105: 062452. DOI: 10.1103/PhysRevA.105.062452
[34]
Bezanson J, Edelman A, Karpinski S, et al. Julia: A fresh approach to numerical computing. SIAM Review,2017, 59 (1): 65–98. DOI: 10.1137/141000671
[35]
Sun Q, Berkelbach T C, Blunt N S, et al. PySCF: the Python-based simulations of chemistry framework. WIREs Comput. Mol. Sci.,2018, 8: e1340. DOI: 10.1002/wcms.1340
[36]
Orús R. A practical introduction to tensor networks: Matrix product states and projected entangled pair states. Ann. Phys.,2014, 349: 117–158. DOI: 10.1016/j.aop.2014.06.013
[37]
Schollwöck U. The density-matrix renormalization group in the age of matrix product states. Ann. Phys.,2011, 326 (1): 96–192. DOI: 10.1016/j.aop.2010.09.012
[38]
Harris C R, Millman K J, van der Walt S J, et al. Array programming with NumPy. Nature,2020, 585 (7825): 357–362. DOI: 10.1038/s41586-020-2649-2
[39]
Virtanen P, Gommers R, Oliphant T E, et al. SciPy 1.0: fundamental algorithms for scientific computing in Python. Nat. Methods,2020, 17: 261–272. DOI: 10.1038/s41592-019-0686-2
[40]
Paszke A, Gross S, Massa F, et al. PyTorch: An imperative style, high-performance deep learning library. In: Wallach H, Larochelle H, Beygelzimer A, editors. Advances in Neural Information Processing Systems 32. New York: Curran Associates, Inc., 2019: 8024–8035.
[41]
Jordan P, Wigner E. Über das paulische äquivalenzverbot. Z. Physik,1928, 47: 631–651. DOI: 10.1007/BF01331938
[42]
Seeley J T, Richard M J, Love P J. The Bravyi-Kitaev transformation for quantum computation of electronic structure. J. Chem. Phys.,2012, 137: 224109. DOI: 10.1063/1.4768229
[43]
Tranter A, Love P J, Mintert F, et al. A comparison of the Bravyi-Kitaev and Jordan-Wigner transformations for the quantum simulation of quantum chemistry. J. Chem. Theory Comput.,2018, 14: 5617–5630. DOI: 10.1021/acs.jctc.8b00450
[44]
Liu J, Wan L Y, Li Z Y, et al. Simulating periodic systems on a quantum computer using molecular orbitals. J. Chem. Theory Comput.,2020, 16: 6904–6914. DOI: 10.1021/acs.jctc.0c00881
[45]
Fan Y, Liu J, Li Z Y, et al. Equation-of-motion theory to calculate accurate band structures with a quantum computer. J. Phys. Chem. Lett.,2021, 12 (36): 8833–8840. DOI: 10.1021/acs.jpclett.1c02153
[46]
Smith D G A, Gray J. opt_einsum - A Python package for optimizing contraction order for einsum-like expressions. J. Open Source Softw.,2018, 3 (26): 753. DOI: 10.21105/joss.00753
[47]
McClean J R, Sung K J, Kivlichan I D, et al. OpenFermion: The electronic structure package for quantum computers. 2017. https://arxiv.org/abs/1710.07629. Accessed August 1, 2022.
[48]
Liu J G, Zhang Y H, Wan Y, et al. Variational quantum eigensolver with fewer qubits. Phys. Rev. Res.,2019, 1: 023025. DOI: 10.1103/PhysRevResearch.1.023025
[49]
Haghshenas R, Gray J, Potter A C, et al. Variational power of quantum circuit tensor networks. Phys. Rev. X,2022, 12: 011047. DOI: 10.1103/PhysRevX.12.011047
[50]
Nguyen D, Mikushin D, Man-Hong Y. HiQ-ProjectQ: Towards user-friendly and high-performance quantum computing on GPUs. In: 2021 Design, Automation & Test in Europe Conference & Exhibition (DATE). IEEE, 2021: 1056–1061.
Jones T, Brown A, Bush I, et al. QuEST and high performance simulation of quantum computers. Sci. Rep.,2019, 9 (1): 10736. DOI: 10.1038/s41598-019-47174-9
[55]
Kottmann J S, Alperin-Lea S, Tamayo-Mendoza T, et al. TEQUILA: a platform for rapid development of quantum algorithms. Quantum Sci. Technol.,2021, 6 (2): 024009. DOI: 10.1088/2058-9565/abe567
[56]
Stair N H, Evangelista F A. QForte: An efficient state-vector emulator and quantum algorithms library for molecular electronic structure. J. Chem. Theory Comput.,2022, 18 (3): 1555–1568. DOI: 10.1021/acs.jctc.1c01155
[57]
McCaskey A J, Lyakh D I, Dumitrescu E F, et al. XACC: a system-level software infrastructure for heterogeneous quantum-classical computing. Quantum Sci. Technol.,2020, 5 (2): 024002. DOI: 10.1088/2058-9565/ab6bf6
[58]
Guo C, Liu Y, Xiong M, et al. General-purpose quantum circuit simulator with projected entangled-pair states and the quantum supremacy frontier. Phys. Rev. Lett.,2019, 123: 190501. DOI: 10.1103/PhysRevLett.123.190501
[59]
Guo C, Zhao Y, Huang H L. Verifying random quantum circuits with arbitrary geometry using tensor network states algorithm. Phys. Rev. Lett.,2021, 126: 070502. DOI: 10.1103/PhysRevLett.126.070502
[60]
Liu X, Guo C, Liu Y, et al. Redefining the quantum supremacy baseline with a new generation sunway supercomputer. 2021. https://arxiv.org/abs/2111.01066. Accessed August 1, 2022.
[61]
McCaskey A, Dumitrescu E, Chen M, et al. Validating quantum-classical programming models with tensor network simulations. PLoS ONE,2018, 13 (12): e0206704. DOI: 10.1371/journal.pone.0206704
[62]
Pfeifer R N C, Haegeman J, Verstraete F. Faster identification of optimal contraction sequences for tensor networks. Phys. Rev. E,2014, 90: 033315. DOI: 10.1103/PhysRevE.90.033315
[63]
Vidal G. Efficient classical simulation of slightly entangled quantum computations. Phys. Rev. Lett.,2003, 91: 147902. DOI: 10.1103/PhysRevLett.91.147902
[64]
Vidal G. Classical simulation of infinite-size quantum lattice systems in one spatial dimension. Phys. Rev. Lett.,2007, 98: 070201. DOI: 10.1103/PhysRevLett.98.070201
Gomez A N, Ren M, Urtasun R, et al. The reversible residual network: Backpropagation without storing activations. 2017. https://arxiv.org/abs/1707.04585. Accessed October 21, 2022.
[67]
Chen R T Q, Rubanova Y, Bettencourt J, et al. Neural ordinary differential equations. 2019. https://arxiv.org/abs/1806.07366. Accessed October 21, 2022.
[68]
Jones T, Gacon J. Efficient calculation of gradients in classical simulations of variational quantum algorithms. 2020. https://arxiv.org/abs/2009.02823. Accessed August 1, 2022.
[69]
Bulik I W, Henderson T M, Scuseria G E. Can single-reference coupled cluster theory describe static correlation? J. Chem. Theory Comput.,2015, 11 (7): 3171–3179. DOI: 10.1021/acs.jctc.5b00422
[70]
Grimsley H R, Claudino D, Economou S E, et al. Is the Trotterized UCCSD ansatz chemically well-defined? J. Chem. Theory Comput.,2020, 16: 1–6. DOI: 10.1021/acs.jctc.9b01083
[71]
Babbush R, McClean J, Wecker D, et al. Chemical basis of Trotter-Suzuki errors in quantum chemistry simulation. Phys. Rev. A,2015, 91: 022311. DOI: 10.1103/PhysRevA.91.022311
[72]
Bravyi S, Gambetta J M, Mezzacapo A, et al. Tapering off qubits to simulate fermionic Hamiltonians. 2017. https://arxiv.org/abs/1701.08213. Accessed August 1, 2022.
[73]
Yordanov Y S, Armaos V, Barnes C H W, et al. Qubit-excitation-based adaptive variational quantum eigensolver. Commun. Phys.,2021, 4 (1): 228. DOI: 10.1038/s42005-021-00730-0
[74]
Ryabinkin I G, Yen T C, Genin S N, et al. Qubit coupled cluster method: A systematic approach to quantum chemistry on a quantum computer. J. Chem. Theory Comput.,2018, 14 (12): 6317–6326. DOI: 10.1021/acs.jctc.8b00932
[75]
Ryabinkin I G, Lang R A, Genin S N, et al. Iterative qubit coupled cluster approach with efficient screening of generators. J. Chem. Theory Comput.,2020, 16 (2): 1055–1063. DOI: 10.1021/acs.jctc.9b01084
[76]
Grimsley H R, Economou S E, Barnes E, et al. An adaptive variational algorithm for exact molecular simulations on a quantum computer. Nat. Commun.,2019, 10: 3007. DOI: 10.1038/s41467-019-10988-2
[77]
Krylov A I. Equation-of-motion coupled-cluster methods for open-shell and electronically excited species: The hitchhiker’s guide to Fock space. Annu. Rev. Phys. Chem.,2008, 59: 433–462. DOI: 10.1146/annurev.physchem.59.032607.093602
[78]
Ollitrault P J, Kandala A, Chen C F, et al. Quantum equation of motion for computing molecular excitation energies on a noisy quantum processor. Phys. Rev. Res.,2020, 2: 043140. DOI: 10.1103/PhysRevResearch.2.043140
[79]
Benedikt U, Auer A A, Jensen F. Optimization of augmentation functions for correlated calculations of spin-spin coupling constants and related properties. J. Chem. Phys.,2008, 129 (6): 064111. DOI: 10.1063/1.2962973
Wan, L., Liu, J., Li, Z. et al. Hybrid Hamiltonian Simulation for Excitation Dynamics. Journal of Physical Chemistry Letters, 2024, 15(45): 11234-11243.
DOI:10.1021/acs.jpclett.4c02624
2.
Yao, Q., Ji, Q., Li, X. et al. Machine Learning Accelerates Precise Excited-State Potential Energy Surface Calculations on a Quantum Computer. Journal of Physical Chemistry Letters, 2024, 15(27): 7061-7068.
DOI:10.1021/acs.jpclett.4c01445
3.
Liu, J., Ma, H., Shang, H. et al. Quantum-centric high performance computing for quantum chemistry. Physical Chemistry Chemical Physics, 2024, 26(22): 15831-15843.
DOI:10.1039/d4cp00436a
4.
Liu, J., Li, Z., Yang, J. Perturbative variational quantum algorithms for material simulations. Electronic Structure, 2024, 6(1): 015007.
DOI:10.1088/2516-1075/ad2277
5.
Zeng, X., Fan, Y., Liu, J. et al. Quantum Neural Network Inspired Hardware Adaptable Ansatz for Efficient Quantum Simulation of Chemical Systems. Journal of Chemical Theory and Computation, 2023, 19(23): 8587-8597.
DOI:10.1021/acs.jctc.3c00527
6.
Shang, H., Fan, Y., Shen, L. et al. Towards practical and massively parallel quantum computing emulation for quantum chemistry. npj Quantum Information, 2023, 9(1): 33.
DOI:10.1038/s41534-023-00696-7
7.
Lai, J., Fan, Y., Fu, Q. et al. Accurate and efficient calculations of Hellmann-Feynman forces for quantum computation. Journal of Chemical Physics, 2023, 159(11): 114113.
DOI:10.1063/5.0167444
Table
1.
Computational resources required to perform VQE simulations for a number of molecules using the unitary coupled-cluster ansatz truncated up to double excitations (UCCSD) and the minimum basis set STO-3G. UCCGSD means that generalized excitation operators (not distinguishing occupied and virtual orbitals) are used. The way to count CNOT gates is described in the supporting information.
Table
2.
Backends for circuit simulations in present open-source quantum computation softwares. External indicates that one or more third-party packages are required to enable the functionality. SA stands for single-amplitude simulation.