Your new experience awaits. Try the new design now and help us make it even better

ORIGINAL RESEARCH article

Front. Quantum Sci. Technol., 04 December 2025

Sec. Quantum Computing and Simulation

Volume 4 - 2025 | https://doi.org/10.3389/frqst.2025.1636042

This article is part of the Research TopicAdvancing Quantum Computation: Optimizing Algorithms and Error Mitigation in NISQ DevicesView all 4 articles

Encodings of the weighted MAX -CUT problem on qubit systems

  • 1Department of Mathematics and Cybernetics, SINTEF AS, Oslo, Norway
  • 2Department of Mathematics, University of Oslo, Oslo, Norway

The weighted MAX k-CUT problem involves partitioning a weighted undirected graph into k subsets, or colors, to maximize the sum of the weights of edges between vertices in different subsets. This problem has significant applications across multiple domains. This study explores encoding methods for MAX k-CUT on qubit systems by utilizing quantum approximate optimization algorithms (QAOA) and addressing the challenge of encoding integer values on quantum devices with binary variables. We examine various encoding schemes and evaluate the efficiency of these approaches. The study presents a systematic and resource-efficient method to implement the phase separation operator for the cost function of the MAX k-CUT problem. When encoding the problem into the full Hilbert space, we show the importance of encoding the colors in a balanced way. We also explore the option of encoding the problem into a suitable subspace by designing suitable state preparations and constrained mixers (LX- and Grover-mixer). Numerical simulations on weighted and unweighted graph instances demonstrate the effectiveness of these encoding schemes, particularly in optimizing circuit depth, approximation ratios, and computational efficiency.

1 Introduction and related work

The quantum approximate optimization algorithm (Farhi et al., 2014)/quantum alternating operator ansatz (Hadfield et al., 2019) (QAOA) is a widely studied hybrid algorithm for approximately solving combinatorial optimization problems encoded into the ground state of a Hamiltonian. Given an objective function f:{0,1}nR, the problem Hamiltonian is defined as HP|x=f(x)|x. Thus, the ground states of HP correspond to the minima of the objective function. In the general framework of QAOA, a parameterized quantum state is prepared as follows:

|γ,β=UM(βp)UP(γp)UM(β1)UP(γ1)|ϕ0.

Starting from an initial state |ϕ0, the algorithm alternates between applying the phase-separation operator UP(γ) and the mixing operator UM(β). The goal is to optimize the parameters γ,βR such that γ,β|HP|γ,β is minimized.

Since the original proposal of QAOA, several extensions and variants have been introduced. One such extension is ADAPT-QAOA (Zhu et al., 2022), which iteratively adds only the terms that most contribute to lowering the expectation value. Another variant is R-QAOA (Bravyi et al., 2020), which progressively removes variables from the Hamiltonian until the reduced instance can be classically solvable. A third extension, WS-QAOA (Egger et al., 2021), incorporates solutions from classical algorithms to warm-start the QAOA process. When a given problem has constraints, the design of mixers is vital. For constrained problems, the design of mixers is crucial. A well-known example is the XY-mixer (Hadfield et al., 2017; Wang et al., 2020), which restricts evolution to “k-hot” states. GM-QAOA (Bartschi and Eidenbenz, 2020) uses Grover-like operators for all-to-all mixing of more general feasible subsets. The mixing operator of GM comprised a circuit US that prepares the uniform superposition of all feasible states, its inverse US, and a multi-controlled rotational phase shift gate. Inspired by the stabilizer formalism, the LX-Mixer (Fuchs and Bassa, 2024; Fuchs et al., 2022) is a generalization of the above methods that provides a flexible framework that allows for tailored mixing within the feasible subspace.

To increase the practical relevance of QAOA, encoding problems with integer values, rather than binary variables, into qubit systems is an important area of research. This process generally introduces considerable flexibility in encoding choices, affecting not only the number of qubits and controlled operations needed but also the complexity of the optimization landscape and the quality of the approximation ratios that can be achieved. In this study, we explore various encoding schemes for the MAX k-CUT problem into qubit systems, building on and improving earlier research (Fuchs et al., 2021). This problem has numerous applications, including the placement of television commercials in program breaks, arrangement of containers on a ship with k bays, partitioning a set of items (e.g., books sold by an online shop) into k subsets, product module design, frequency assignment, scheduling, and pattern matching (Aardal et al., 2007; Ram Gaur et al., 2008). Given a weighted undirected graph G=(V,E), the MAX k-CUT problem consists of finding a maximum-weight k-cut. This involves partitioning the vertices into k subsets such that the sum of the weights of the edges between vertices in different subsets is maximized (Figure 1). By assigning a label xi{1,,k} to each vertex iV and defining x=(x1,,x|V|), the optimization problem for MAX k-CUT can be formulated as

maxx{1,,k}nC(x),C(x)=(i,j)Ewij, if xixj0,otherwise.(1)

Figure 1
A graph composed of five colored nodes connected by black lines, forming a square with a central node. The corners of the square have blue and purple nodes, and the center has a light blue node. Red and blue curved lines weave through the graph.

Figure 1. Example of an optimal solution for a MAX3-CUT problem.

Here, wij>0 is the weight of edge (i,j)E. The function C(x) is commonly referred to as the “cost function.” For k=2, the MAX k-CUT problem becomes the well-known MAX CUT problem. The MAX k-CUT problem is NP-complete, and it has been demonstrated that no polynomial-time approximation scheme exists for k2 unless P = NP (Alan and Jerrum, 1997). A randomized approximation algorithm for (1) has an approximation ratio α if

E[C(x)]αC(x*),

where x* denotes an optimal solution.

Expressing the solutions as strings of k-dits as in Equation 1 is a natural extension of the MAX (2-)CUT problem to k>2. However, most quantum devices work with a two-level system, so we need to make a suitable encoding on a qubits system (Fuchs et al., 2021; Hadfield et al., 2019). One-hot encoding uses k bits for each vertex, where the single bit that is 1 encodes which set/color the vertex belongs to. Using this encoding requires k|V| qubits. However, k not being a power of 2 results in more computational states per vertex than there are colors. The corresponding subspaces need to be dealt with in a suitable fashion. The Grover or the LX-mixer (which becomes the XY-mixer in this case) can be readily applied. However, the ratio of the dimension of the feasible states to the system size is k/2k, which becomes exponentially small for increasing k. Therefore, it is advantageous to use a binary encoding, which does not have this problem. For a given k, we encode the information of a vertex belonging to one of the sets by |ink, which requires

nklog2(k)

qubits. Here, means rounding up to the nearest integer. Binary encoding requires nk|V| qubits, which is exponentially fewer than required by one-hot encoding. The resulting problem Hamiltonian can be written as the sum of local terms, that is,

HP=eEweHe,

where wi,j is the weight of the edge between vertices i and j. Furthermore, the local term can be expressed as

He=2ĤeI,Ĥe=(i,j)clr|ii||jj|.(2)

where clr is a set of index pairs (i,j) representing equivalent colors under an equivalence relation. From the definition, He has eigenvalue +1 for a state |i|j if iclrj and 1 if not. The phase separating operator eitHe differs from eitĤe only by a scalar factor and a global phase, so it is sufficient to realize the latter.

More formally, an equivalence relation clr is defined on X={0,,2nk1}, where clr consists of all pairs (i,j) such that iclrj. For example, if clr={(0,0),(1,1),(2,2),(3,3),(2,3),(3,2)}, the equivalence relation defines the following equivalence classes: [0]={0},[1]={1},[2]={2,3}. For convenience, we can work with a generating set. Suppose R is a relation on the set X. The equivalence relation on X generated by a R, denoted R̄, is then the smallest equivalence relation on X that contains R, which can be obtained by the reflexive, symmetric, and transitive closure (in that order). Hence, only the non-trivial relations must be specified, and the above example can be generated by the closure of the relation R={(2,3)} which generates R̄={(0,0),(1,1),(2,2),(3,3),(2,3),(3,2)}. The set of colors in the context of MAX k-CUT is then the set of equivalence classes induced by clr, denoted

X/clr{[x]:xX},

with each equivalence class given by

[c]{xX:cclrx}.

We recognize that the phase separating operator—the real time evolution of Ĥe—acts by applying a phase on a specific subsets of all computational basis states. When these subsets are sparse, such unitaries can be efficiently realized (Fuchs and Bassa, 2025): let PB be the projector onto a subspace given by set of computational basis states B. The unitary operator eitPB can be realized by a circuit for mapping the (indexed) states of B to the first |B| computational basis states, which can be achieved by M=j=0|B|1Tj,zj, where Ti,j is a transposition gate. It follows directly that

MPBM|j=MPB|zj=M|zj=|j, for j<|B|,0, otherwise.

Therefore, we find that MPBM=j<|B||jj|, from which it follows that the exponential has the form

eitPB=Meitj<|B||jj|M=MC|B|Ph(t)M,

where C|B|Ph(t) is a low-pass controlled phase shift gate as defined in Fuchs and Bassa (2025). For a general subspace, the overall circuit requires On|B| CX gates and On|B|+log(|B|)log(1ϵ) T gates.

When the subspace is given by the span of a Pauli X-orbit as defined in Fuchs and Bassa (205), the overall circuit requires only Onlog(|B|) CX gates and On+log(1ϵ) T gates. Here, ϵ is a given tolerance for approximating rotational gates. Even though spanB might not be a Pauli X-orbit subspace, we can always decompose into a direct sum of Pauli X-orbit subspaces and apply the construction individually on the subspaces of the decomposition. We will therefore here aim to divide the subspaces such that they are Pauli X-orbit subspaces if it leads to an efficient circuit.

An overview of possible encoding techniques is provided in Figure 2. When k is not a power of 2, we must deal with the fact that we have non-trivial equivalence classes clr. There are two ways to deal with this. The first is to directly implement the phase separating Hamiltonian on the full Hilbert space (Fuchs et al., 2021) or restrict the evolution onto the relevant subspace. The main contributions of this study are for the cases when k is not a power of 2. We introduce:

A systematic way to implement the phase separating Hamiltonian, resulting in a reduction of the complexity of the resulting circuit using the theorems from Fuchs and Bassa (2025).

A method to directly work with a feasible subspace with a suitable state preparation and constrained mixer in Section 4.

More balanced sets of equivalent colors, which help improve the resulting cost landscape, in Section 3.

Figure 2
Diagram illustrating MAX k-CUT qubit encodings with two branches: one-hot and binary. The one-hot branch shows \(I \subseteq \mathcal{H}\), \(H_M = LX\), and \(H_P = H^{\text{one-hot}}_P(k)\). The binary branch splits into \(k = 2^;L\) and \(k \neq 2^L\). At \(k = 2^L\), Section 2 details \(I = \mathcal{H}\), \(H_M = X\), and \(H_P = H^{\text{bin}}_P(k)\). For \(k \neq 2^L\), Section 3 shows \(I = \mathcal{H}\), \(H_M = X\), \(H_P = H^{\text{bin}}_P(k)\); Section 4 has \(I \subseteq \mathcal{H}\), \(H_M = LX\), \(H_P = H^{\text{bin}}_P(2^Lk)\).

Figure 2. Overview of different ways to encode the MAX k-CUT-problem into a (sub-)space I of the full Hilbert space H with a corresponding problem Hamiltonian HP. If I is restricted, a valid mixer (Hadfield et al., 2019) HM needs to be constructed. For binary encoding when k is not a power of 2, we are left with two choices: use the full Hilbert space and introduce an equivalence class of k colors with an unrestricted mixer or use a restricted subspace I with a valid mixer that restricts to I.

We also employ the Grover mixer to all cases, indicating that the resulting landscape might be favorable. Throughout this study, the notation ClU means an lcontrolled U gate. For example, a Toffoli gate is C2X, and CPh=CPh(t) is the controlled phase shift gate, where we mostly omit the parameter. We will make use of the following notation for multi-controlled unitary (MCU) gates

CbcUt=(Ic|bb|c)It+|bb|cUt,(3)

where c,t is index control and target qubits, and b specifies the control condition.

2 Binary encodings when k is a power of 2

When k=2nk, the equivalence relation for the problem Hamiltonian in Equation 2 becomes trivial—that is, clr={}̄={(0,0),(1,1),,(k1,k1)}—and hence

Ĥe=i=0k1|ii||ii|.(4)

By definition, Ĥe is a projection operator PB of rank k onto the subspace spanned by B={|j|j,0j<k}, consisting of all states with identical basis vectors in both registers. We notice that the set B is Pauli X-orbit generated as defined in Fuchs and Bassa (2025) since it can be written as

B=Gnk|02nk,

that is, the orbit of the computational basis state |02nk under the group action of Gnk={XiXi}i=0nk1. Here, S denotes the subgroup generated by a subset S of the Pauli group. To construct the phase separating operator for our concrete case, we follow the proof of Theorem 3 in Fuchs and Bassa (2025) which recursively gives us the following permutation matrix in each step, Mj=C1jXj+nk, which leaves the all-zero state unchanged and maps the state |j|j to |j|0. Overall, this leads to

MPBM=Ink|00|nk,M=i=0nk1C1iXi+nk,

resulting in the following circuit:

www.frontiersin.org

The number of controlled gates required for realizing the mixer and phase separating operators are as follows.

Realizing eitĤe through Equation 5 requires 2nkCX gates and 1 Cnk1Ph gate. Alternatively, we can also do a direct decomposition of Ĥe in the Pauli basis and perform Pauli evolution gates with this. For k=2,4,8, the first approach needs 2CX, (4CX and 1 CPh) and (6CX and 1C2Ph), whereas the Pauli evolution needs 2CX, 10CX, and 34CX per gate, respectively. Thus, it is better for these cases to realize the phase separation with the circuit given in Equation 5 and not through Pauli evolution.

The X mixer does not require any controlled gates, the Grover mixer needs one C|V|nk1P gate, and the GroverV needs |V|Cnk1P gates, where the box product is defined in Equation 11.

We numerically test the performance of the resulting QAOA algorithm on the same instances as in Fuchs et al. (2021), given in Supplementary Appendix A. Table 1 shows that the approximation ratios achieved are very good for all cases. An overview of the energy/approximation ratio landscapes are provided in Supplementary Appendix Table A3.

Table 1
www.frontiersin.org

Table 1. Approximation ratios achieved for the case when k=2nk.

3 Binary encodings for k2nk using the full Hilbert space

When k is not a power of 2, the equivalence relation for the problem Hamiltonian in Equation 2 becomes non-trivial. One way to deal with this is what we will refer to as k-encoding, where we encode the color k into all states with |i for ki2nk1. This gives us

clr<kk={(k1,k),(k,k+1),,(2nk2,2nk1)}̄.

Of course, in general there are many ways to define k colors through an equivalence relation clr, which influences the cardinality of the equivalence classes. There is, however, always a way to define it such that the maximum cardinality of all equivalence classes is at most 2. In the following, we denote such a relation as clrbalk. This also influences the rank of the Hamiltonian Ĥe. In the following, we make a concrete construction of the Hamiltonians for k{3,5,6,7}.

3.1 The case k=3

For k=3, clrbal3=clr<33={(2,3)}̄, which means that the three colors are given by [0]={0},[1]={1},[2]={2,3}. The subspace of the projector is given by B={|0000,|0101,|1010,|1111,|1011,|1110}. We can realize the phase separating operator using the low-pass controlled phase shift gate C6Ph in the permuted basis, as described in Fuchs and Bassa (2025). However, to reduce the circuit complexity, we can instead divide the subspace in two Pauli X-orbit generated subspaces, B1=X1X3|0000 and B2=X1,X3|1010, which results in the circuit

www.frontiersin.org

3.2 The case k=5

For k=5, clr<55={(4,5,6,7)}̄, which means that the five colors are given by [0]={0},[1]={1},[2]={2},[3]={3},[4]={4,5,6,7}. We can divide B into two Pauli X-orbit generated subspaces. The first subspace containing four states is related to the first four colors |000,|001,|010|011, forming the subset B1=X1X4,X2X5|000000. The second subspace contains all states related to the last degenerated color |100,|101,|110,|111, forming B2=X1,X2,X4,X5|100100. The resulting circuit is given by.

www.frontiersin.org

which realizes the phase separating unitary with one single- and one triple-controlled phase shift gate.

Looking at the case for k=3 and k=5, it becomes clear that the structure of the circuit can be generalized for clr<k with k=2l+1. The feasible subspace can always be divided into two Pauli X-orbit generated subspaces, B1=X1Xnk+1,,XlXnk+l|00, related to the first k1 color states characterized by bitstrings x=yy, where the first digit of y is always 0. The second subspace related to the degenerate color is given by B2=X1,,Xnk1,Xnk+1,,X2nk1|100|100. From this, we can conclude that the resulting circuit is a generalization of Equation 6, where eitH1 consists of the MGHZ circuit where the CX between the first and nk-th qubit is omitted and a phase shift gate the with target on the last qubit controlling the first and last nk (without the last) qubits. The circuit for eitH2 is a phase shift gate with control of the first and target on the nk+1-th qubit.

A second possibility is to encode the problem so that the cardinality of the equivalence classes is minimized. This can, for instance, be achieved by clrbal5={(0,1),(4,5),(6,7)}̄. In this case, the five colors are given by [0]={0,1},[2]={2},[3]={3},[4]={4,5},[6]={6,7} and the according Pauli X-orbit generated subspaces are

B1=X0X3,X1X4,X2X5|000000,(7)
B2=X0X3,X2X5|000001,(8)
B3=X2X5|111110.(9)

The resulting circuit for the phase separating operator is

www.frontiersin.org

where the gates in the gray box cancel to the identity.

3.3 The case k=6

For k=6, we have that clr<66={(5,6,7)}̄, meaning that the six colors are given by [0]={0},[1]={1},[2]={2},[3]={3},[4]={4},[5]={5,6,7}. We can divide B into the following two Pauli X-orbit generated subspaces B1=X0X3,X1X4,X2X5|000000,B2=X2X5|110111, together with B3={|110101,|110111,|111101,|111110}, which cannot be generated by a Pauli X-orbit. The resulting circuit is given by

www.frontiersin.org

The circuit for the real time evolution of H2 contains a Toffoli gate for realizing the basis change since the subspace is not Pauli X-orbit generated. In particular, the circuit for the second term H2 can be derived considering that if we exchange the state |111110 and |111111 using a transposition gate (in this case a 5-controlled not-gate C5X), the new set B2̃=X2,X4|110101 becomes Pauli X-orbit generated. Since all the states in the subset B2B2̃ have the bit value 1 in position 0,1,3,5 we can instead replace the use of C5X by a Toffoli gate CCX2,45.

In order to encode the problem in a balanced way, we can use clrbal6={(0,1),(4,5)}̄. Since clrbal6{(6,7)}̄=clrbal5, we can divide B into the subspace B1 and B2 shown in Equation 7; the resulting circuit is shown in Equation 10, but the circuit for H3 is omitted.

3.4 The case k=7

For k=7, clrbal7=clr<77={(6,7)}̄, which means that the seven colors are given by [0]={0},,[5]={5},[6]={6,7}. Since clrbal7{(0,1),(4,5)}̄=clrbal5, we can divide B into the subspace B1 and B3 shown in Equation 7, where the resulting circuit is shown in Equation 10, but the circuit for H2 is omitted. Notice here too that the two adjacent C2X5 gates between the circuits for H1 and H3 cancel.

3.5 Resource analysis

When k is not a power of 2, the method presented in [9, Section 3.2.2] is not optimal in terms of resource efficiency; for each edge of the graph, it requires the circuit shown in Equation 5 and a(a1) times the circuit shown in Figure 3b, where a=2nk(k1). Each of these individual circuits uses four CnkX-gates, and one C2P gate and requires the use of two ancillary qubits. Concretely, for each edge, 2,12,6,2,56, of these circuits are needed for k=3,5,6,7,9,, respectively, with the cost shown in Figure 3a. The method derived from the theorem in Fuchs and Bassa (2025) on the other hand, requires much fewer entangling gates and does not require ancilla qubits. For a single edge, the size of the relevant subspace B scales as O(k2) in the encoding using clrbalk and as O(k4) in the encoding using clr<kk. This quadratic scaling in the latter case is due to the degeneracy of the highest color level, which leads to (22n+1k)2 valid computational basis states. From the theorem in Fuchs and Bassa (2025), the overall gate complexity for the two encoding strategies is as follows.

Encoding using clrbalk: O(|E|k2log2(k)) CNOTs and O(|E|k2log2(k))+2log2(k)log2(1/ϵ) single-qubit rotations.

Encoding using clr<kk: O(|E|k4log2(k)) CNOTs and O(|E|k4log2(k))+4log2(k)log2(1/ϵ) single-qubit rotations.

Figure 3
A table compares the number of controlled gates required for phase shift gates between

Figure 3. Resource comparison shows that the circuits for realizing the phase separating operator UP as proposed here require fewer resources in terms of entangling gates as Fuchs et al. (2021). Another advantage of the proposed method is that it does not require ancilla qubits. Whereas we realize the diagonal operator directly, Fuchs et al. (2021) utilized the circuit shown in (b) between each edge (i,j). For each element {y1,y2}clrk\i,j{i,i}, one such circuit is necessary with Nyi=Xbin(yi). (a) Number of controlled gates to realize the phase shift gate for one edge of the graph.

Here, we have explicitly constructed circuits for k=3,5,6,7,9, using a decomposition similar to that in Fuchs and Bassa (2025), but with a key optimization: we partitioned subspace |B| into ad hoc sums of Pauli X-orbits. This additional structure further reduces the implementation cost. See Supplementary Appendix Table A3a for a comparison.

4 Binary encodings for k2nk using subspaces

When k is not a power of 2, there is an alternative to encoding the problem in the full Hilbert space as presented in Section 3. Instead, the evolution of the QAOA can be restricted to a suitably chosen subspace spanned by a set B consisting of k computational basis states. Consequently, we need a way to prepare an initial state in a k-dimensional subspace for each vertex of the graph and a mixer constrained to this subspace. We observe that

HPbin(2nk)spanB=HPbin(k),

meaning we can use the circuit for the power-of-2 case. Overall, this approach shifts complexity from the phase separating Hamiltonian to the mixer.

4.1 Initial state

For the MAX k-CUT problem, one possibility is to define the subspace for each vertex through Bk={|i|0ik1}. Since the feasible bit-strings admit a Cartesian product structure, the feasible subspace becomes a tensor product of the form

Bk1Bk|V|.

An initial state can be prepared as the uniform superposition of all feasible basis states—

|Φ0<k|V|, where |Φ0<k=1ki=0k1|i.

This can, in general, be efficiently prepared with a gate complexity and circuit depth of only Olog2(k) (Shukla and Vedula, 2024). One way to realize the initial state for k3,5,6,7 is shown in Figures 4a–h.

Figure 4
Quantum circuit diagrams illustrate various gate configurations and valid mixers. Panels (a), (c), and (e) show circuits with \(R_Y\) and \(R_{XY}\) gates, with specific parameter values indicated. Panels (b), (d), (f), and (h) depict valid mixers for quantum states \(B_3\), \(B_5\), \(B_6\), and \(B_7\) using \(CX\) gates. Arrows indicate transitions, with corresponding labels like \(IX(+ZI)\) and \(XII(+IZI)\). Each configuration is detailed with mathematical expressions and gate counts.

Figure 4. Initial state preparation and mixer for k = 3 (a) and (b), k = 5 (c) and (d), k = 6 (e) and (f), k = 7 (g) and (h), when restricting to a suitably chosen subspace. We use the notation RP(t)=expit2p, P{X,Y,Z}, and RXY(t)=expit4(XX+YY).

4.2 Constrained mixer

Given a feasible subspace spanBH, a mixer UM is then called valid (Hadfield et al., 2019) if it preserves the feasible subspace, that is,

UM(β)|vspanB,|vspanB,βR,

and if it provides transitions between all pairs of feasible states, where for each pair of computational basis states |x,|yB there exist β*R and rN{0}, such that

|x|UMr(β*)|y|>0.

Apart from the Grover mixer, we consider here constraint-preserving mixers in the stabilizer form (Fuchs and Bassa, 2024), in which case the Hamiltonian can be written as

HM=αcαX̄αVα,

where α{0,1}n\{0}n is a multi-index, X̄α=X1α1Xnαn{I,X}n\{I}n, and Vα is a projection onto Vα. Furthermore, Vα is a subspace fulfilling |xVαX̄α|xVα. The free parameter cα{0,1} must be chosen such that we have a valid mixer. Let {S1,,Sl} be a minimal generating set of the stabilizer group S=S1,,Sl defining the code subspace C(S). We can choose the projection operator to be of the form

C(S)=12kSS1,,SkS.

For more details, see Fuchs and Bassa (2024). In the following, we will use the notation

X̄S1,,Sk:=12kSS1,,SkX̄S.

Given the independence of the different color constraints for each vertex of the problem, we can then define the following LX-mixer Hamiltonian

HM=G|V|=GGG,

where the Cartesian or Box product is defined as

GH=GI+IH.(11)

It can be shown that if G is a valid mixer, HM is constructed in this way (Fuchs and Bassa, 2024). Valid mixers with optimal cost in terms of CX gates are shown in Figure 4 for k{3,5,6,7}. We note that this choice is not unique and that other mixers are possible as well.

5 Simulations

We perform numerical simulations for an unweighted Erdős–Rényi graph and a weighted Barabási–Albert graph with ten vertices (Supplementary Appendix A). Since the case where k is a power of 2 is presented in Section 2, we will focus on evaluating the methods presented in Sections 3 and 4. Using an ideal simulator, we compare the results for the binary encoding with the standard X-mixer and different choices of equivalence relations to encode the colors, and we compare the subspace encoding with different choices of mixers. The resulting energy landscapes are provided in Supplementary Appendix A. As expected, the landscapes are periodic in β when using the X- and Grover-mixer, whereas the landscape associated with the LX-mixer is generally not. The resulting approximation ratios are shown in Table 2. Overall, the subspace-encoding using the Grover mixer achieves the highest values for these two graphs, although with only a small distance to the LX-mixer. We can also see that balancing the bin sizes for the different colors has a very positive effect on the approximation ratio when using the full Hilbert space and the X-mixer. The effect of increasing the depth is shown in Table 3, which is exemplified for k=6. Note that the behavior for k=3,5,6, and 7 were very similar. Overall, the Grover achieved the best convergence for these two graphs, irrespective of whether the full Hilbert space or the subspace method was used.

Table 2
www.frontiersin.org

Table 2. Comparison of different encoding schemes when k is not a power of 2. The X-mixer uses the encoding of the full Hilbert space presented in Section 3, whereas the LX- and Grover mixers encode the problem in a subspace as described in Section 4. Approximation ratios achieved for the graphs shown in Supplementary Appendix A for depth p = 1. The light gray color indicates methods using subspaces as described in Section 4, whereas the rest indicates methods using the full Hilbert space as described in Section 3.

Table 3
www.frontiersin.org

Table 3. Approximation ratio for k=6 for the different methods as the depth p is increased, employing the interpolation-based heuristic described in (Zhou et al., 2020) and compared with the Frieze–Jerrum semidefinite programming relaxation (Alan and Jerrum, 1997). The subspace methods constrained to subspaces use dashed lines with circles as makers, and the methods using the full Hilbert space use solid lines with ´´x” as markers.

We note, however, that the averaged approximation ratio achieved should be carefully considered with respect to the required circuit depth. For encoding in the full Hilbert space, we can use the X-mixer, but the phase-separation operator requires a deeper circuit. For encoding into a subspace, we can use the phase-separation operator for the power-of-2 case (leading to a more shallow circuit), but the circuit for the constrained preserving mixer is deeper. An indication of the cost is given in Table 4, where we used the compiler from qiskit, assuming full connectivity. Note that for a sparse graph |E|=O(|V|) and for a fully connected graph |E|=Θ(|V|2). Therefore, for graphs with sufficient connectivity, the subspace encoding uses fewer resources than the encoding into the full Hilbert space.

Table 4
www.frontiersin.org

Table 4. Cost in terms of CX gates when using the qiskit compiler. Methods from previous research is marked with light gray background: The line with HPold(k) is the Hamiltonian presented in Fuchs et al. (2021), and the HPPauli(k) decomposes the Hamiltonian in the Pauli basis. Terms related to the phase-separating Hamiltonian scale with the number of edges and terms related to the mixer scale with the number of vertices. Notice that by encoding the problem in a specific subspace rather than the entire Hilbert space, the complexity is shifted away from the phase-separating Hamiltonian and instead transferred to the mixer.

6 Conclusion

This study presents advances in encoding the MAX k-CUT problem into qubit systems, with a focus on cases where k is not a power of 2. We present new ways of encoding that significantly reduce the resource requirements compared to previous approaches. In our implementation, we compared two different encodings using the full Hilbert space. Empirically, we observed that the balanced encoding consistently produced more compact circuits and achieved higher approximation ratios across all tested circuit depths and for both graph instances. We believe that this improvement is linked to the structure of the cost Hamiltonian, specifically the reduced degeneracy induced by the balanced encoding, which may lead to a smoother optimization landscape. However, we acknowledge that we do not currently have a theoretical guarantee that the balanced encoding results in fewer barren plateaus than the k encoding. While the empirical results suggest an improvement in trainability, a rigorous analysis of the gradient landscape remains an open direction for future work. Balanced color sets and constrained mixers demonstrate notable improvements in optimization landscapes and approximation ratios.

While our method is designed for digital quantum architectures, extending it to quantum annealers is possible in principle but practically nontrivial. Quantum annealing hardware is restricted to 2-local Ising Hamiltonians, whereas our encoding yields k-local PUBO terms for k3. Mapping these higher-order terms to 2-local form would require ancillary qubits and penalty constraints, introducing significant overhead and embedding complexity (Nagies et al., 2025) or the use of hybrid techniques as exposed in (Wurtz et al., 2024). In the future, we plan to do a careful analysis of which ansatz is preferable when k is not a power of 2, using a suite of graph instances. The analysis should take into account the overall circuit depth, the achieved approximation ratio for increasing depth size, as well as if the landscape has barren plateaus or many “bad” local minima.

Data availability statement

The raw data supporting the conclusions of this article will be made available by the authors, without undue reservation.

Author contributions

FF: Writing – review and editing, Investigation, Software, Conceptualization, Writing – original draft, Supervision, Visualization, Data curation, Project administration, Formal Analysis, Methodology. RP: Conceptualization, Investigation, Formal Analysis, Writing – review and editing, Methodology, Writing – original draft. FL: Writing – review and editing, Software, Data curation.

Funding

The authors declare that financial support was received for the research and/or publication of this article. We would like to thank for funding of the work by the Research Council of Norway through project number 332023.

Acknowledgments

Acknowledgements

The authors wish to thank Terje Nilsen at Kongsberg Discovery for the access to an H100 GPU for the simulations.

Conflict of interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Generative AI statement

The authors declare that no Generative AI was used in the creation of this manuscript.

Any alternative text (alt text) provided alongside figures in this article has been generated by Frontiers with the support of artificial intelligence and reasonable efforts have been made to ensure accuracy, including review by the authors wherever possible. If you identify any issues, please contact us.

Publisher’s note

All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article, or claim that may be made by its manufacturer, is not guaranteed or endorsed by the publisher.

Supplementary material

The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/frqst.2025.1636042/full#supplementary-material

References

Aardal, K. I., van Hoesel, S. P. M., Koster, A. M. C. A., Mannino, C., and Sassano, A. (2007). Models and solution techniques for frequency assignment problems. Ann. Operations Res. 153 (1), 79–129. doi:10.1007/s10479-007-0178-0

CrossRef Full Text | Google Scholar

Alan, F., and Jerrum, M. (1997). Improved approximation algorithms for maxk-cut and max bisection. Algorithmica 18 (1), 67–81. doi:10.1007/BF02523688

CrossRef Full Text | Google Scholar

Bartschi, A., and Eidenbenz, S. (2020). “Grover mixers for qaoa: shifting complexity from mixer design to state preparation,” in 2020 IEEE International Conference on Quantum Computing and Engineering (QCE) (IEEE), 72–82. doi:10.1109/qce49297.2020.00020

CrossRef Full Text | Google Scholar

Bravyi, S., Kliesch, A., Koenig, R., and Tang, E. (2020). Obstacles to variational quantum optimization from symmetry protection. Phys. Rev. Lett. 125 (26), 260505. doi:10.1103/PhysRevLett.125.260505

PubMed Abstract | CrossRef Full Text | Google Scholar

Egger, D. J., Mareček, J., and Woerner, S. (2021). Warm-starting quantum optimization. Quantum 5, 479. doi:10.22331/q-2021-06-17-479

CrossRef Full Text | Google Scholar

Farhi, E., Goldstone, J., and Gutmann, S. (2014). A quantum approximate optimization algorithm. arXiv Prepr. arXiv:1411.4028. doi:10.48550/arXiv.1411.4028

CrossRef Full Text | Google Scholar

Fuchs, F. G., and Bassa, R. P. (2024). Lx-mixers for qaoa: optimal mixers restricted to subspaces and the stabilizer formalism. Quantum 8, 1535–11. doi:10.22331/q-2024-11-25-1535

CrossRef Full Text | Google Scholar

Fuchs, F. G., and Bassa, R. P. (2025). Compact circuits for constrained quantum evolutions of sparse operators. arXiv. doi:10.48550/arXiv.2504.09133

CrossRef Full Text | Google Scholar

Fuchs, F. G., Kolden, H. Ø., Henrik Aase, N., and Sartor, G. (2021). Efficient encoding of the weighted MAX $$k$$-CUT on a quantum computer using QAOA. SN Comput. Sci. 2 (2), 89. doi:10.1007/s42979-020-00437-z

CrossRef Full Text | Google Scholar

Fuchs, F. G., Olsen Lye, K., Nilsen, H. M., Stasik, A. J., and Sartor, G. (2022). Constraint preserving mixers for the quantum approximate optimization algorithm. Algorithms 15 (6), 202. doi:10.3390/a15060202

CrossRef Full Text | Google Scholar

Hadfield, S., Wang, Z., Rieffel, E. G., O’Gorman, B., Venturelli, D., and Biswas, R. (2017). “Quantum approximate optimization with hard and soft constraints,” in Proceedings of the second international workshop on post moores era supercomputing, 15–21. doi:10.1145/3149526.3149530

CrossRef Full Text | Google Scholar

Hadfield, S., Wang, Z., O’Gorman, B., Rieffel, E. G., Venturelli, D., and Biswas, R. (2019). From the quantum approximate optimization algorithm to a quantum alternating operator ansatz. Algorithms 12 (2), 34. doi:10.3390/a12020034

CrossRef Full Text | Google Scholar

Nagies, S., Geier, K. T., Akram, J., Bantounas, D., Johanning, M., and Hauke, P. (2025). Boosting quantum annealing performance through direct polynomial unconstrained binary optimization. Quantum Sci. Technol. 10 (3), 035008. doi:10.1088/2058-9565/adcae6

CrossRef Full Text | Google Scholar

Ram Gaur, D., Krishnamurti, R., and Kohli, R. (2008). The capacitated max k-cut problem. Math. Program. 115 (1), 65–72. doi:10.1007/s10107-007-0139-z

CrossRef Full Text | Google Scholar

Shukla, A., and Vedula, P. (2024). An efficient quantum algorithm for preparation of uniform quantum superposition states. Quantum Inf. Process. 23 (2), 38–1332. doi:10.1007/s11128-024-04258-4

CrossRef Full Text | Google Scholar

Wang, Z., Rubin, N. C., Dominy, J. M., and Rieffel, E. G. (2020). XY mixers: analytical and numerical results for the quantum alternating operator ansatz. Phys. Rev. A 101 (1), 012320. doi:10.1103/physreva.101.012320

CrossRef Full Text | Google Scholar

Wurtz, J., Sack, S. H., and Wang, S.-T. (2024). Solving non-native combinatorial optimization problems using hybrid quantum-classical algorithms. IEEE Trans. Quantum Eng. 5, 1–14. doi:10.1109/tqe.2024.3443660

CrossRef Full Text | Google Scholar

Zhou, L., Wang, S.-T., Choi, S., Pichler, H., and Lukin, M. D. (2020). Quantum approximate optimization algorithm: performance, mechanism, and implementation on near-term devices. Phys. Rev. X 10 (2), 021067. doi:10.1103/physrevx.10.021067

CrossRef Full Text | Google Scholar

Zhu, L., Tang, Ho L., Barron, G. S., Calderon-Vargas, F. A., Mayhall, N. J., Barnes, E., et al. (2022). Adaptive quantum approximate optimization algorithm for solving combinatorial problems on a quantum computer. Phys. Rev. Res. 4 (3), 033029. doi:10.1103/PhysRevResearch.4.033029

CrossRef Full Text | Google Scholar

Keywords: quantum optimization algorithm, quantum circuit compilation, quantum approximate optimization algorithm, quantum technologies, variational quantum circuits

Citation: Fuchs FG, Pariente Bassa R and Lien F (2025) Encodings of the weighted MAX k-CUT problem on qubit systems. Front. Quantum Sci. Technol. 4:1636042. doi: 10.3389/frqst.2025.1636042

Received: 27 May 2025; Accepted: 15 August 2025;
Published: 04 December 2025.

Edited by:

Jaewoo Joo, University of Portsmouth, United Kingdom

Reviewed by:

Saravana Prakash Thirumuruganandham, SIT Health, Ecuador
Bikas K Chakrabarti, Saha Institute of Nuclear Physics (SINP), India

Copyright © 2025 Fuchs, Pariente Bassa and Lien. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Ruben Pariente Bassa, c2Nvb21lbnNAZ21haWwuY29t

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.