Abstract
Quantum algorithm is an algorithm for solving mathematical problems using quantum systems encoded as information, which is found to outperform classical algorithms in some specific cases. The objective of this study is to develop a quantum algorithm for finding the roots of nth degree polynomials where n is any positive integer. In classical algorithm, the resources required for solving this problem increase drastically when n increases and it would be impossible to practically solve the problem when n is large. It was found that any polynomial can be rearranged into a corresponding companion matrix, whose eigenvalues are roots of the polynomial. This leads to a possibility to perform a quantum algorithm where the number of computational resources increase as a polynomial of n. In this study, we construct a quantum circuit representing the companion matrix and use eigenvalue estimation technique to find roots of polynomial.
1 Introduction
Roots finding is a centuries-old problem that has continued to attract considerable research interests and efforts due to its relevance in many fields of mathematics and physics involving geometry, number theory, probability and combinatorics. It is well known that for a polynomial of degree 4 or less, there exists a formula or procedure to solve for its roots exactly [1]. However, such a task is impossible for a polynomial of degree 5 or greater [2]. Many root-finding algorithms have been devised for obtain approximated roots of a polynomial of arbitrary degree [3, 4, 5].
The plausibility of a quantum computer—a new type of computation, which embraces quantum mechanics into its information, algorithms, and output measurements—has entailed quantum algorithms. A simple enhancement by rather non-intuitive mathematics of quantum mechanics like superposition, the uncertainty principle, and entanglement, brings quantum algorithms forth to a new level of computation unreachable before by conventional computers with classical algorithms. For example, the Shor’s algorithm, an algorithm to factorize a large integer into a product of primes, is proven in principles to overcome the classical-algorithm limit in terms of speed [6]. A breakthrough in quantum simulation is expected to bring eminent impact into science and technology [7, 8]. Recent progress on the actual quantum devices, such as a successful small-molecule simulation [9, 10, 11, 12] or probing the statistics of quantum systems [13, 14, 15], have yielded high promises and attracted immense interests. The advancement of computation and simulation in the aforementioned examples owes largely to a common underlying method called phase estimation algorithm (PEA) [16]. Still, PEA can be improved, especially at the fundamental algorithm of finding roots of a polynomial.
However, PEA is only applicable to unitary operators which are not always the case for some quantum algorithms; for instance, the phase measurement under the circumstance where decoherence is present in the process [17]. In a measurement process of the quantum algorithm, the non-unitary matrices also play key roles as projective operators. In order to modify existing PEA to be
suitable for eigenvalue problems comprehensively, a programmable circuit, and measurement of the control and ancillary qubits are recently exploited to tailor-made any arbitrary matrix [18]. The great advantage of this proposed scheme is that any matrix can be constructed and the control gate of the respective matrix can be realized, paving ways to build a quantum computer which can calculate eigenvalue of any matrix. However, some drawbacks exist as the algorithm itself may not be efficient for complicated matrices, which quantum complexity arises following the increasing number of non-zero matrix elements [19]. Further investigation on the algorithm in terms of appropriate complexity is still needed.
Our main aim in this paper is to propose a modified quantum phase estimation algorithm for finding polynomial roots, where we present a benchmark implementation of quantum non-unitary eigenvalue calculation scheme for polynomials. This specific task represents the least complex eigenvalue, which the algorithm can be fruitful without too much concern over the complexity.
This article is organized as follows. The remaining subsections of this section will cover key concepts and ideas about the phase estimate algorithm, and the iterated phase estimate algorithm (IPEA) for unitary operators, as well as the quantum algorithm to find complex eigenvalues of a general matrix. In Section II, we present our modified PEA and IPEA, together with the companion matrix approach, and more importantly, the circuit design to estimate roots of a polynomial of degree n. There we focus our presentation of the circuit operation and outputs, leaving the discussion and complexity analysis in Section III. Finally, the conclusions are summarized in Section IV.
1.1 PEA and IPEA for Eigenvalue Problems of Unitary Operators
In the original version of PEA, a phase φ arising after a unitary evolution U with eigenvalue exp(2πφi) is operated on its basis. Because a quantum evolution can be interpreted by a phase factor U = exp(−iHt/~), where H is a Hamiltonian of a finite system, the phase as a result of the phase estimation algorithm is indeed the eigenvalue of the Hamiltonian. PEA has also been introduced as a potential quantum tool to effectively solve various eigenvalue problems involving unitary operators [20, 21, 22, 23]. The unitary operators play a central role in all of the quantum algorithms, as they are required for universal quantum computations [24].
In order to estimate the value of a phase parameter ωj up to the b bit-precision using PEA, b ancillary qubits in control register are required. In practice, however, the number of qubits which can be implemented is very limited. Iterative Phase Estimation Algorithm (IPEA) is an algorithm improved from the original PEA with an aim to estimate ωj up to bth digit while using only one ancillary qubit together with b iterations as a result of scalable inverse quantum Fourier transform in a semi-classical manner [25, 26]. In order to explain the algorithm as illustrated in Figure 1, we first assume that the phase parameter ωj has a binary expansion no more than b digits (written as ωj = 0.x1x2x3 . . . xb000 . . .). Initially, all of the ancillary qubits are prepared in state |0〉 and the target register is prepared in the eigenstate

A circuit for the kth iteration of the IPEA where θk is the feedback from prior iterations.
where θ1 = 0 are applied. After that, the second Hadamard gate is applied on the control qubit and its state is measured in the computational basis {|0〉, |1〉}. This results in state
whose measurement gives either 0 or 1, and is determined by the majority probability between |0〉 and |1〉. This measurement result consequently dictates the value of xb. The next iteration is performed with the
The original IPEA has been used to determine only the phase parameter ωj of the eigenvalue
1.2 Quantum Algorithm for Finding Complex Eigenvalues of General Matrices
Recently, Daskin et al. have introduced their technique to find the complex eigenvalues of general matrices [18]. In order to employ the IPEA on the non-unitary operators, first of all, the non-unitary operator O has to be controlled by a phase qubit and the
In the scheme proposed by Daskin et al., the decomposition of the control gate of the non-unitary operator O of size N = 2m uses the programmable circuit design, which requires m +1 ancillary qubits and m main qubits [18]. The operator O generally has a eigenvalue of the form
where p and m denote phase qubit and main qubits, respectively. As can be seen, the
where N is the dimension of matrix. In practice, |λj| is determined by the statistics of the measurement. We can also improve the accuracy of the estimation by using the statistics from other iterations. For the kth iteration after which
Since we can estimate both |λj| and ωj, the complex eigenvalue λj can be determined.
2 Quantum Algorithm for Finding Polynomial Roots
2.1 Companion Matrix Approach
As the aim of this study is to find roots of a generic polynomial of degree n, we can formulate this problem as the eigenvalue problem of a non-unitary operator. First of all, consider
it can be factorized into the form
where z1, z2, . . . , zn ∈ C are the roots of p(x). From general linear algebra [27], the roots of polynomial p(x) are eigenvalues of its companion matrix defined as
with respect to the basis {1, x, x2, . . . , xn−1}.
Daskin’s algorithm requires that the absolute value of every coefficient ai must be less than or equal to 1, since rotation gates are used to simulate these coefficients. Therefore, we introduce a scaling method to meet this requirement. Let amax denote the greatest absolute value of a0, a1, . . . , an. We choose a basis of circuit in the x-mode or (1/x)-mode depending on whether |an| or |a0| is greater to maximize the success probability of the circuit scheme.
In case |an| > |a0|, the x-mode will be chosen, so the polynomial p(x) can be equivalently expressed in the form
Let μ = amax/an be a scaling factor. Then the corresponding eigenvalue equation is written as
where
On the other hand, if |a0| > |an|, the (1/x)-mode will be used. Dividing the polynomial p(x) by amaxxn leads to
In this case, a scaling factor is μ = amax/a0, and the corresponding eigenvalue equation is in the form
where
However, the traditional companion matrix as described in (8) has 1’s in the upper diagonal entries but all of such entries of the modified companion matrices as shown in (10) and (12) have absolute values less than 1. To rectify this, we introduce a scaling gate Sm,μ which will be explained in details later; see Equation (21).
2.2 Quantum Circuit Design
Our design of the respective algorithm relies on Polynomial Representative Circuit (PRC), a circuit to represent this modified companion matrix as illustrated in Figure 2. PRC requires m main qubits and 2 ancillary qubits where 2m = n is a degree of the polynomial. (Although it is inconvenient, the circuit is also applicable for n ≠ 2m simply by shifting the degree of polynomial up to the nearest power of 2.) First, let the main qubit be prepared in the initial state :

Polynomial Representative Circuit (PRC) which is used to represent an operation of a companion matrix.
and we define |β〉 as a result of Cp operating on |α〉; i.e.
Multiplying |α〉 by the modified companion matrix from (10) or (12) gives |β〉 in the form:
where
which can be implemented by the Toffoli gates as shown in Figure 3.

The cyclic-swap gate can be implemented by a sequence of Toffoli gates.
The aim of the operator Cs is to generate the matrix element of the companion matrix from row 1 to row n − 1. Since the operation is underpinned by the presences of the sequences of Toffoli gates, the algorithm will be plagued by the huge complexity. The complexity of the algorithm is quite large, and yet still smaller than that of Daskin’s scheme, as their matrix elements are generated by the formation block which incurs more complexity.
The formation block in our version plays a role of the controlled gate of an operator Fμ, which represents the components in the last row of the modified companion matrix Cp as in (10) or (12). The rotation gate Ri is represented by a matrix as follows:
where i = 0, 1, 2, . . . , n − 1. Accordingly, the array of Ri forms the block matrix F μ as follows:
The operation of F μ can be simulated by a sequence of controlled-rotation gates as in Figure 4. The operation of F μ will be performed on main qubits and the second ancillary qubit in case that the state of first ancillary qubit is |1〉.

The formation block can be simulated by a sequence of controlled-rotation gates.
Next step, in the combination block, we define the operator C as follows:
where "•" represents the elements we can neglected because they will be filter out by post-selection at the final stage of the algorithm.
There are three sub-tasks to undertake in the combination block. First, a controlled-C gate with the operator C is operated on the main qubits conditioning to the state of the first ancillary qubit as |1〉 to create the
qubits and second ancillary qubit conditioning to the first ancillary state |1〉 give the following output:
with the probability amplitude
This gate is, in fact, a rotation gate Ry(θ), where θ =
However, referring to (22), the final state is not exactly |β〉. The last task is just to swap between the coefficient α0 and
where
2.3 Polynomial Root-finding by Eigenvalue Estimation Technique
In order to find roots of the polynomial, we will use the circuit shown in Figure 5. A controlled operation of the PRC by the phase qubit is denoted by c-Cp in the figure. To describe the operation, we will firstly assume that the main qubits are initially prepared in an eigenstate

A circuit scheme for finding polynomial roots.
Here we will assume that ωj has a binary expansion in the form ωj = 0.x1x2x3 . . . xb, where b is bit-precision. As in IPEA, the c-Cp will be operated 2b−k times in the kth iteration as illustrated in Figure 6. The result of the first iteration is given by

In order to estimate polynomial roots up to b bit-precision, c-Cp must be operated 2b−k times in the kth iteration.
Similarly, for the kth iteration, we have
After the operation of Z(θk) with θ1 = 0 and θk = 2π (0.0xb−k+2xb−k+3 . . . xb) followed by the Hadamard gate, the phase qubit will be in the following state,
The value of xb−k+1 can be either 0 or 1. Therefore, the probabilities of finding the phase qubit in states |0〉 or |1〉 given that the both ancillary qubits give result 0 depend on the value of xb−k+1; namely,
Since xb−k+1 can be either 0 or 1, the value of cos(2π0.xb−k+1) is either +1 or −1. In practice, xb can be obtained by comparing P0 and P1 [25], i.e., xb = 0 if and only if P0 > P1; and xb = 1 if and only if P0 < P1. In addition, the value of |λj| from the kth iteration can be calculated from the equation
It should be emphasized that in later iterations, the parameter θk used in Z(θk) is constructed from xb−k+1 from the prior iterations as in IPEA. Finally, an estimate of λj can now be obtained and the corresponding root of the polynomial can be calculated depending on which mode (x-mode or 1/x-mode) is being used.
However, in general, the eigenstates of the companion matrix are unknown. The following approach is to estimate the greatest eigenvalue |λmax|. Suppose that an initial state is prepared in a mixed state, the density operator can be expressed as
where Aj is a probability of preparing the initial state in the eigenstate
For the kth iteration after which
where
The value of x b−k+1 can be found by comparing P0 and P1. Even without knowing the probability Amax, an estimate of |λmax| can be obtained from
After the largest root is found, it can be factorized from the polynomial, and the same technique and procedure can be repeated to calculate the other roots.
3 Discussion
In order to justify the efficiency of the quantum algorithm for finding roots of a polynomial, we have to compare it with the classical algorithm for solving the same problem. One of the most efficient classical algorithms for finding roots of a polynomial was created by Pan in 2002 [28]. We shall compare these two versions of the algorithm based on (i) resources required for calculation and (ii) algorithmic complexity.
We start by comparing the number of bits and qubits required by the computations. In order to find roots of an nth degree polynomial, the quantum algorithm requires O(log n) qubits. In contrast, the Pan’s classical root-finding algorithm requires O(n) or O(n log n) bits. This makes it obvious that the quantum algorithm requires significantly fewer bits than its classical counterpart. In this way, especially for larger n, the quantum version of algorithm is capable for finding roots of a much higher order degree than the classical one.
Next, we will compare their algorithmic complexities. In Pan’s algorithm, the number of operations required to find the roots is
where b is the bit precision of the solutions. In contrast, since any m-qubit unitary gates can be simulated using only single-qubit gates and CNOT gates [29], it is appropriate to compute the complexity of a quantum circuit in terms of the number of single-qubit gates and CNOT gates required to construct the circuit. From polynomial root-finding circuit, many unitary operations are controlled by several qubits. We will use the following corollary to calculate complexity of these gates (See Corollary 7.12 in Barenco et al. [24]).
Corollary: For any unitary U, the corresponding c-U gate controlled by (m − 2)-qubit can be simulated by O(m) basic operations in m-qubit network, where the initial value of one qubit is fixed and incurs no net change.
In order to apply this corollary with the root-finding circuit, we need one more ancillary qubit and set its initial value to state |0〉. Note that this ancillary qubit can also be reused to simulate several controlled-unitary operations. In order to compute the overall complexity of the whole circuit, a complexity of each part may be found separately. The cyclic-swap gate can be simulated by m CNOT gates. Number of control qubits of each gate varies from 0 to m−1. For other CNOT gates with multiple control qubits, its operation can be simulated by O(i+2) operations where i > 1 is the number of control qubits. Therefore the overall complexity of the cyclic-swap gate is
The total complexity of the complete circuit is the sum of complexity of each part as described above. However, in the complexity calculation, only the greatest term is kept. In the case of large n (where n is the degree of a polynomial), we can clearly see that the dominant term comes from the formation gate. Therefore, the complexity of the circuit in terms of the degree of a polynomial is
for one iteration, or
for k iterations. Compared with the classical case for b-bit precision, our approach needs k = 2b and the total complexity of the quantum version is
Comparing between (38) and (41) (see Figure 7), at certain values of b with increasing n, the quantum algorithm performs faster than the classical one at high n.However, there are some disadvantage influences of b, when the computation is undertaken with higher bit-precision requirements on low degree polynomials.

We compare the number of operations needed for our quantum algorithm (magenta for b = 3, red for b = 8) and the best known classical algorithm (blue for b = 3, green for b = 8), with the increasing n. Our algorithm clearly outperforms the classical one for the calculation with high n for both values of b (upper figure), especially at low bit-precision. For low n, the bit-precision b increases the number of operations exponentially, instead of linearly as in the Pan’s classical algorithm.
In addition, the rising complexity of the algorithm for high degree polynomials can possibly be inflicted by its inscalable success probability. Following (22), the success probability is diminished to 1/2mμ and will require more iterations to maintain the precision. As a consequence, the increase iterations will effectively raise the complexity.
However, here we can validate that the quantum version of the algorithm is less complex than the classical version in the case where the polynomial has a high degree.On the contrary, the quantum algorithm may be an overkill when finding the roots, with high-bit precision, of a low degree polynomial.
4 Conclusion
Polynomials are the key foundation of various calculations in mathematics and physics. The computational advantages provided by this quantum-based algorithm could be very useful for a broad field of studies [30, 31, 32, 33, 34, 35, 36, 37]. However, to implement this algorithm in further application efficiently, some requirements of the particular task must be considered. In summary, we have provided a quantum algorithm for finding roots of the nth degree polynomial partially based on Daskin et al.’s circuit for finding complex eigenvalues of a general matrix [18]. To make a comparison with classical version of the algorithm, resources and algorithmic complexities are considered. The quantum version requires significantly fewer number of (quantum) bits than its classical counterpart for a high degree polynomial. In terms of algorithm complexities, the quantum algorithm also trumps the classical algorithms for a high degree polynomial, requiring low bit-precision solutions. The growth in complexity stems from a larger number of iterations needed to achieve the desired precision. Although our result clearly shows that finding the roots of polynomials using quantum information scheme is possible, the most important challenge, however, remains in strengthening the algorithm to overcome the classical algorithm both in the utilized resources and the chosen precisions. Another challenge lies of course in the practical issue of a working quantum computer. It is well known that the current quantum computer technology still falls short of the theoretical requirement of the algorithm, especially in terms of the number of entangled qubits and multiple-qubit quantum operations.
Acknowledgement
We would like to thank Assist. Prof. Dr. Kwan Arayathanitkul for helpful discussions.T.T. acknowledges the support of The Queen Sirikit Scholarship under The Royal Patronage of Her Majesty Queen Sirikit of Thailand. This work is a collaboration of Collaborative Research Unit on Quantum Information, Mahidol University and Optical and Quantum Communication (OQC) Laboratory, National Electronics and Computer Technology Center (NECTEC). Grant No. 035/2557 from the Development and Promotion of Science and Technology Talents project (DPST) scholarship, research fund for DPST graduate with first placement is acknowledged.
References
[1] Weisstein E.W., CRC encyclopedia of mathematics, 2nd ed., CRC Press Taylor & Francis, Boca Raton, Florida, 2009Search in Google Scholar
[2] Jacobson N.,Basic algebra 1, 2nd ed.,Dover, 2009Search in Google Scholar
[3] McNamee J.M., Numerical Methods for Roots of Polynomials, Part 1, Elsevier, Amsterdam, The Netherlands, 2007Search in Google Scholar
[4] Mekwi W.R., Iterative methods for roots of polynomials, Master’s thesis, University of Oxford, Oxford, UK, 2001Search in Google Scholar
[5] Pan V.Y., Solving a Polynomial Equation: Some History and Recent Progress, SIAM Review,1997, 39, 187-22010.1137/S0036144595288554Search in Google Scholar
[6] Shor P.W., Algorithms for quantum computation: discrete logarithms and factoring, In: Goldwasser S.(Ed.), Proceedings 35th Annual Symposium on Foundations of Computer Science (20-22 Nov 1994, Santa Fe, NM, USA), IEEE Comput. Soc. Press, 1994, 124–13410.1109/SFCS.1994.365700Search in Google Scholar
[7] Lloyd S., Universal Quantum Simulators, Science, 1996, 273, 1073–107810.1126/science.273.5278.1073Search in Google Scholar PubMed
[8] Feynman R.P., Simulating Physics with Computers, Int. J. Thy. Phys., 1982, 21, 467–48810.1007/BF02650179Search in Google Scholar
[9] Aspuru-Guzik A., Dutoi A.D., Love P.J., Head-Gordon M., Simulated Quantum Computation of Molecular Energies, Science, 2005, 309, 1704–170710.1126/science.1113479Search in Google Scholar PubMed
[10] Ma X.S., Dakic B., Naylor W., Zeilinger A., Walther P., Quantum simulation of the wavefunction to probe frustrated Heisenberg spin systems, Nature Phys., 2011, 7, 399–40510.1038/nphys1919Search in Google Scholar
[11] Brown K.R., Clark R.J., Chuang I.L.,Limitations of Quantum Simulation Examined by Simulating a Pairing Hamiltonian Using Nuclear Magnetic Resonance, Phys. Rev. Lett., 2006, 97, 05050410.1103/PhysRevLett.97.050504Search in Google Scholar PubMed
[12] Negrevergne C., Somma R., Ortiz G., Knill E., Laflamme R., Liquid-state NMR simulations of quantum many-body problems, Phys. Rev. A, 2005, 71, 03234410.1103/PhysRevA.71.032344Search in Google Scholar
[13] Matthews J.C.F., Poulios K., Meinecke J.D.A., Politi A., Peruzzo A., Ismail N., Wörhoff K., Thompson M.G., O’Brien J.L.,Observing fermionic statistics with photons in arbitrary processes, Sci. Rep., 2013, 3, 153910.1038/srep01539Search in Google Scholar PubMed PubMed Central
[14] Ovidiu I.P., Correlation functions and momentum distribution of one-dimensional hard-core anyons in optical lattices, Journal of Statistical Mechanics: Theory and Experiment, 2015, 1, P0100410.1088/1742-5468/2015/01/P01004Search in Google Scholar
[15] Crespi A., Suppression laws for multiparticle interference in Sylvester interferometers, Phys. Rev. A, 2015, 91, 01381110.1103/PhysRevA.91.013811Search in Google Scholar
[16] A.Y. Kitaev, Quantum measurements and the Abelian Stabilizer Problem, Coll. Comput. Complex., 1996, 3, 3Search in Google Scholar
[17] Kacprowicz M., Demkowics-Dobrzanski R., Wasilewski w., Banszek K., Walmsley I.A., Experimental quantum-enhanced estimation of a lossy phase shift, Nature Photonics, 2010, 4, 357–36010.1038/nphoton.2010.39Search in Google Scholar
[18] Daskin A., Grama A., Kais S., A universal quantum circuit scheme for finding complex eigenvalues, Quantum Information Processing, 2014, 13, 333–353.10.1007/s11128-013-0654-1Search in Google Scholar
[19] Daskin A., Grama A., Kollias G., Kais S., Universal programmable quantum circuit schemes to emulate an operator, J. Chem. Phys., 2012, 137, 23411210.1063/1.4772185Search in Google Scholar PubMed
[20] Abrams D.S., Lloyd S., Quantum Algorithm Providing Exponential Speed Increase for Finding Eigenvalues and Eigenvectors, Phys. Rev. Lett., 1999, 83, 516210.1103/PhysRevLett.83.5162Search in Google Scholar
[21] Zhou X.Q., Kalasuwan P.,Ralph T.C., O’Brien J.L., Calculating unknown eigenvalues with a quantum algorithm, Nature Photonics, 2013, 7, 223–22810.1038/nphoton.2012.360Search in Google Scholar
[22] Wang H., Wu L.A., Liu Y.x., Nori F., Measurement-based quantum phase estimation algorithm for finding eigenvalues of non-unitary matrices, Phys. Rev. A, 2010, 82, 06230310.1103/PhysRevA.82.062303Search in Google Scholar
[23] Barz S., Kassal I., Ringbauer M., Lipp Y.O., Dakic B., Aspuru-Guzik A., Walther P., Univariate Polynomials: Nearly Optimal Algorithms for Numerical Factorization and Root-finding, Scientific Reports, 2014, 4, 611EP10.1038/srep06115Search in Google Scholar PubMed PubMed Central
[24] Barenco A., Bennett C.H., Cleve R., Vincenzo D.P.D., Margolus N., Shor P., Sleator T., Smolin J.A., Weinfurter H., Elementary gates for quantum computation, Phys. Rev. A, 1995, 52,345710.1103/PhysRevA.52.3457Search in Google Scholar PubMed
[25] Griflths R.B., Niu C.S., Semiclassical Fourier Transform for Quantum Computation, Phys. Rev. Lett., 1996, 76, 322810.1103/PhysRevLett.76.3228Search in Google Scholar PubMed
[26] Chiaverini J., Britton J., Leibfried D., Knill E., Barrett M.D., Blakestad R.B., Itano W.M., Jost J.D., Langer C., Ozeri R., Schaetz T., Wineland D.J., Implementation of the Semiclassical Quantum Fourier Transform in a Scalable System, Science, 2005, 308, 997–100010.1126/science.1110335Search in Google Scholar PubMed
[27] Buchberger B., An algorithmic method in polynomial ideal theory, D. Reidel Publishing Company, Dordrecht, Boston Langcaster, 198510.1007/978-94-009-5225-6_6Search in Google Scholar
[28] Pan V.Y., Univariate Polynomials: Nearly Optimal Algorithms for Numerical Factorization and Root-finding, Journal of Symbolic Computation, 2002, 33, 701–73310.1006/jsco.2002.0531Search in Google Scholar
[29] Barenco A., A universal two-bit gate for quantum computation, Proc. R. Soc. Lond. A, 1995, 449, 67910.1098/rspa.1995.0066Search in Google Scholar
[30] Hoffmann C.M., Geometric and Solid Modeling, San Mateo, California, 1989Search in Google Scholar
[31] Go N., Scherga H.A., Ring Closure and Local Conformational Deformations of Chain Molecules, Macromolecules, 1970, 3, 178– 18710.1021/ma60014a012Search in Google Scholar
[32] Faugeras O., Three-Dimensional Computer Vision : A Geometric Viewpoint, MIT Press, Cambridge, Massachusate, 1993Search in Google Scholar
[33] Bishop G., Fuchs H, Research directions in virtual environments, Computer Graphics, 1992, 26, 15310.1145/142413.142416Search in Google Scholar
[34] Baleanu D., Asad J.H., Jajarmi A., New aspects of the motion of a particle in a circular cavity, P ROMANIAN ACAD A, 2018, 19, 361–36710.1186/s13662-018-1684-xSearch in Google Scholar
[35] Baleanu D., Asad J.H., Jajarmi A., Classical and fractional aspects of two coupled pendulums, ROM REP PHYS, 2019, 71, 103Search in Google Scholar
[36] Massey J., Step-by-step Decoding of the Bose-Chadhuri-Hocquenghem Codes, IEEE Trans. Inf. Theory, 1965, 11, 580–58510.1109/TIT.1965.1053833Search in Google Scholar
[37] Hong J., Vetterli M., Simple ALgorithms for BCH Decoding, IEEE Trans. Commun., 1995, 43, 2324–233310.1109/26.403765Search in Google Scholar
© 2019 T. Tansuwannont et al., published by De Gruyter
This work is licensed under the Creative Commons Attribution 4.0 International License.
Articles in the same Issue
- Regular Articles
- Non-equilibrium Phase Transitions in 2D Small-World Networks: Competing Dynamics
- Harmonic waves solution in dual-phase-lag magneto-thermoelasticity
- Multiplicative topological indices of honeycomb derived networks
- Zagreb Polynomials and redefined Zagreb indices of nanostar dendrimers
- Solar concentrators manufacture and automation
- Idea of multi cohesive areas - foundation, current status and perspective
- Derivation method of numerous dynamics in the Special Theory of Relativity
- An application of Nwogu’s Boussinesq model to analyze the head-on collision process between hydroelastic solitary waves
- Competing Risks Model with Partially Step-Stress Accelerate Life Tests in Analyses Lifetime Chen Data under Type-II Censoring Scheme
- Group velocity mismatch at ultrashort electromagnetic pulse propagation in nonlinear metamaterials
- Investigating the impact of dissolved natural gas on the flow characteristics of multicomponent fluid in pipelines
- Analysis of impact load on tubing and shock absorption during perforating
- Energy characteristics of a nonlinear layer at resonant frequencies of wave scattering and generation
- Ion charge separation with new generation of nuclear emulsion films
- On the influence of water on fragmentation of the amino acid L-threonine
- Formulation of heat conduction and thermal conductivity of metals
- Displacement Reliability Analysis of Submerged Multi-body Structure’s Floating Body for Connection Gaps
- Deposits of iron oxides in the human globus pallidus
- Integrability, exact solutions and nonlinear dynamics of a nonisospectral integral-differential system
- Bounds for partition dimension of M-wheels
- Visual Analysis of Cylindrically Polarized Light Beams’ Focal Characteristics by Path Integral
- Analysis of repulsive central universal force field on solar and galactic dynamics
- Solitary Wave Solution of Nonlinear PDEs Arising in Mathematical Physics
- Understanding quantum mechanics: a review and synthesis in precise language
- Plane Wave Reflection in a Compressible Half Space with Initial Stress
- Evaluation of the realism of a full-color reflection H2 analog hologram recorded on ultra-fine-grain silver-halide material
- Graph cutting and its application to biological data
- Time fractional modified KdV-type equations: Lie symmetries, exact solutions and conservation laws
- Exact solutions of equal-width equation and its conservation laws
- MHD and Slip Effect on Two-immiscible Third Grade Fluid on Thin Film Flow over a Vertical Moving Belt
- Vibration Analysis of a Three-Layered FGM Cylindrical Shell Including the Effect Of Ring Support
- Hybrid censoring samples in assessment the lifetime performance index of Chen distributed products
- Study on the law of coal resistivity variation in the process of gas adsorption/desorption
- Mapping of Lineament Structures from Aeromagnetic and Landsat Data Over Ankpa Area of Lower Benue Trough, Nigeria
- Beta Generalized Exponentiated Frechet Distribution with Applications
- INS/gravity gradient aided navigation based on gravitation field particle filter
- Electrodynamics in Euclidean Space Time Geometries
- Dynamics and Wear Analysis of Hydraulic Turbines in Solid-liquid Two-phase Flow
- On Numerical Solution Of The Time Fractional Advection-Diffusion Equation Involving Atangana-Baleanu-Caputo Derivative
- New Complex Solutions to the Nonlinear Electrical Transmission Line Model
- The effects of quantum spectrum of 4 + n-dimensional water around a DNA on pure water in four dimensional universe
- Quantum Phase Estimation Algorithm for Finding Polynomial Roots
- Vibration Equation of Fractional Order Describing Viscoelasticity and Viscous Inertia
- The Errors Recognition and Compensation for the Numerical Control Machine Tools Based on Laser Testing Technology
- Evaluation and Decision Making of Organization Quality Specific Immunity Based on MGDM-IPLAO Method
- Key Frame Extraction of Multi-Resolution Remote Sensing Images Under Quality Constraint
- Influences of Contact Force towards Dressing Contiguous Sense of Linen Clothing
- Modeling and optimization of urban rail transit scheduling with adaptive fruit fly optimization algorithm
- The pseudo-limit problem existing in electromagnetic radiation transmission and its mathematical physics principle analysis
- Chaos synchronization of fractional–order discrete–time systems with different dimensions using two scaling matrices
- Stress Characteristics and Overload Failure Analysis of Cemented Sand and Gravel Dam in Naheng Reservoir
- A Big Data Analysis Method Based on Modified Collaborative Filtering Recommendation Algorithms
- Semi-supervised Classification Based Mixed Sampling for Imbalanced Data
- The Influence of Trading Volume, Market Trend, and Monetary Policy on Characteristics of the Chinese Stock Exchange: An Econophysics Perspective
- Estimation of sand water content using GPR combined time-frequency analysis in the Ordos Basin, China
- Special Issue Applications of Nonlinear Dynamics
- Discrete approximate iterative method for fuzzy investment portfolio based on transaction cost threshold constraint
- Multi-objective performance optimization of ORC cycle based on improved ant colony algorithm
- Information retrieval algorithm of industrial cluster based on vector space
- Parametric model updating with frequency and MAC combined objective function of port crane structure based on operational modal analysis
- Evacuation simulation of different flow ratios in low-density state
- A pointer location algorithm for computer visionbased automatic reading recognition of pointer gauges
- A cloud computing separation model based on information flow
- Optimizing model and algorithm for railway freight loading problem
- Denoising data acquisition algorithm for array pixelated CdZnTe nuclear detector
- Radiation effects of nuclear physics rays on hepatoma cells
- Special issue: XXVth Symposium on Electromagnetic Phenomena in Nonlinear Circuits (EPNC2018)
- A study on numerical integration methods for rendering atmospheric scattering phenomenon
- Wave propagation time optimization for geodesic distances calculation using the Heat Method
- Analysis of electricity generation efficiency in photovoltaic building systems made of HIT-IBC cells for multi-family residential buildings
- A structural quality evaluation model for three-dimensional simulations
- WiFi Electromagnetic Field Modelling for Indoor Localization
- Modeling Human Pupil Dilation to Decouple the Pupillary Light Reflex
- Principal Component Analysis based on data characteristics for dimensionality reduction of ECG recordings in arrhythmia classification
- Blinking Extraction in Eye gaze System for Stereoscopy Movies
- Optimization of screen-space directional occlusion algorithms
- Heuristic based real-time hybrid rendering with the use of rasterization and ray tracing method
- Review of muscle modelling methods from the point of view of motion biomechanics with particular emphasis on the shoulder
- The use of segmented-shifted grain-oriented sheets in magnetic circuits of small AC motors
- High Temperature Permanent Magnet Synchronous Machine Analysis of Thermal Field
- Inverse approach for concentrated winding surface permanent magnet synchronous machines noiseless design
- An enameled wire with a semi-conductive layer: A solution for a better distibution of the voltage stresses in motor windings
- High temperature machines: topologies and preliminary design
- Aging monitoring of electrical machines using winding high frequency equivalent circuits
- Design of inorganic coils for high temperature electrical machines
- A New Concept for Deeper Integration of Converters and Drives in Electrical Machines: Simulation and Experimental Investigations
- Special Issue on Energetic Materials and Processes
- Investigations into the mechanisms of electrohydrodynamic instability in free surface electrospinning
- Effect of Pressure Distribution on the Energy Dissipation of Lap Joints under Equal Pre-tension Force
- Research on microstructure and forming mechanism of TiC/1Cr12Ni3Mo2V composite based on laser solid forming
- Crystallization of Nano-TiO2 Films based on Glass Fiber Fabric Substrate and Its Impact on Catalytic Performance
- Effect of Adding Rare Earth Elements Er and Gd on the Corrosion Residual Strength of Magnesium Alloy
- Closed-die Forging Technology and Numerical Simulation of Aluminum Alloy Connecting Rod
- Numerical Simulation and Experimental Research on Material Parameters Solution and Shape Control of Sandwich Panels with Aluminum Honeycomb
- Research and Analysis of the Effect of Heat Treatment on Damping Properties of Ductile Iron
- Effect of austenitising heat treatment on microstructure and properties of a nitrogen bearing martensitic stainless steel
- Special Issue on Fundamental Physics of Thermal Transports and Energy Conversions
- Numerical simulation of welding distortions in large structures with a simplified engineering approach
- Investigation on the effect of electrode tip on formation of metal droplets and temperature profile in a vibrating electrode electroslag remelting process
- Effect of North Wall Materials on the Thermal Environment in Chinese Solar Greenhouse (Part A: Experimental Researches)
- Three-dimensional optimal design of a cooled turbine considering the coolant-requirement change
- Theoretical analysis of particle size re-distribution due to Ostwald ripening in the fuel cell catalyst layer
- Effect of phase change materials on heat dissipation of a multiple heat source system
- Wetting properties and performance of modified composite collectors in a membrane-based wet electrostatic precipitator
- Implementation of the Semi Empirical Kinetic Soot Model Within Chemistry Tabulation Framework for Efficient Emissions Predictions in Diesel Engines
- Comparison and analyses of two thermal performance evaluation models for a public building
- A Novel Evaluation Method For Particle Deposition Measurement
- Effect of the two-phase hybrid mode of effervescent atomizer on the atomization characteristics
- Erratum
- Integrability analysis of the partial differential equation describing the classical bond-pricing model of mathematical finance
- Erratum to: Energy converting layers for thin-film flexible photovoltaic structures
Articles in the same Issue
- Regular Articles
- Non-equilibrium Phase Transitions in 2D Small-World Networks: Competing Dynamics
- Harmonic waves solution in dual-phase-lag magneto-thermoelasticity
- Multiplicative topological indices of honeycomb derived networks
- Zagreb Polynomials and redefined Zagreb indices of nanostar dendrimers
- Solar concentrators manufacture and automation
- Idea of multi cohesive areas - foundation, current status and perspective
- Derivation method of numerous dynamics in the Special Theory of Relativity
- An application of Nwogu’s Boussinesq model to analyze the head-on collision process between hydroelastic solitary waves
- Competing Risks Model with Partially Step-Stress Accelerate Life Tests in Analyses Lifetime Chen Data under Type-II Censoring Scheme
- Group velocity mismatch at ultrashort electromagnetic pulse propagation in nonlinear metamaterials
- Investigating the impact of dissolved natural gas on the flow characteristics of multicomponent fluid in pipelines
- Analysis of impact load on tubing and shock absorption during perforating
- Energy characteristics of a nonlinear layer at resonant frequencies of wave scattering and generation
- Ion charge separation with new generation of nuclear emulsion films
- On the influence of water on fragmentation of the amino acid L-threonine
- Formulation of heat conduction and thermal conductivity of metals
- Displacement Reliability Analysis of Submerged Multi-body Structure’s Floating Body for Connection Gaps
- Deposits of iron oxides in the human globus pallidus
- Integrability, exact solutions and nonlinear dynamics of a nonisospectral integral-differential system
- Bounds for partition dimension of M-wheels
- Visual Analysis of Cylindrically Polarized Light Beams’ Focal Characteristics by Path Integral
- Analysis of repulsive central universal force field on solar and galactic dynamics
- Solitary Wave Solution of Nonlinear PDEs Arising in Mathematical Physics
- Understanding quantum mechanics: a review and synthesis in precise language
- Plane Wave Reflection in a Compressible Half Space with Initial Stress
- Evaluation of the realism of a full-color reflection H2 analog hologram recorded on ultra-fine-grain silver-halide material
- Graph cutting and its application to biological data
- Time fractional modified KdV-type equations: Lie symmetries, exact solutions and conservation laws
- Exact solutions of equal-width equation and its conservation laws
- MHD and Slip Effect on Two-immiscible Third Grade Fluid on Thin Film Flow over a Vertical Moving Belt
- Vibration Analysis of a Three-Layered FGM Cylindrical Shell Including the Effect Of Ring Support
- Hybrid censoring samples in assessment the lifetime performance index of Chen distributed products
- Study on the law of coal resistivity variation in the process of gas adsorption/desorption
- Mapping of Lineament Structures from Aeromagnetic and Landsat Data Over Ankpa Area of Lower Benue Trough, Nigeria
- Beta Generalized Exponentiated Frechet Distribution with Applications
- INS/gravity gradient aided navigation based on gravitation field particle filter
- Electrodynamics in Euclidean Space Time Geometries
- Dynamics and Wear Analysis of Hydraulic Turbines in Solid-liquid Two-phase Flow
- On Numerical Solution Of The Time Fractional Advection-Diffusion Equation Involving Atangana-Baleanu-Caputo Derivative
- New Complex Solutions to the Nonlinear Electrical Transmission Line Model
- The effects of quantum spectrum of 4 + n-dimensional water around a DNA on pure water in four dimensional universe
- Quantum Phase Estimation Algorithm for Finding Polynomial Roots
- Vibration Equation of Fractional Order Describing Viscoelasticity and Viscous Inertia
- The Errors Recognition and Compensation for the Numerical Control Machine Tools Based on Laser Testing Technology
- Evaluation and Decision Making of Organization Quality Specific Immunity Based on MGDM-IPLAO Method
- Key Frame Extraction of Multi-Resolution Remote Sensing Images Under Quality Constraint
- Influences of Contact Force towards Dressing Contiguous Sense of Linen Clothing
- Modeling and optimization of urban rail transit scheduling with adaptive fruit fly optimization algorithm
- The pseudo-limit problem existing in electromagnetic radiation transmission and its mathematical physics principle analysis
- Chaos synchronization of fractional–order discrete–time systems with different dimensions using two scaling matrices
- Stress Characteristics and Overload Failure Analysis of Cemented Sand and Gravel Dam in Naheng Reservoir
- A Big Data Analysis Method Based on Modified Collaborative Filtering Recommendation Algorithms
- Semi-supervised Classification Based Mixed Sampling for Imbalanced Data
- The Influence of Trading Volume, Market Trend, and Monetary Policy on Characteristics of the Chinese Stock Exchange: An Econophysics Perspective
- Estimation of sand water content using GPR combined time-frequency analysis in the Ordos Basin, China
- Special Issue Applications of Nonlinear Dynamics
- Discrete approximate iterative method for fuzzy investment portfolio based on transaction cost threshold constraint
- Multi-objective performance optimization of ORC cycle based on improved ant colony algorithm
- Information retrieval algorithm of industrial cluster based on vector space
- Parametric model updating with frequency and MAC combined objective function of port crane structure based on operational modal analysis
- Evacuation simulation of different flow ratios in low-density state
- A pointer location algorithm for computer visionbased automatic reading recognition of pointer gauges
- A cloud computing separation model based on information flow
- Optimizing model and algorithm for railway freight loading problem
- Denoising data acquisition algorithm for array pixelated CdZnTe nuclear detector
- Radiation effects of nuclear physics rays on hepatoma cells
- Special issue: XXVth Symposium on Electromagnetic Phenomena in Nonlinear Circuits (EPNC2018)
- A study on numerical integration methods for rendering atmospheric scattering phenomenon
- Wave propagation time optimization for geodesic distances calculation using the Heat Method
- Analysis of electricity generation efficiency in photovoltaic building systems made of HIT-IBC cells for multi-family residential buildings
- A structural quality evaluation model for three-dimensional simulations
- WiFi Electromagnetic Field Modelling for Indoor Localization
- Modeling Human Pupil Dilation to Decouple the Pupillary Light Reflex
- Principal Component Analysis based on data characteristics for dimensionality reduction of ECG recordings in arrhythmia classification
- Blinking Extraction in Eye gaze System for Stereoscopy Movies
- Optimization of screen-space directional occlusion algorithms
- Heuristic based real-time hybrid rendering with the use of rasterization and ray tracing method
- Review of muscle modelling methods from the point of view of motion biomechanics with particular emphasis on the shoulder
- The use of segmented-shifted grain-oriented sheets in magnetic circuits of small AC motors
- High Temperature Permanent Magnet Synchronous Machine Analysis of Thermal Field
- Inverse approach for concentrated winding surface permanent magnet synchronous machines noiseless design
- An enameled wire with a semi-conductive layer: A solution for a better distibution of the voltage stresses in motor windings
- High temperature machines: topologies and preliminary design
- Aging monitoring of electrical machines using winding high frequency equivalent circuits
- Design of inorganic coils for high temperature electrical machines
- A New Concept for Deeper Integration of Converters and Drives in Electrical Machines: Simulation and Experimental Investigations
- Special Issue on Energetic Materials and Processes
- Investigations into the mechanisms of electrohydrodynamic instability in free surface electrospinning
- Effect of Pressure Distribution on the Energy Dissipation of Lap Joints under Equal Pre-tension Force
- Research on microstructure and forming mechanism of TiC/1Cr12Ni3Mo2V composite based on laser solid forming
- Crystallization of Nano-TiO2 Films based on Glass Fiber Fabric Substrate and Its Impact on Catalytic Performance
- Effect of Adding Rare Earth Elements Er and Gd on the Corrosion Residual Strength of Magnesium Alloy
- Closed-die Forging Technology and Numerical Simulation of Aluminum Alloy Connecting Rod
- Numerical Simulation and Experimental Research on Material Parameters Solution and Shape Control of Sandwich Panels with Aluminum Honeycomb
- Research and Analysis of the Effect of Heat Treatment on Damping Properties of Ductile Iron
- Effect of austenitising heat treatment on microstructure and properties of a nitrogen bearing martensitic stainless steel
- Special Issue on Fundamental Physics of Thermal Transports and Energy Conversions
- Numerical simulation of welding distortions in large structures with a simplified engineering approach
- Investigation on the effect of electrode tip on formation of metal droplets and temperature profile in a vibrating electrode electroslag remelting process
- Effect of North Wall Materials on the Thermal Environment in Chinese Solar Greenhouse (Part A: Experimental Researches)
- Three-dimensional optimal design of a cooled turbine considering the coolant-requirement change
- Theoretical analysis of particle size re-distribution due to Ostwald ripening in the fuel cell catalyst layer
- Effect of phase change materials on heat dissipation of a multiple heat source system
- Wetting properties and performance of modified composite collectors in a membrane-based wet electrostatic precipitator
- Implementation of the Semi Empirical Kinetic Soot Model Within Chemistry Tabulation Framework for Efficient Emissions Predictions in Diesel Engines
- Comparison and analyses of two thermal performance evaluation models for a public building
- A Novel Evaluation Method For Particle Deposition Measurement
- Effect of the two-phase hybrid mode of effervescent atomizer on the atomization characteristics
- Erratum
- Integrability analysis of the partial differential equation describing the classical bond-pricing model of mathematical finance
- Erratum to: Energy converting layers for thin-film flexible photovoltaic structures