Abstract
The simulation of multidimensional wave propagation with variable material parameters is a computationally intensive task, with applications from seismology to electromagnetics. While quantum computers offer a promising path forward, their algorithms are often analyzed in the abstract oracle model, which can mask the high gate-level complexity of implementing those oracles. We present a framework for constructing a quantum algorithm for the multidimensional wave equation with a variable speed profile. The core of our method is a decomposition of the system Hamiltonian into sets of mutually commuting Pauli strings, paired with a dedicated diagonalization procedure that uses Clifford gates to minimize simulation cost. Within this framework, we derive explicit bounds on the number of quantum gates required for Trotter–Suzuki-based simulation. Our analysis reveals significant computational savings for structured block-model speed profiles compared to general cases. Numerical experiments in three dimensions confirm the practical viability and performance of our approach. Beyond providing a concrete, gate-level algorithm for an important class of wave problems, the techniques introduced here for Hamiltonian decomposition and diagonalization enrich the general toolbox of quantum simulation.
1. Introduction
Wave equations are fundamental for modeling a wide range of physical phenomena, from acoustic and seismic wave propagation to electromagnetic fields and quantum mechanics [1,2]. Numerically simulating these equations, especially in high dimensions and in the presence of heterogeneous material properties, remains computationally demanding for classical computers. While finite-difference and finite-element methods are widely used, they often suffer from the “curse of dimensionality”, where computational costs increase exponentially with the number of spatial dimensions [2,3]. This scaling imposes a significant bottleneck on applications requiring high-resolution models in three or more dimensions, such as full-waveform inversion in geophysics [4,5] or detailed optical simulations [6].
Quantum computing presents a promising avenue for overcoming these limitations. By exploiting the inherent parallelism of quantum states, quantum algorithms can achieve exponential speedups for certain linear algebra tasks and differential equation solvers [7,8]. Recent advancements have made significant strides in creating quantum algorithms tailored for partial differential equations (PDEs), notably the wave equation. Previous studies have demonstrated the efficacy of quantum algorithms employing an oracle to probe the wave speed profile [9,10]. In contrast, different studies have concentrated on more practical applications concerning one-dimensional scenarios where the speed remains constant [11,12,13]. An important challenge remains in creating clear, non-oracle methods for high-dimensional wave equations with changing speed coefficients, which are vital for accurate physical modeling. A recent study introduced an effective oracle-based solution for this task [14], employing an oracle technique that, while scalable, necessitates more ancilla qubits and incurs further overhead.
Our approach addresses this gap and builds on prior methods for Pauli decomposition of sparse matrices [15,16], extending them to arbitrary multidimensional wave problems with general and block-structured variable speed profiles. We derive explicit expressions for the number of Pauli strings, the structure of mutually commuting sets, and the corresponding diagonalization circuits. Exploiting these structures, we provide upper bounds on the number of one- and two-qubit gates required for first-order and higher-order Trotter approximations. Furthermore, by incorporating block-structured velocity profiles—common in practical applications such as layered media [5]—we demonstrate substantial reductions in circuit complexity, highlighting the advantage of leveraging problem-specific structure.
To support the theoretical scaling, we offer numerical simulations for a 3D wave equation featuring block-structured speed profiles. The results illustrate the effectiveness of our decomposition method and confirm the predicted scaling of Pauli term counts. Our analysis shows that the proposed quantum algorithm alleviates the classical “curse of dimensionality”, providing a practical approach to modeling wave dynamics in high-dimensional spaces.
The article begins by outlining the general problem of the multidimensional wave equation as framed for quantum algorithms in Section 2, including essential definitions. The main results are detailed in Section 3, with Section 3.1 covering Pauli decomposition, Section 3.2 focusing on diagonalization, Section 3.3 addressing the scaling of the multidimensional problem, and Section 3.4 examining the block speed scenario. Numerical simulations for the three-dimensional wave equation are presented in Section 3.5, followed by a discussion in Section 4 and concluding remarks in Section 5. Details on discretization and vectorization are provided in Appendix A; Appendix B contains the example of quantum algorithm construction, while Appendix C compares the classical finite difference approach with a developed algorithm in case of standing wave in terms of number of operations. Finally proofs of propositions are in Appendix D.
2. Materials and Methods
The wave equation set in D dimensions, characterized by variable speed and adhering to zero boundary conditions, is expressed as follows
where and is the length of the corresponding dimension.
After discretization and vectorization denoted as (details are shown in Appendix A), we can write this in matrix–vector format as
where is the tensor for the function in a given domain, F is the tensor for the function in a given domain, and G is the tensor for the function in a given domain. The discrete operator is
where S is the diagonal matrix with diagonal given by vectorized speed profile tensor C, which is discrete representation of in a given domain, that is, , and is the first order forward first derivative approximation operator with explicit boundary conditions (first and last rows are zeros, as well as first and last columns). With this choice of , the boundary conditions are incorporated into .
2.1. Formulation as Schrödinger Equation
Following [9,16], consider the Schrödinger equation using the Hamiltonian
where , with , , being the matrix approximation of the first derivative with incorporated zero boundary conditions in a manner consistent with [16]. It is important to mention that typically, the size of matrix may vary across dimensions; however, for the present discussion, we assume it is the same. The matrices have the dimensions , while the Hamiltonian is sized . At present, we set ; extending this setup is straightforward since can be supplemented with zero matrices, which have no effect on the Pauli decomposition.
In order to incorporate a variable speed profile in this Hamiltonian, we consider
where , and I is the identity matrix of the same size.
Differentiating the Schrödinger equation over time, given the Hamiltonian in (5), we get
where , are some additional components in the wavefunction and . Note that if matrix B is a finite difference approximation of the first derivative, then its negative transpose, and is also an approximation. Specifically, employs the mirror scheme: it yields a backward scheme if B uses a forward scheme, a forward scheme if B uses a backward scheme, and remains a central scheme if B is central. We can see now that the first component indeed evolves according to (2). One way to set the initial condition of the Schrödinger equation is
Putting this together, the quantum algorithm for solving (1) reduces to preparing and evolving the state
We then postselect on the first component of (). While postselection, initialization, and the design of a suitable cost function are all very challenging tasks, in this work we focus on implementing the propagator using one- and two-qubit gates.
Remark 1.
If the right hand side of the wave Equation (1) is given by , one can use and consider the first component in the wavefunction as . This way the component changes over time according to , which is effectively a form of . Initial conditions in this case can be set as , and . This does not affect the results presented here since they are based on decompositions of S and .
2.2. Propagator Implementation Technique
To execute the propagator on a quantum device, it must be broken down into operations that can be performed on such a device. This can be achieved by expressing as a sum of Pauli strings, which are tensor products of Pauli matrices, and then applying the Trotter formula [17,18]. For comprehensive definitions, the reader is directed to Section 2 of [15]; here, we will only present the key concepts.
To express Pauli strings with X and Z matrices, we use bit strings ; with them, an arbitrary Pauli string can be defined as the image of the extended Pauli string operator (Walsh function) as follows
with the matrix product between and and denoting the inner product of two bitstrings. It can be seen that the Walsh function is bijective. Thus, each Pauli string can be encoded with a unique pair , and decomposition in the Pauli basis can be rewritten as
where , and as shown in the proof of Proposition 4 of [15], the coefficients can be expressed in the form
where ⊕ is a binary XOR (addition modulo 2) operation and are elements of , which makes it possible to compute coefficients in decomposition with operations.
As the strings in the decomposition do not all commute with each other, the Trotter formula can be utilized, offering different accuracy levels depending on the formula’s order. This approach is employed to manage the non-commutative characteristics of the operators involved in the decomposition. Building upon prior studies [15,16], we express as , where each consists of mutually commuting Pauli strings. The Trotter formulas for orders 1, 2, and higher even orders , where , are represented as
where . The approximation accuracy is determined by the number of Trotterization steps r, the evolution time t, the order p of the Trotter formula, and the Hamiltonian norm.
3. Results
This section outlines our findings in the form of propositions and corollaries. We express the propagator for the multidimensional wave equation using single and two qubit operations as follows:
- We expand on the decomposition of Pauli strings as described in [16] to apply it to the wave equation in D dimensions (Proposition 1).
- We present a method for efficiently diagonalizing mutually commuting groups that emerge during decomposition (Proposition 2).
- We establish an upper bound and scaling on the complexity involved in solving the multidimensional wave equation with a variable speed profile using the Trotterization algorithm in terms of single- and two-qubit operations (Corollaries 2 and 3).
- We examine the practical scenario of a wave equation in D dimensions, characterized by a variable speed profile with a block structure and establish its upper bound and scaling (Corollary 4).
- We demonstrate the algorithm’s numerical performance on the three-dimensional wave equation with a block-structured speed profile (Section 3.5). We also compare the finite-difference method (FDM) with the quantum algorithm presented here for a three-dimensional standing wave, reporting the number of operations required to achieve the same accuracy (Appendix C).
3.1. Pauli String Decomposition
We extend the results presented in Proposition 1 from [16], particularly focusing on the case of a block Hamiltonian H with dimensions .
Proposition 1
(Decomposition of a block Hamiltonian). The only Pauli strings that can have non-zero coefficients in the decomposition of matrix
where , , are d-diagonal matrices with , described by , where and
where , , , , . Moreover, the main diagonals of are represented by , with
where .
Here, function returns the number of bits necessary to represent D in binary form. Meanwhile, provides the binary form of b with a specified length a, padding with leading zeros if necessary. The symbol ∗ denotes the concatenation of binary strings.
It is noteworthy that if is not a power of 2, this proposition can still be utilized by appending matrices for , where is defined as . The d-diagonal matrices referenced in the proposition allow for enhanced accuracy of differential operators. Specifically, the three-diagonal matrices with d = 1 (where d denotes the count of diagonals above the main diagonal) will represent the first-order accurate differential operators.
All Pauli strings with non-zero coefficients in the decomposition are part of the sets labeled by and , as described below:
In each set represented by and , the elements are generated with , which are the binary representation of numbers from 0 to of length . Therefore, the cardinality of each set is . Furthermore, if is a power of 2, the cardinality can also be expressed as . Utilizing this proposition alongside Proposition 2 from [16], we formulate the ensuing corollary.
Corollary 1
(Number of sets in a block Hamiltonian). The total count of sets (including ) in the decomposition of Hamiltonian (15) with a d-band matrices , where is given by
where is the binary length of d.
We group the sets from Equation (18) into mutually commuting subsets, a result that aligns with previous findings [15,16].The assignment to a subset is determined by whether a Pauli string contains an odd or even number of Y matrices (i.e., the value of ), as stated in Corollary 2 of [16]. In the specific case of a real-valued matrix, all Pauli strings have an even number of Y matrices, which leads to mutually commuting sets.
3.2. Mutual Diagonalization
In Proposition 1 we have provided strings , which generate mutually commuting sets based on parity of Y operators (value of ). We outline the diagonalization process for these sets, drawing upon [19,20], and present it as the subsequent proposition.
Proposition 2
(Diagonalization of sets). Given the set of mutually commuting operators, characterized by a string , that is, or one can construct diagonalization operator , such that , with as
where is a controlled-NOT operation with control on the c-th qubit and target on the t-th qubit; and are Hadamard and phase gates acting on the k-th qubit, respectively. The product runs over all indices of the nonzero bits in , where M is the total number of these bits and is the index of the first nonzero bit. This procedure yields the string , which is identical to except that its -th bit is set to 1.
This proposition enables the diagonalization of any set of mutually commuting operators using only the corresponding string . The number of one- and two-qubit gates required for this diagonalization is determined by the parity of : it is M if and if , where M is the number of nonzero bits (Hamming weight) in . Additionally, the proposition provides the outcome of the diagonalization, that is, string .
3.3. Scaling of Multidimensional Wave Equation Quantum Algorithm
Using general results presented in previous sections, we formulate the following proposition made specifically for the multidimensional wave equation.
Proposition 3
(Decomposition of multidimensional wave equation Hamiltonian). The Hamiltonian for the D-dimensional wave problem stated as (1) can be written as
where with - d-diagonal matrices, with , and diagonal matrix . Given Pauli decomposition , where , with being the k-th bit in , the number of Pauli strings that can have non-zero coefficients in the decomposition of matrix is bounded by , where is the number of mutually commuting sets in , and K is the number of Pauli strings in the single set. T is the number of Pauli strings in the decomposition of .
The Hamiltonian can be directly subjected to Proposition 1 and Corollary 1 with no alterations. The form of the Pauli strings in the decomposition remains essentially the same. To convert H into , one simply needs to insert extra identity (I) matrices at the qubit locations that align with the structure of the operators. In the binary representation of the Pauli strings using vectors and , this operation corresponds to adding zeros at the appropriate bit locations.
It is also observed that the number of mutually commuting sets in is identical to that in because represents a diagonal matrix. According to Corollary 1, this count is denoted by , owing to the real-valued nature of . If the number of diagonals d above the main is significantly less than N, a situation common with finite difference approximation matrices , the number of commuting sets can be approximated by . The count of Pauli strings K contained within a single commuting set can be bounded by since only strings with an even number of Y Pauli matrices participate in the decomposition. Consequently, the overall number of Pauli strings that appear in can be expressed as , where T denotes the number of Pauli strings used in the decomposition of . Furthermore, in cases where , the estimation may be modified to
From this result, we can estimate the number of one- and two-qubit gates required for a single Trotter step that realizes the time evolution operator . The construction of one Trotter step requires the diagonalization of each of the mutually commuting sets of Pauli strings. Recall that a Pauli string can contain non-zero bits solely within the initial places and the n locations specified by j in . Based on Proposition 2 and given the condition , the count of one- and two-qubit gates necessary for the diagonalization and reverse diagonalization of a single set is limited by
Diagonalized Pauli strings are composed solely of Z operators. These can be executed using multi-qubit rotations denoted by , where represents the modified string in each respective diagonal group. The sequence of these rotations is organized in such a way as to optimize their implementation by reducing the number of CNOT gates required, achieved through minimizing the Hamming distance between successive strings [21] (see a circuit example for a single group in Appendix B). Without particular assumptions about the configuration of , we employ a worst-case scenario in which every sequence is composed entirely of ones, with no cancellations occurring. This provides an upper limit of CNOT gates for each rotation since the maximum number of CNOTs needed for an m-qubit rotation is [21]. Hence, the total number of gates necessary for realizing all rotations within a single diagonal configuration is bounded by .
By bringing these components together, the total number of one- and two-qubit gates required for each single step of the first-order Trotter–Suzuki decomposition to approximate is constrained by
where
- represents the number of sets of Pauli strings that internally mutually commute;
- is the gate count for diagonalization operators per set;
- represents the gate count for implementing the diagonal rotations per set. We relied on the estimation as suggested by Proposition 1.
Therefore, the explicit bound in case for one step of first order Trotter formula is
For higher-order Trotter–Suzuki formulas of even order p [17,18], the gate count scales as
We formalize the scaling for a single Trotter step in the following corollary.
Corollary 2
(One Trotter step scaling). Given the Hamiltonian
where with - d-diagonal matrices, with , and diagonal matrix with T strings in decomposition. The number of one- and two-qubit gates for one step of first order Trotter formula for with assumptions and scales as
This process can be made more efficient with a few methods. To start, the Hamming distance between neighboring bitstrings should be reduced. This configuration aids in eliminating CNOT gates used for executing the multi-qubit rotations. Secondly, an analogous improvement is realized by tactically reordering the sets, which facilitates the elimination of CNOT gates produced during the diagonalization process. Moreover, the arrangement of these sets constituting can be utilized to lessen the number of gates, as illustrated in Section 3.4.
Finally, by employing Corollary 2, we shall illustrate the scaling of one- and two-qubit gates required for executing the propagator using the Trotter formula of order p. The scaling can be expressed as , where denotes the count of gates per trotter step of p-th order, and r represents the total number of steps needed to achieve an error of . In this context, serves as the Trotter approximation for . To determine r, we utilize the scaling outlined by the authors in [17], specifically
where denotes the quantity of easy to implement Hamiltonians (in our case, we choose it to be mutually commuting sets) within . We can approximate the Hamiltonian norm by because the matrices in function as finite difference operators, which inherently contain the inverse of the discretization step size . The subsequent corollary outlines the scaling requirements essential for constructing a quantum circuit that sets up the propagator for the D-dimensional wave equation, denoted as , with a margin of error .
Corollary 3
(Scaling for multidimensional wave equation quantum algorithm). Given the Hamiltonian for D-dimensional wave equation as
where with - d-diagonal matrices, with , and diagonal matrix with T strings in decomposition, the number of one- and two-qubit gates required to implement a p-th order Trotter approximation with r steps, satisfying scales as
assuming and .
The suggested approach mitigates the “curse of dimensionality” in a manner similar to the oracle-based method discussed in [9]. According to Corollary 2, the gate complexity for one Trotter step predominantly scales with the factor, which varies linearly with the system size, where . Nevertheless, the total complexity is primarily determined by the number of steps needed to reach the desired precision. When utilizing a p-th order Trotter formula, the dominant scaling factor is . The extra scaling related to N stems from the finite difference approximation, which requires a step size that is contingent upon N.
3.4. Scaling of Multidimensional Wave Equation Quantum Algorithm with Block-Model Speed Profile
In this section, we adopt a block-model representation in which the domain is partitioned into regions of constant wave speed (acoustic approximation). This assumption is widely used because it simplifies the forward problem, provides clear correspondence between model parameters and geological interfaces, and enables efficient numerical implementation. However, it should be noted that real Earth materials rarely consist of perfectly homogeneous blocks. In practice, velocity and density typically vary smoothly due to compaction, mineral composition, and fluid content, and fine-scale heterogeneity introduces scattering and waveform complexity that are not captured in block models [22]. As a result, the block approximation can overestimate reflection amplitudes at sharp interfaces and underestimate energy redistribution into scattered or coda waves. Nevertheless, when seismic wavelengths are large relative to heterogeneity scales, block models offer a reasonable first-order description of wave kinematics, particularly for traveltime and phase analyses.
Consider a computational domain of size , discretized uniformly into , , and segments along the x, y, and z axes, respectively. The total number of distinct material blocks, and thus the number of independent variables in the system, is given by . Moreover, the vectorized velocity profile , with C being a tensor representation of , can be expressed as a linear combination of Pauli operators as follows:
where , with being the k-th bit in . This formulation demonstrates that the operator S is decomposed into a sum of T Pauli terms. Each term corresponds to a diagonal Pauli string (composed of I and Z operators) acting on the qubits that encode the model parameterization, while identity operators act on the remaining qubits that correspond to a size of block in particular direction.
The number of terms in this decomposition is precisely equal to the number of variables, T, and the generalization to the multidimensional case is straightforward. To estimate the gate complexity of implementing the operator , one must account for an ancillary register of size qubits. Crucially, the block structure of S given by Equation (32) provides a significant reduction in computational complexity. We leverage this by reformulating Corollaries 2 and 3 for the block-model speed profile.
Corollary 4
(Scaling for block-model speed profile). Given the Hamiltonian
where with - d-diagonal matrices, with , and a real diagonal matrix S, given as
The number of one- and two-qubit gates for one step of first order Trotter formula for with assumption scales as
Consequently, under the same assumptions the number of one- and two-qubit gates required to implement a p-th order Trotter approximation with r steps, satisfying , scales as
The manner in which the system scales is dictated by the configuration of the resulting sets of Pauli operators. According to Proposition 1, one can systematically generate the entire set of possible bit strings .
Given a binary string , the strings are formulated in the following manner:
- In the case where , the non-zero elements of the strings are constrained to the positions directly specified by the structure of the matrix . For example, given , the Pauli strings associated with are the same as in decomposition of B but are padded with identity operators (I). This corresponds to appending zeros to both the and strings.
- For a general parameter , if the velocity profile adheres to the structure defined in Equation (34), the number of positions in the strings that can support non-zero values increases. Specifically, an additional bits must be considered. These correspond to the first m bits in each of the D spatial directions within the string.
Therefore, the number of Pauli strings in a single set can be bounded as , where the term appears because, for a single dimension in the considered set, all bits are already accounted for in the implementation of B. Moreover, in this scenario, Gray code ordering can be applied within each mutually commuting set, allowing the elimination of certain CNOT gates and thus reducing the number of gates required to implement rotations for a single group to .
To illustrate this we present the full set of strings and corresponding masks for as described above for a three-dimensional wave equation—discretized with 2 qubits per dimension and with finite difference operators approximated by tridiagonal matrices () in Table 1 for different values of m.
Table 1.
Example of all possible Pauli strings for the three-dimensional wave equation, discretized with 2 qubits per dimension and with finite difference operators approximated by tridiagonal matrices (). The strings (where due to ) are generated according to Proposition 1. The corresponding masks for the strings are shown for different values of m in the block speed model; a “∗” denotes a position that can be either 0 or 1. Bits are grouped for readability: the first bits are used for the Hamiltonian construction, and each subsequent block of bits encodes a spatial direction.
The number of strings that must be considered can be reduced by leveraging the decomposition of the specific matrix . However, in this work, we consider an arbitrary diagonal structure as a more general approach that enables the explicit encoding of boundary conditions, as demonstrated in [16].
3.5. A Three-Dimensional Wave Equation in a Numerical Example
As a practical example of our approach, we conducted a numerical simulation focusing on the three-dimensional wave Equation (). A finite-difference scheme is employed to discretize the problem on a regular grid, with each spatial dimension depicted by n qubits, leading to grid points for each dimension. The tridiagonal () matrices provide an approximation for the finite-difference operators, and we utilize the block speed model described in Equation (32). The task at hand involves computing the implementation of the propagator , where the Hamiltonian is defined as
with , , . Here, , and B is a tridiagonal matrix incorporating zero boundary conditions [15].
Direct classical simulation of is computationally hard. For instance, a discretization with qubits ( points) per dimension requires exponentiating a matrix of size . For realistic scenarios requiring high resolution (e.g., , or points per dimension), direct classical computation of the propagator becomes intractable.
For this physically meaningful resolutions—e.g., so grid points per axis—the state dimension is , and even a single sparse matvec becomes impractical on commodity hardware. These constraints motivate our validation approach: rather than attempting end-to-end classical time evolution at large sizes, we (i) normalize the geometry and evolution time (, ) to isolate algorithmic—not unit—scaling; (ii) adopt a randomized block speed field on a partition so that is representative (avoiding degenerate cases that would understate Trotter costs); and (iii) evaluate quantities that directly determine quantum resource scaling—namely, the number of Pauli terms and the gate count per first-order Trotter step—without reconstructing the full propagator. Where feasible (e.g., ), we still perform a functional check against a classical reference using expm_multiply, but the principal evidence comes from structural counts that (by Propositions 3 and Corollary 4) control the asymptotic behavior. This strategy preserves fidelity to the “hard part” of the problem—captured by the term structure and —while remaining computationally tractable across the range of needed to reveal the predicted scaling trends.
Therefore, to efficiently yet rigorously examine the scaling characteristics of our quantum algorithm, we employ a representative parameterization that encapsulates the essential complexity:
- Time of evolution .
- Domain lengths .
- A block speed model with random elements from the range , encoded with an equal number of qubits m per direction.
- An equal number of qubits per dimension n.
For the Hamiltonian , the maximum possible number of gates (Proposition 3) is represented by , where is the number of sets containing mutually commuting Pauli strings (Equation (19)), and is the number of Pauli strings per set. In the block speed model (Section 3.4), we find that . Thus, the limit turns into
Figure 1 illustrates the findings of the numerical simulation. We expressed the Hamiltonian as a sum of Pauli strings and identified how many of these terms had non-zero coefficients. This decomposition was achieved by forming terms as outlined in Proposition 1 and evaluating their respective coefficients. For systems with qubits per dimension, we fully reconstructed the Hamiltonian from its Pauli decomposition and verified its equivalence to the original matrix to validate our method. For , direct reconstruction becomes computationally prohibitive; therefore, we relied solely on the coefficient computation routine without full matrix reconstruction. The plot displays the counts of the resulting Pauli terms as crosses, and the theoretical upper limit from Equation (38) is represented by a dotted line.
Figure 1.
Number of non-zero Pauli terms in the decomposition of the Hamiltonian given by Equation (37). Empirical data (crosses), obtained with randomized velocity profiles for various block sizes m, are compared against the theoretical upper bound from Equation (38) (dotted line). The results demonstrate the scaling of the term count with the number of discretization qubits n for different values of m.
The empirical results reveal that the calculated upper bound closely estimates the actual count of Pauli strings. This difference arises from the distinctive configuration of the finite-difference matrix B used in our simulation. While the theoretical limit is formulated for any tridiagonal matrix, our approach uses a typical first-order stencil with matrix B having on the main diagonal and 1 on the upper diagonal. This specific arrangement results in a more efficient Pauli decomposition, needing about strings for each operator, as opposed to the general maximum of .
The number of gates required for a single iteration of a p-th order Trotterization is based on the first-order equation as presented in Equation (26). Consequently, our analysis prioritizes the numerical validation of the first-order estimate. For the Hamiltonian , Equation (24) provides the upper limit on the gate count for one step of a first-order Trotterization, expressed as . Here, denotes the number of sets containing commuting Pauli strings, represents the gate count required to diagonalize an individual set, and signifies the gate count to execute the diagonal rotations in a diagonalized set.
For the block speed model, it is possible to utilize Gray code ordering within each mutually commuting set. This approach allows for further elimination of CNOT gates, thereby reducing the limit to . Previously, in Corollary 4 it was established that the block speed model restricts the number of Pauli strings per set by . Thus, the limit on the number of one- and two-qubit gates for a first-order step is
Figure 2 illustrates the results of the numerical simulation, showing how the gate counts vary with the number of qubits per dimension. We created a software program designed to produce a circuit corresponding to one Trotter step and for each collection of commuting Pauli strings. Each group’s circuit is output in QASM format for later integration into several Trotter steps. Following this, the overall gate count was ascertained from these output files. In systems where the qubit count is small, specifically , we confirmed that the circuit constructed for a single group of mutually commuting operators accurately realizes . Here, represents a Hamiltonian made up exclusively of Pauli strings from that group.
Figure 2.
Gate count for a single first-order Trotter step of the Hamiltonian . Empirical data (crosses), obtained from compiled QASM circuits, are compared against the theoretical upper bound from Equation (39) (dotted line). The results demonstrate the scaling of the gate count with the number of discretization qubits n for different velocity block sizes m.
In Figure 2, the experimental results, indicated by crosses, are slightly beneath the theoretical limit outlined in Equation (39), represented by the dotted line. This is attributed to circuit optimization techniques applied during compilation. The CNOT gates in the diagonalization circuits of each set can cancel each other out if placed in a specific order, providing a slight optimization benefit. However, the main impact comes from performing the diagonal component.
Additionally, to validate the functional correctness of the algorithm, we examined a specific instance with fixed parameters and . This corresponds to solving the wave equation on a grid (), partitioned into velocity blocks per dimension, resulting in a total of 64 individual blocks, each of size and assigned a unique velocity value. For this configuration, we verified that the implemented quantum circuit accurately approximates the action of the target unitary .
We assessed the accuracy by setting the initial condition to a random wavefunction and comparing the statevector produced by our algorithm against a classical reference computed using the “scipy.sparse.linalg.expm_multiply” function in Python. Specifically, we compute the error
where is the state obtained from our quantum algorithm using r Trotter steps of order p.
Figure 3 illustrates how the error varies with both the quantity of Trotter steps and the Trotter order. As anticipated, the error diminishes when the number of steps or the formula’s order is raised. This outcome confirms our implementation and offers a pragmatic calculation of the Trotter steps needed to reach a specified error threshold.
Figure 3.
Trotter error scaling for the Hamiltonian with fixed parameters , . The error given by (40) is plotted against the number of Trotter steps r for different Trotter orders p. The results validate the algorithm and demonstrate the expected convergence with increasing r and p.
Conducting a more thorough validation requires calculating the operator norm error and assessing it against the bound in Corollary 4. Nevertheless, this calculation turns out to be computationally infeasible using classical methods for the matrix dimensions we are dealing with, even when n and m are relatively small.
4. Discussion
We introduced a structured quantum algorithm for simulating the multidimensional variable-coefficient wave equation. The method begins with a Hamiltonian formulation and a decomposition into Pauli strings—tensor products of . This representation affords a clear physical interpretation: Z terms encode diagonal energy shifts, whereas X and Y terms generate off-diagonal transitions between basis states.
Our main contribution is a systematic extension of bounds on only relevant Pauli strings and their generation for Hamiltonians with a special block structure, together with a partition of these strings into commuting sets that admit efficient diagonalization (Propositions 1 and 2). This customizes and generalizes prior decomposition strategies [15,16] to the setting of variable-coefficient, multi-dimensional wave equations.
A second contribution is the establishment of precise gate complexity limits for calculating time evolution operators expressed as . Our analysis indicates that, given assumptions applicable to physical models, the gate complexity for a single Trotter step increases linearly with the size of one dimension N (Corollary 2). Nevertheless, employing Trotter–Suzuki formulas adds extra overhead: the gate complexity for the complete algorithm utilizing a p-th order Trotter formula scales as with respect to the size of a single dimension (Corollary 3). This result is significant because it tackles the challenge posed by the “curse of dimensionality”, which hinders the functionality of conventional wave equation solvers that typically scale as [1,2].
In contrast to oracle-based strategies [9] (with a 1D implementation in [12]), our algorithm specifies deterministic circuits in terms of one- and two-qubit gates. Although oracle-based methods may exhibit superior asymptotic query complexity, their constant factors and ancilla requirements can be substantial in regimes relevant to near-term problems [12]. Consequently, despite worse asymptotics, our explicit construction is often more practical at modest scales and enables precise resource estimation. Related oracle-dependent works [10,14] demonstrate scalability but at the cost of extra ancillas. For constant-speed models, ref [13] employs the Bell-basis approach to efficiently diagonalize each term of the Hamiltonian, yielding the same diagonalization as our method, while [11] demonstrates hardware experiments using Fourier transforms; however, these techniques do not directly extend to variable-speed profiles. In summary, relative to these lines of work, our algorithm provides explicit higher-dimensional resource bounds while accommodating variable coefficients.
For block-structured speed profiles, our analysis (Corollary 4) shows that respecting physical structure can materially reduce cost: the complexity simplifies to when m qubits encode each block parameter (for a total of distinct speeds). Such piecewise-homogeneous models are common in seismic and acoustic imaging [5], making this specialization particularly relevant.
Three-dimensional simulations corroborate the predicted trends and indicate that rotation scheduling within each diagonal group can further reduce cost [21]. These optimizations are compatible with our commuting-set framework and offer practical gains without altering asymptotics.
Our use of Trotter–Suzuki decomposition entails the usual trade-off between accuracy and depth. Techniques such as qubitization [23] and linear combinations of unitaries [24] may improve asymptotic performance but generally require additional ancillas and more elaborate control logic. Moreover, our present estimates omit measurement overhead, cost-function construction, noise, and limited connectivity, all of which are consequential in the NISQ regime [25,26]. Closing these gaps is a necessary step toward end-to-end application benchmarks.
Beyond PDEs, the proposed Pauli decomposition and commuting-set diagonalization extend naturally to Hamiltonians with short-range interactions, where matrix elements cluster near the diagonal. Reducing non-commuting terms directly lowers measurement cost in variational and hybrid schemes [27,28]. The framework is also complementary to advances in randomized simulation [29], qubitization [23], and Schrödingerization [30]. We anticipate fruitful combinations that retain the structural advantages of our decomposition while improving asymptotic scaling.
Overall, the results advance quantum simulation of the wave equation in higher dimensions with variable coefficients, delivering explicit gate counts, deterministic circuit structure, and a pathway to exploiting block heterogeneity. We expect the practical advantage over oracle-based techniques observed in lower-dimensional, structured instances [15] to persist in 3D, though a like-for-like quantitative comparison remains open due to the absence of clear oracle constructions in this setting. Future work will integrate advanced simulation primitives and incorporate hardware-aware compilation and error mitigation to translate the present complexity gains into experimentally validated performance.
5. Conclusions
We have developed a general framework for quantum simulation of the multidimensional wave equation using Pauli string decomposition, diagonalization of commuting operator sets, and Trotterized time evolution. The method provides rigorous gate-complexity bounds and shows favorable scaling, particularly for the block speed model. Numerical validation in three dimensions confirms both the theoretical predictions and the potential for additional reductions through circuit-level optimization.
These results demonstrate that quantum computing can offer practical advantages for simulating high-dimensional wave dynamics, a class of problems that remain computationally demanding for classical solvers. Future directions include integrating qubitization and other advanced simulation techniques as well as designing hardware-aware circuit optimizations. The presented approach establishes a foundation for scalable quantum algorithms with applications in geophysics, nondestructive testing, and materials science.
Author Contributions
Conceptualization, B.A. and I.Z.; software, B.A.; validation, B.A. and I.Z.; formal analysis, B.A.; writing, review and editing, B.A. and I.Z. All authors have read and agreed to the published version of the manuscript.
Funding
This research received no external funding.
Data Availability Statement
The original data presented in the study are openly available in GitHub repository at https://github.com/barseniev/d_dim_quantum_wave_solver (accessed on 9 October 2025).
Acknowledgments
The authors acknowledge the use of Skoltech’s Zhores supercomputer [31] for obtaining the numerical results presented in this paper.
Conflicts of Interest
The authors declare no conflicts of interest.
Abbreviations
The following abbreviations are used in this manuscript:
| PDE | Partial differential equation |
| FDM | Finite difference method |
Appendix A. Discretization and Vectorization Conventions
This appendix details the spatial discretization scheme and vectorization procedure employed to transform the continuous three dimensional wave equation, Equation (1) (), into a discrete system suitable for numerical computation and quantum algorithm construction. While the focus is on three dimensions, the methodology generalizes straightforwardly to other cases.
The continuous scalar field is discretized onto a structured grid with , , and points in the x, y, and z directions, respectively. We adopt the convention where the discrete solution is stored as a three-dimensional tensor , such that its elements are defined by
where the tensor indices correspond to the spatial coordinates . This specific index ordering is chosen to yield a canonical and efficient structure for the resulting discrete differential operators. A schematic representation of this data structure is provided in Figure A1.
Figure A1.
Schematic example of a three dimensional data tensor , i.e., storing points corresponding to different coordinates as an array. Thus, an element of the array corresponds to a point with coordinates . For discretization, 4 points per direction are used.
To interface with standard numerical linear algebra routines, which typically operate on vectors, the tensor U is transformed into a state vector via a vectorization operation, denoted . We adopt the Fortran-style (column-major) vectorization convention. This process maps the multi-dimensional array into a column vector . The sequence of this mapping is illustrated schematically in Figure A2.
This chosen discretization and vectorization ordering induces a highly structured form for the discrete Laplacian operator. The right-hand side of Equation (1) is approximated as
where the discrete 3D Laplacian is given by the sum of Kronecker products:
Here, are matrix representations of one-dimensional second-derivative operators (e.g., from a finite-difference method) incorporating the desired boundary conditions, and are identity matrices of appropriate sizes. Crucially, the order of the Kronecker product factors (x, y, z) is a direct consequence of the chosen vectorization convention, ensuring consistent and efficient application of the operator.
Figure A2.
Illustration of the vectorization process for the tensor U from Figure A1. The red dashed lines indicate the order in which elements are sequenced into the resulting column vector (from top to bottom).
Consequently, the discrete form of the wave equation initial value problem, incorporating a spatially varying wave speed , is expressed as the following system of ordinary differential equations:
where is the state vector, and F and G are the tensor representations of the initial conditions and , respectively. The dependence of the operator on the wave speed profile is implied.
Appendix B. Decomposition Example
This section provides a detailed, step-by-step example of the proposed decomposition method. We consider the three-dimensional () wave equation with a block velocity profile:
The velocity profile is defined as
This equation can be transformed into the Schrödinger form, , with the Hamiltonian:
where , , and . The matrices , with , arise from discretizing each spatial dimension, and B is a tridiagonal matrix incorporating the zero boundary conditions.
The next step is to decompose this Hamiltonian for quantum simulation. We set qubits per dimension. Following Proposition 1, the Pauli strings that may appear in the decomposition are listed in the first column of Table A1. The second step involves analyzing the block velocity profile. In this case, the profile is split only along the z-direction, implying , , and . Consequently, the matrix S can be written as
From this, we derive the masks for the strings, shown in the second column of Table A1.
Table A1.
Pauli strings for the three-dimensional wave equation, discretized with qubits per dimension and finite-difference operators approximated by tridiagonal matrices (). The strings (with for ) are generated per Proposition 1. The corresponding masks for the strings are shown for a two-block velocity model; a “∗” denotes a position that can be 0 or 1. Bits are grouped for readability: the first bits are for the Hamiltonian, and each subsequent block of bits encodes a spatial direction. The third column lists the diagonalization operators for case where , according to Proposition 2. Here, denotes a Hadamard gate on qubit k, and is a controlled-NOT gate with control c and target t.
Table A1.
Pauli strings for the three-dimensional wave equation, discretized with qubits per dimension and finite-difference operators approximated by tridiagonal matrices (). The strings (with for ) are generated per Proposition 1. The corresponding masks for the strings are shown for a two-block velocity model; a “∗” denotes a position that can be 0 or 1. Bits are grouped for readability: the first bits are for the Hamiltonian, and each subsequent block of bits encodes a spatial direction. The third column lists the diagonalization operators for case where , according to Proposition 2. Here, denotes a Hadamard gate on qubit k, and is a controlled-NOT gate with control c and target t.
| z | Diagonalization Operator D | |
|---|---|---|
To illustrate, consider the row for with the mask . This mask indicates that only the Pauli strings listed in the second column of Table A2 may appear in the decomposition. Since these Pauli strings all commute, we can apply Proposition 2 to construct a diagonalization circuit. The required operator D is given in the last column of Table A1, and the result of applying this diagonalization is shown in the final column of Table A2.
Table A2.
Pauli strings generated for and its corresponding mask , where “∗” denotes a position that can be 0 or 1. Only strings with an even number of Y operators () are retained as the Hamiltonian is real. The first column lists the specific strings generated from the mask. The second column shows the corresponding Pauli strings in the decomposition. The third column lists the strings after diagonalization per Proposition 2, and the last column shows the resulting diagonalized Pauli strings with diagonalization operator , and its conjugate transpose , since both the CNOT and Hadamard gates are Hermitian. Bits and Pauli matrices are grouped for readability.
Table A2.
Pauli strings generated for and its corresponding mask , where “∗” denotes a position that can be 0 or 1. Only strings with an even number of Y operators () are retained as the Hamiltonian is real. The first column lists the specific strings generated from the mask. The second column shows the corresponding Pauli strings in the decomposition. The third column lists the strings after diagonalization per Proposition 2, and the last column shows the resulting diagonalized Pauli strings with diagonalization operator , and its conjugate transpose , since both the CNOT and Hadamard gates are Hermitian. Bits and Pauli matrices are grouped for readability.
We express the total Hamiltonian as a sum , where each is a mutually commuting group of Pauli strings characterized by a single . Since these groups do not all commute with each other, we employ a Trotter–Suzuki decomposition to approximate the time evolution.
A single Trotter step can be implemented using methods from [21]. The quantum circuit for the propagator , corresponding to the group characterized by , is shown in Figure A3. The circuit emphasizes the gate arrangement; the specific rotation angles for the gates (which are defined in our implementation) are omitted for visual clarity. Using a Gray code ordering minimizes the number of CNOT gates in the diagonalization circuit.
The circuits for each group are combined to form a single Trotter step. These steps are then repeated according to the chosen Trotter formula order to achieve the desired simulation accuracy.
Figure A3.
Quantum circuit for the propagator , where is characterized by . The strings are processed in the following order (left to right): 00000000, 10000001, 10000011, 00000010, 11000010, 01000011, 01000001, 11000000. That is, in the the Gray code order for . The rotation angles are , where is the coefficient of the corresponding Pauli string and is the scaled time from the Trotter decomposition (e.g., for a first-order formula, , with r being the number of steps). The figure shows gate arrangement; the numerical values inside the gates are not relevant.
Appendix C. Application to a 3D Standing Wave Problem
This section demonstrates the application of our proposed quantum algorithm to a three-dimensional standing wave problem. We consider a constant wave velocity and compare the computational complexity of our method against a standard finite-difference method (FDM) for the accuracy level. The problem is defined by the following wave equation and initial/boundary conditions:
An exact analytical solution is known for this problem:
We compare the solution from our quantum method against a classical second-order FDM using an identical spatial discretization. The classical FDM solution is constructed iteratively for —the discretized and vectorized version of :
Here, is the discretized and vectorized initial condition . The discrete Laplacian is defined as
where , , and . The matrix (and similarly , ) is a first-order finite-difference operator (same as in Hamiltonian) with zero boundary conditions. For example, for we have . For the classical FDM simulation, the number of time steps is chosen to satisfy the Courant–Friedrichs–Lewy (CFL) condition for numerical stability, specifically , where .
To quantify accuracy, we use the discrete -norm error:
After computing the error between the FDM and analytical solutions, we estimate the number of Trotter steps r required for the quantum algorithm to achieve the same accuracy. This estimate is derived from the data plotted in Figure A4, where the crosses represent the quantum algorithm’s error (error between the quantum and analytical solutions) as a function of r. For each spatial discretization level (i.e., for each number of qubits per dimension), we locate the fixed FDM error level on the y-axis. We then determine the point where a horizontal line at this FDM error value intersects the interpolated trend (dashed line) of the quantum error data on the log–log plot. The x-coordinate of this intersection gives the estimated number of Trotter steps r needed for the quantum solution to match the classical FDM’s precision. These intersection points are marked with dots in the figure.
Figure A4.
Estimation of the quantum Trotter steps required for the second order formula to match classical FDM accuracy. The crosses show — error between quantum algorithm and analytical solution — plotted against the number of Trotter steps r for varying qubits per dimension n, corresponding to discretization points . For a fixed FDM error, the required Trotter steps are determined by the intersection with the error trend (dashed line). These intersections, marked by dots, provide the estimated r required for the quantum algorithm to achieve the same accuracy as the FDM.
Finally, we compare the computational cost, measured in the total number of operations. For the classical FDM, the cost is estimated as as the matrix has 3 non-zero entries per row, and the solution is evolved over time steps. For the quantum algorithm, the cost is the total number of one- and two-qubit gates, estimated as , where r is the number of Trotter steps and is the gate count for a single step (can be evaluate as in Equation (39)). This comparison is shown in Figure A5, where it can be seen that the quantum algorithm requires fewer operations than the standard FDM for this problem.
Figure A5.
Comparison of the total number of operations (gate count for quantum, floating-point operations for classical) required by the quantum algorithm with the second order formula versus the classical FDM.
Appendix D. Proofs
Proof of Proposition 1.
Without loss of generality, we assume for some integer . If this is not the case, one can extend the Hamiltonian by adding matrices for , where , ensuring is a power of two. This padding does not alter the structure or Pauli decomposition of the original .
To prove the proposition, we utilize the standard basis matrices , defined as the matrices that are zero everywhere except for a 1 at position . These matrices possess a crucial tensor product structure:
where and are the bits in the n-bit binary representations of i and j, respectively, i.e., and . Using this basis, the Hamiltonian can be expressed as
Since the Pauli strings constituting and are identical (the difference is only in coefficients of these matrices), we can denote their combined Pauli support simply as . Moreover, according to Proposition 1 in [16], the matrix admits a decomposition into Pauli strings characterized by binary vectors of the form
for , , , and , plus an additional diagonal string .
The single-qubit basis matrices have well-known Pauli decompositions:
Crucially, and are diagonal and are represented by the binary string (indicating I or Z), while and are off-diagonal and are represented by (indicating X or Y).
Now, applying the tensor product property (A13), we analyze the term :
where is the -bit binary representation of p. The Pauli string representation of this matrix is determined by the -component of each single-qubit factor. Since each factor is represented by the binary value , the full string for is simply . An identical argument shows that is also represented by the same string, .
Therefore, the overall Pauli string representation for a term in is given by the concatenation of the string for the first subsystem and the string for . This yields the general form
for , , , . Additionally, the diagonal contributions from lead to strings of the form
This completes the characterization of all Pauli strings present in the decomposition of . □
Proof of Proposition 2.
We employ the standard tableau method for the simultaneous diagonalization of sets of commuting Pauli strings, as detailed in [19,20]. For a set of m commuting Pauli operators, each acting on n qubits, the tableau is a data structure of size bits. Each row k of the tableau corresponds to a Pauli string and is represented as a pair , where the binary vectors encode the corresponding Pauli string. The tableau for our set, characterized by a single , is structured as follows:
Our goal is to construct a Clifford circuit that maps these operators to strings consisting solely of Z and I operators. This is equivalent to transforming the tableau such that the -block becomes zero.
The transformation rules for the tableau under elementary Clifford gates are well-established [19,20]:
- A Hadamard gate on qubit j swaps the j-th columns of the and blocks for all rows.
- A CNOT gate with control c and target t performs the following for all rows:
- A Phase gate on qubit j performs
The diagonalization procedure processes can be described as follows:
- Identify Pivot: Find the first column j (the pivot column) for which .
- Eliminate Other Entries: For every other columns with , apply a CNOT gate with control j and target l. This operation adds column j to column l in the -block, zeroing out the entry .
- Clear the Pivot: After step 2, only the pivot column j has a 1 in -block. At the same time only j-th column of the -block has changed. Moreover its values are equal to , where l runs over all non zero bit in the initially given . It can be seen that .
- If we are given a set, characterized by , apply a Hadamard gate on qubit j. This swaps the 1 in the -block with the 0 in the -block, completing the zeroing of block.
- If we are given a set, characterized by , first apply a Phase gate on qubit j. This sets (since and ). Then, apply a Hadamard gate on qubit j to swap the 1 in with the 0 in .
The final result is a tableau with , meaning all Pauli strings have been diagonalized. Additionally, it is easy to see that after the diagonalization procedure only a single bit is changed in strings. That is, we set pivot column bit j to 1 in each .
We now analyze the cumulative sign change from the specific CNOT operations applied in Step 2 of the diagonalization procedure. In this step, for a fixed target qubit t, a CNOT gate with control c (the pivot) and target t is applied to every other column k in the set for which .
Substituting these values simplifies the update rule significantly:
Using it directly based on step 2 in the diagonalization procedure, one can obtain following result
where denotes i-th index in (that is i-th column in table), and is number of combinations with being the number of bits in equal to 1. Simplifying it further we can get
Additionally, the sign bit remains unchanged after the application of a Hadamard gate. The sign update rule for a Hadamard gate on qubit t is . This update is trivial because a Hadamard gate is only applied to a qubit t when its state in the tableau is prepared such that either or , ensuring the product is always zero.
In contrast, the sign update rule for a Phase (S) gate is identical: . However, an S gate is applied under precisely the opposite condition when both and . Consequently, the product equals 1, and the sign bit is flipped.
That is the sign that appears in diagonalization is , where
or,
Finally the sign that appears during diagonalization is given in the form
□
Proof of Proposition 3.
Let the velocity-model operator be decomposed as , where is a Pauli string composed solely of I and Z matrices, and the Hamiltonian as , where are Pauli strings.
We note that the operators are constructed by embedding into a larger tensor product. Consequently, the Pauli strings constituting are those of , padded with zeros in the and vectors at positions corresponding to the identity matrices. Therefore, the structure of the commuting sets in , as established by Proposition 1 and Corollary 1, remains valid. The Hamiltonian can be expressed as a sum over mutually commuting sets:
where the phase factor arises from the Walsh operator definition (Equation (9)). According to Corollary 1, and since is real-valued, the number of sets is , and the number of strings per set is , where the term accounts for the constraint of an even number of Y operators.
We now analyze the transformed Hamiltonian :
Using the Pauli commutation relation and the fact that Z operators commute, we simplify:
In the final expression, the index p runs over all unique binary vectors generated by the indices and . The coefficient is the sum of all terms for which .
Two key observations follow from Equation (A27):
- The commuting sets of are identical to those of as they are characterized by the same strings.
- The number of Pauli strings within each set is bounded by the number of unique vectors that can be generated. This number is at most the minimum of two values:
- The total number of combinations: .
- The total number of all possible diagonal Pauli strings of length , which is . However, since remains a real-valued matrix, its Pauli decomposition can only contain strings with an even number of Y operators. For a fixed , this restricts the associated vectors, effectively halving the number of possibilities to .
Thus, , and the total number of Pauli strings in the decomposition of is bounded by
Substituting the expressions (for ), , and , the scaling of can be written as
□
References
- Virieux, J.; Operto, S. An overview of full-waveform inversion in exploration geophysics. Geophysics 2009, 74, WCC1–WCC26. [Google Scholar] [CrossRef]
- Taflove, A.; Hagness, S.C.; Piket-May, M. Computational electromagnetics: The finite-difference time-domain method. In The Electrical Engineering Handbook; Elsevier: Amsterdam, The Netherlands, 2005; Volume 3, p. 15. [Google Scholar]
- LeVeque, R.J. Finite Difference Methods for Ordinary and Partial Differential Equations: Steady-State and Time-Dependent Problems; Society for Industrial and Applied Mathematics (SIAM): Philadelphia, PA, USA, 2007. [Google Scholar]
- Tarantola, A. Inverse Problem Theory and Methods for Model Parameter Estimation; Society for Industrial and Applied Mathematics (SIAM): Philadelphia, PA, USA, 2005. [Google Scholar]
- Pratt, R.G. Seismic waveform inversion in the frequency domain, Part 1: Theory and verification in a physical scale model. Geophysics 1999, 64, 888–901. [Google Scholar] [CrossRef]
- Yee, K. Numerical solution of initial boundary value problems involving Maxwell’s equations in isotropic media. IEEE Trans. Antennas Propag. 1966, 14, 302–307. [Google Scholar]
- Harrow, A.W.; Hassidim, A.; Lloyd, S. Quantum algorithm for linear systems of equations. Phys. Rev. Lett. 2009, 103, 150502. [Google Scholar] [CrossRef]
- Berry, D.W. High-order quantum algorithm for solving linear differential equations. J. Phys. A Math. Theor. 2014, 47, 105301. [Google Scholar] [CrossRef]
- Costa, P.C.S.; Jordan, S.; Ostrander, A. Quantum algorithm for simulating the wave equation. Phys. Rev. A 2019, 99, 012323. [Google Scholar] [CrossRef]
- Bösch, C.; Schade, M.; Aloisi, G.; Keating, S.D.; Fichtner, A. Quantum wave simulation with sources and loss functions. Phys. Rev. Res. 2025, 7, 033225. [Google Scholar] [CrossRef]
- Wright, L.; Mc Keever, C.; First, J.T.; Johnston, R.; Tillay, J.; Chaney, S.; Rosenkranz, M.; Lubasch, M. Noisy intermediate-scale quantum simulation of the one-dimensional wave equation. Phys. Rev. Res. 2024, 6, 043169. [Google Scholar] [CrossRef]
- Suau, A.; Staffelbach, G.; Calandra, H. Practical quantum computing: Solving the wave equation using a quantum approach. ACM Trans. Quantum Comput. 2021, 2, 1–35. [Google Scholar] [CrossRef]
- Sato, Y.; Kondo, R.; Hamamura, I.; Onodera, T.; Yamamoto, N. Hamiltonian simulation for hyperbolic partial differential equations by scalable quantum circuits. Phys. Rev. Res. 2024, 6, 033246. [Google Scholar] [CrossRef]
- Sato, Y.; Tezuka, H.; Kondo, R.; Yamamoto, N. Quantum algorithm for partial differential equations of nonconservative systems with spatially varying parameters. Phys. Rev. Appl. 2025, 23, 014063. [Google Scholar] [CrossRef]
- Arseniev, B.; Guskov, D.; Sengupta, R.; Biamonte, J.; Zacharov, I. Tridiagonal matrix decomposition for Hamiltonian simulation on a quantum computer. Phys. Rev. A 2024, 109, 052629. [Google Scholar] [CrossRef]
- Arseniev, B.; Guskov, D.; Sengupta, R.; Zacharov, I. High-order schemes for solving partial differential equations on a quantum computer. Phys. Rev. A 2025, 111, 042625. [Google Scholar] [CrossRef]
- Berry, D.W.; Ahokas, G.; Cleve, R.; Sanders, B.C. Efficient quantum algorithms for simulating sparse Hamiltonians. Commun. Math. Phys. 2007, 270, 359–371. [Google Scholar] [CrossRef]
- Childs, A.M.; Su, Y.; Tran, M.C.; Wiebe, N.; Zhu, S. Theory of trotter error with commutator scaling. Phys. Rev. X 2021, 11, 011020. [Google Scholar] [CrossRef]
- Kawase, Y.; Fujii, K. Fast classical simulation of Hamiltonian dynamics by simultaneous diagonalization using Clifford transformation with parallel computation. Comput. Phys. Commun. 2023, 288, 108720. [Google Scholar] [CrossRef]
- Van Den Berg, E.; Temme, K. Circuit optimization of Hamiltonian simulation by simultaneous diagonalization of Pauli clusters. Quantum 2020, 4, 322. [Google Scholar] [CrossRef]
- Welch, J.; Greenbaum, D.; Mostame, S.; Aspuru-Guzik, A. Efficient quantum circuits for diagonal unitaries without ancillas. New J. Phys. 2014, 16, 033040. [Google Scholar] [CrossRef]
- Sato, H.; Fehler, M.C.; Maeda, T. Seismic Wave Propagation and Scattering in the Heterogeneous Earth; Springer: Berlin/Heidelberg, Germany, 2012; Volume 496. [Google Scholar]
- Low, G.H.; Chuang, I.L. Optimal Hamiltonian simulation by quantum signal processing. Phys. Rev. Lett. 2017, 118, 010501. [Google Scholar] [CrossRef]
- Berry, D.W.; Childs, A.M.; Cleve, R.; Kothari, R.; Somma, R.D. Simulating Hamiltonian dynamics with a truncated Taylor series. Phys. Rev. Lett. 2015, 114, 090502. [Google Scholar] [CrossRef]
- Kandala, A.; Temme, K.; Córcoles, A.D.; Mezzacapo, A.; Chow, J.M.; Gambetta, J.M. Error mitigation extends the computational reach of a noisy quantum processor. Nature 2019, 567, 491–495. [Google Scholar] [CrossRef]
- Preskill, J. Quantum computing in the NISQ era and beyond. Quantum 2018, 2, 79. [Google Scholar] [CrossRef]
- Cerezo, M.; Arrasmith, A.; Babbush, R.; Benjamin, S.C.; Endo, S.; Fujii, K.; McClean, J.R.; Mitarai, K.; Yuan, X.; Cincio, L.; et al. Variational quantum algorithms. Nat. Rev. Phys. 2021, 3, 625–644. [Google Scholar] [CrossRef]
- Peruzzo, A.; McClean, J.; Shadbolt, P.; Yung, M.H.; Zhou, X.Q.; Love, P.J.; Aspuru-Guzik, A.; O’brien, J.L. A variational eigenvalue solver on a photonic quantum processor. Nat. Commun. 2014, 5, 4213. [Google Scholar] [CrossRef] [PubMed]
- Childs, A.M.; Ostrander, A.; Su, Y. Faster quantum simulation by randomization. Quantum 2019, 3, 182. [Google Scholar] [CrossRef]
- Jin, S.; Liu, N.; Yu, Y. Quantum simulation of partial differential equations via Schrödingerization. Phys. Rev. Lett. 2024, 133, 230602. [Google Scholar] [CrossRef]
- Zacharov, I.; Arslanov, R.; Gunin, M.; Stefonishin, D.; Bykov, A.; Pavlov, S.; Panarin, O.; Maliutin, A.; Rykovanov, S.; Fedorov, M. “Zhores”—Petaflops supercomputer for data—Driven modeling, machine learning and artificial intelligence installed in Skolkovo Institute of Science and Technology. Open Eng. 2019, 9, 512–520. [Google Scholar] [CrossRef]
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content. |
© 2025 by the authors. Licensee MDPI, Basel, Switzerland. This article is an open access article distributed under the terms and conditions of the Creative Commons Attribution (CC BY) license (https://creativecommons.org/licenses/by/4.0/).