The paper derives the current-voltage relationship in the semiconductor circuit breaker based on the equation of fluid mechanics which has application for safe and water access. Then, the paper proposes a Newton iterative method based on the finite element analysis method to solve the nonlinear algebraic equation relationship in the semiconductor circuit breaker. At the same time, the paper constructed a coupled numerical model based on the hydrodynamic equations and applied it to the pulse current prediction. Experiments have proved that the algorithm can realize large-scale open-circuit switching current forecast, and the algorithm has high efficiency and accuracy.
Keywords
- Semiconductor circuit breaker
- fluid mechanics
- numerical simulation
- finite volume method
- algebraic multigrid method
MSC 2010
- 34A34
The drift-diffusion model is a physical model that describes the movement of carriers in semiconductor materials and has essential application backgrounds in the fields of remote sensing and solar power generation. The model consists of a Poisson equation and two carrier continuity equations. It is a system of tightly coupled and strongly nonlinear partial differential equations. Among them, the carrier continuity equation is a singular perturbation equation. Furthermore, it is understood that there is a sharp boundary layer and the value range is extremely large. This has brought great difficulties to its numerical solution [1]. Only by selecting appropriate variables and carefully designed discrete formats can good numerical simulation results be obtained. In addition, because the equations are strongly nonlinear, we need to develop targeted and efficient algorithms for solving nonlinear equations. Most of the open-source and commercial software used for semiconductor device simulation are serial or only support small-scale parallelism. Limited by its computational scale, it can only be used for numerical simulation of two-dimensional devices. There are few scalable algorithms in the literature that are suitable for large-scale parallelism. This paper focuses on the numerical calculation method of the three-dimensional drift-diffusion model. The purpose is to provide a scalable parallel algorithm suitable for large-scale equality for the numerical simulation of three-dimensional semiconductor devices.
The limited volume method is the discrete method used by most open-source and commercial semiconductor device simulation software. It has local conservation. The discrete system satisfies the principle of discrete extremum, which can keep the carrier concentration always positive. The discrete current flux in the finite volume method usually adopts the Scharfetter-Gummel format. It is an adaptive exponential upwind style, which adds artificial viscosity to the original problem and reduces numerical fluctuations. This paper uses this method as the basic numerical discrete format [2]. We use the coupled Newton iteration method to solve the nonlinear equations and propose using the algebraic multigrid (AMG) preconditioning GMRES method to solve the linear equations in the Newton iteration. Numerical experiments show that as long as multiple variables at the same geometric position are arranged together when sorting unknowns and treated as a whole when the grid is coarsened, the algebraic grid preconditioner can solve the problem efficiently. The number of iteration steps generally does not increase with the increase of the grid size, which ensures the parallel scalability of the algorithm. In the numerical experiment, the maximum grid size reached 500 million units, and the maximum number of processes reached 1024. This shows that our proposed algorithm has good scalability.
The steady-state drift-diffusion model consists of the Poisson equation −∇[(
Here −
We introduce the quasi-Fermi levels
Then the currents
Common semiconductor device boundaries include ohmic contacts, metal-oxide limits, free borders, and so on.
In addition to the electrostatic potential
In the actual calculation, one of the three groups of variables after the corresponding non-dimensionalization is often used:
The variable group (
The variables Φ
The carrier continuity equation in the drift-diffusion model is the convection-diffusion equation of strong convection. It is understood that there is a sharp boundary layer. The general finite element or finite difference method is easy to cause numerical oscillations. Therefore, we need to adopt the upside-down style or exponential fitting format. In addition, the ideal discrete structure should make the discrete system satisfy the principle of discrete extremum. It requires that the extreme value of the numerical solution is reached on the boundary and the carrier concentration is always positive [6]. This paper uses a three-dimensional tetrahedral unstructured grid. The control volume of the finite volume method is the area centered on the vertex and surrounded by the vertical bisector of each side. As shown in Figure 1, Figure 2.
Fig. 1
Control body centered on the vertex.

Fig. 2
Division of the control body in the unit.

Suppose
Discrete it in a finite volume, and get the equation for each control body
Here,
The Scharfetter-Gummel format is a one-dimensional discrete format for calculating electron current and hole current density [7]. Define the Bernoulli function:
The formula for calculating the electron current and gap current on the side in the SG format is
The SG format is an adaptive exponential upwind style. When
Corresponds to the central difference format. When
In the above two cases, the current given by the SG format is equivalent to the first-order upwind formula.
The equation of the drift-diffusion model is
This is a system of nonlinear equations, which must be solved by an iterative method. Commonly used iterative methods include Gummel iteration for decoupled solution of equations and coupled Newton iteration.
The Gummel iteration method is a decoupled iteration method equivalent to the nonlinear block Gauss-Seidel iteration. It decouples the system of equations [9]. First fix
The Newton iteration is a coupled iterative method. The Jacobi matrix of the equation system needs to be calculated in each iteration [10]. The iterative process is as follows:
The advantage of Newton iteration is that it has a quadratic convergence rate, and the number of iteration steps is not sensitive to voltage. The disadvantage is that a larger-scale linear equation system needs to be solved. Some numerical methods are not easy to get an accurate Jacobi matrix. If an inexact Jacobi matrix is used, the convergence speed will be reduced to linear convergence [11]. Furthermore, Newton's iteration is sensitive to the selection of initial values. It is often calculated in sequence from low voltage to high voltage in a certain step size in device simulation. When solving, take the solution obtained from the last voltage as the initial value of the iteration. Therefore, the Newton iteration limits the step size of the voltage increase.
We use (
Most of the early methods used are sparse direct methods or block iterative approaches. The Jacobi matrix coupled with Newton iteration has a block structure. The block iteration method regards each matrix block as an element and performs Richardson, Jacobi, or Gauss-Seidel iteration on a large matrix. However, the article pointed out that various block iteration methods are not satisfactory for the semiconductor device after startup. The number of iterative convergence steps will increase as the voltage increases, and its behavior is similar to the decoupled Gummel iteration. After many experiments, we have found that the existing algebraic multigrid (AMG) solver is produced by solving the coupled Newton iteration Very effective preconditioner for linear equations. Using the GMRES method and combining algebraic multigrid preconditioners can achieve high computational efficiency and good parallel scalability [12]. We need to consecutively different number variables at the same geometric position. We deal with them as a whole in the mesh coarsening module of the Algebraic Multigrid Presolver. The following numerical experiments show that we use the GMRES method combined with the algebraic multigrid preconditioner to solve the linear equations generated by the coupled Newton iteration. The number of iteration steps does not generally increase with the increase of the grid size.
We implemented the algorithm introduced in this article based on the parallel adaptive meta-software platform PNG. PNG provides the management of parallel three-dimensional tetrahedral unstructured grids, supports large-scale parallelism, and has good scalability. Although it is designed to develop parallel adaptive finite element programs, it can also support the development of limited volume algorithm programs.
The Newton iterative algorithm in our program is directly implemented based on the PHG's degree of freedom and vector management function. The linear equations are solved by calling the GMRES solver in the parallel open-source solver PETSc to complete. The algebraic multigrid preconditioner uses Boomer AMG, another parallel open-source solver Hyper. We found in numerical experiments that such a combination has the best solution efficiency and robustness [13]. The coarsening method of Boomer AMG preconditioner is “Falgout,” which corresponds to the 3 × 3 sub-block structure of the linear equation system. We set the parameter of HYPRE_Boomer AMG Set Num Functions to 3.
The calculation examples used in the thesis are PN junction and MOSFET transistors. The cluster contains 282 computing nodes, including two Intel X55504 core CPUs and 24GB of memory. The interconnection network is Infiniband DDR.
The device structure and dimensions are shown in Figure 3. The doping concentration of the P area and N area is both 1 × 1017
Fig. 3
PN junction.

Fig. 4
IV curve of PN junction.

This is an example of heavy doping concentration. The device structure and dimensions are shown in Figure 5. The thickness of the oxide layer is 0.025 nm, the doping concentration of the source region and the drain region are both 1 × 1020
Fig. 5
Metal-oxide-semiconductor field-effect transistor.

Figure 6 shows the output characteristic curve of the MOSFET. Compared with the PN junction, the carrier movement in the MOSFET is more complicated. The device can work in different modes such as the cut-off region, the saturation region, and the linear region. It can be seen from the calculation results that our algorithm is highly consistent with the theoretical results under these modes.
Fig. 6
MOSFET output characteristic curve.

The primary calculation time for semiconductor device simulation lies in the solution of linear equations. In large-scale parallel computing, the resolution of linear equations is based on iterative methods. Generally speaking, as the grid size increases, the number of iteration steps of the linear equation system increases. Table 1 and Table 2 respectively show the number of Newton iteration steps (NT) required for PN junction and MOSFET simulation under different grid sizes and the number of MPI processes, as well as the average number of iteration steps (GMRES) and average solution time (Time). It can be seen from the table that the number of iterative steps for solving the linear equations in the algorithm of this paper does not increase with the increase of the grid size and the number of processes, and it is not sensitive to the rise in voltage. This illustrates the efficiency of algebraic multigrid preconditioners.
Numerical simulation of PN junction diffusion test.
Voltage/V | 8429568 unit 16 processes | 67436544 unit 128 processes | ||||
---|---|---|---|---|---|---|
NT | GMRES | Time/s | NT | GMRES | Time/s | |
0.2 | 6 | 25 | 27.7 | 6 | 29 | 53.8 |
0.4 | 6 | 27.3 | 29.3 | 6 | 27.2 | 52 |
0.6 | 6 | 30.3 | 31.3 | 6 | 32 | 57.2 |
0.8 | 6 | 20.7 | 24.7 | 6 | 24 | 48.5 |
1 | 4 | 20.8 | 20.3 | 4 | 24.8 | 45.8 |
1.2 | 3 | 26 | 23.2 | 3 | 32 | 50.4 |
1.4 | 3 | 35.3 | 28.7 | 3 | 39.3 | 55.2 |
1.6 | 3 | 45.7 | 34.3 | 3 | 49.7 | 61.5 |
1.8 | 3 | 53.7 | 38.7 | 3 | 62.3 | 72.7 |
2 | 3 | 61.7 | 43.3 | 3 | 74 | 82.4 |
MOSFET numerical simulation scalability test (VG=8V).
VD/V | 5050368 Unit 8 Process | 40402944 unit 64 processes | ||||
---|---|---|---|---|---|---|
NT | GMRES | Time/s | NT | GMRES | Time/s | |
2 | 6 | 35.5 | 44.8 | 6 | 49.7 | 87.7 |
4 | 5 | 32.2 | 41.6 | 5 | 47.4 | 84.8 |
6 | 5 | 30.4 | 39.7 | 5 | 40 | 75.2 |
8 | 5 | 32 | 41.4 | 5 | 41 | 76.2 |
10 | 5 | 32 | 41.2 | 4 | 45.2 | 81.5 |
12 | 4 | 37 | 45.8 | 4 | 45.5 | 81.8 |
14 | 4 | 38.2 | 46.8 | 4 | 43 | 78.9 |
16 | 4 | 37.2 | 45.9 | 4 | 44.8 | 80.8 |
18 | 4 | 39 | 47.5 | 4 | 46 | 82.3 |
20 | 4 | 38.8 | 47.4 | 4 | 45.8 | 81.8 |
The paper proposes a parallel algorithm for the numerical simulation of the three-dimensional drift-diffusion model. This method uses the finite volume method for numerical discretization. In addition, it uses the coupled Newton iteration and the GMRES iteration based on algebraic multigrid preconditions to solve the nonlinear equations generated by the discretization. Numerical experiments show that the proposed method is robust, effective, and highly scalable and can be applied to three-dimensional large-scale parallel numerical simulations of some semiconductor devices.
Fig. 1

Fig. 2

Fig. 3

Fig. 4

Fig. 5

Fig. 6

Numerical simulation of PN junction diffusion test.
Voltage/V | 8429568 unit 16 processes | 67436544 unit 128 processes | ||||
---|---|---|---|---|---|---|
NT | GMRES | Time/s | NT | GMRES | Time/s | |
0.2 | 6 | 25 | 27.7 | 6 | 29 | 53.8 |
0.4 | 6 | 27.3 | 29.3 | 6 | 27.2 | 52 |
0.6 | 6 | 30.3 | 31.3 | 6 | 32 | 57.2 |
0.8 | 6 | 20.7 | 24.7 | 6 | 24 | 48.5 |
1 | 4 | 20.8 | 20.3 | 4 | 24.8 | 45.8 |
1.2 | 3 | 26 | 23.2 | 3 | 32 | 50.4 |
1.4 | 3 | 35.3 | 28.7 | 3 | 39.3 | 55.2 |
1.6 | 3 | 45.7 | 34.3 | 3 | 49.7 | 61.5 |
1.8 | 3 | 53.7 | 38.7 | 3 | 62.3 | 72.7 |
2 | 3 | 61.7 | 43.3 | 3 | 74 | 82.4 |
MOSFET numerical simulation scalability test (VG=8V).
VD/V | 5050368 Unit 8 Process | 40402944 unit 64 processes | ||||
---|---|---|---|---|---|---|
NT | GMRES | Time/s | NT | GMRES | Time/s | |
2 | 6 | 35.5 | 44.8 | 6 | 49.7 | 87.7 |
4 | 5 | 32.2 | 41.6 | 5 | 47.4 | 84.8 |
6 | 5 | 30.4 | 39.7 | 5 | 40 | 75.2 |
8 | 5 | 32 | 41.4 | 5 | 41 | 76.2 |
10 | 5 | 32 | 41.2 | 4 | 45.2 | 81.5 |
12 | 4 | 37 | 45.8 | 4 | 45.5 | 81.8 |
14 | 4 | 38.2 | 46.8 | 4 | 43 | 78.9 |
16 | 4 | 37.2 | 45.9 | 4 | 44.8 | 80.8 |
18 | 4 | 39 | 47.5 | 4 | 46 | 82.3 |
20 | 4 | 38.8 | 47.4 | 4 | 45.8 | 81.8 |
Law of interest rate changes in financial markets based on the differential equation model of liquidity Basalt fibre continuous reinforcement composite pavement reinforcement design based on finite element model Industrial transfer and regional economy coordination based on multiple regression model Response model for the psychological education of college students based on non-linear finite element equations Satisfactory consistency judgement and inconsistency adjustment of linguistic judgement matrix Spatial–temporal graph neural network based on node attention Financial accounting measurement model based on numerical analysis of rigid normal differential equation and rigid generalised functional equation Research of cascade averaging control in hydraulic equilibrium regulation of heating pipe network Mathematical analysis of civil litigation and empirical research of corporate governance Health monitoring of Bridges based on multifractal theory College students’ innovation and entrepreneurship ability based on nonlinear model Health status diagnosis of the bridges based on multi-fractal de-trend fluctuation analysis Mathematical simulation analysis of optimal testing of shot puter's throwing path Performance evaluation of college laboratories based on fusion of decision tree and BP neural network Application and risk assessment of the energy performance contracting model in energy conservation of public buildings The term structure of economic management rate under the parameter analysis of the estimation model based on common differential equation Sensitivity analysis of design parameters of envelope enclosure performance in the dry-hot and dry-cold areas The Spatial Form of Digital Nonlinear Landscape Architecture Design Based on Computer Big Data Analysis of the relationship between industrial agglomeration and regional economic growth based on the multi-objective optimisation model The improvement of museum information flow based on paste functional mapping method Constraint effect of enterprise productivity based on constrained form variational computing The art design of industrialised manufacturing furniture products based on the simulation of mathematical curves The impact of urban expansion in Beijing and Metropolitan Area urban heat Island from 1999 to 2019 TOPSIS missile target selection method supported by the posterior probability of target recognition Research on Evaluation of Intercultural Competence of Civil Aviation College Students Based on Language Operator Ultrasonic wave promoting ice melt in ice storage tank based on polynomial fitting calculation model The incentive contract of subject librarians in university library under the non-linear task importance Modelling and Simulation of Collaborative Innovation System in Colleges and Universities Based on Interpreted Structural Equation Model Small amplitude periodic solution of Hopf Bifurcation Theorem for fractional differential equations of balance point in group competitive martial arts The Optimal Solution of Feature Decomposition Based on the Mathematical Model of Nonlinear Landscape Garden Features Composite mechanical performance of prefabricated concrete based on hysteresis curve equation Higher education innovation and reform model based on hierarchical probit Application of Fuzzy Mathematics Calculation in Quantitative Evaluation of Students’ Performance of Basketball Jump Shot The teaching of sports science of track and field-based on nonlinear mathematical equations Visual error correction of continuous aerobics action images based on graph difference function Ecological balance model of effective utilization of agricultural water resources based on fractional differential equations Application of Higher Order Ordinary Differential Equation Model in Financial Investment Stock Price Forecast Precision algorithms in second-order fractional differential equations Application of Forced Modulation Function Mathematical Model in the Characteristic Research of Reflective Intensity Fibre Sensors Fractional differential equations in National Sports Training in Colleges and Universities Radioactive source search problem and optimisation model based on meta-heuristic algorithm Visualized calculation of regional power grid power data based on multiple linear regression equation Application of mathematical probabilistic statistical model of base – FFCA financial data processing Least-squares method and deep learning in the identification and analysis of name-plates of power equipment Research on a method of completeness index based on complex model Distribution network monitoring and management system based on intelligent recognition and judgement Research on the sustainable development and renewal of Macao inner harbour under the background of digitisation Support design of main retracement passage in fully mechanised coal mining face based on numerical simulation Study on the crushing mechanism and parameters of the two-flow crusher Topological optimisation technology of gravity dam section structure based on ANSYS partial differential equation operation Modeling the pathway of breast cancer in the Middle East Corporate social responsibility fulfilment, product-market competition and debt risk: Evidence from China ARMA analysis of the green innovation technology of core enterprises under the ecosystem – Time series data Reconstruction of multimodal aesthetic critical discourse analysis framework Image design and interaction technology based on Fourier inverse transform What does students’ experience of e-portfolios suggest Research on China interregional industrial transformation slowdown and influencing factors of industrial transformation based on numerical simulation The optimal model of employment and entrepreneurship models in colleges and universities based on probability theory and statistics A generative design method of building layout generated by path Analysis of the causes of the influence of the industrial economy on the social economy based on multiple linear regression equation Research of neural network for weld penetration control Regarding new wave distributions of the non-linear integro-partial Ito differential and fifth-order integrable equations Analysing the action techniques of basketball players’ shooting training using calculus method Engineering project management based on multiple regression equation and building information modelling technology Research on predictive control of students’ performance in PE classes based on the mathematical model of multiple linear regression equation Beam control method for multi-array antennas based on improved genetic algorithm The influence of X fuzzy mathematical method on basketball tactics scoring Mathematical model of back propagation for stock price forecasting Application of regression function model based on panel data in bank resource allocation financial risk management Application of Logical Regression Function Model in Credit Business of Commercial Banks Research on aerobics training posture motion capture based on mathematical similarity matching statistical analysis Application of Sobolev-Volterra projection and finite element numerical analysis of integral differential equations in modern art design Research on motion capture of dance training pose based on statistical analysis of mathematical similarity matching Application of B-theory for numerical method of functional differential equations in the analysis of fair value in financial accounting Badminton players’ trajectory under numerical calculation method Research on the influence of fuzzy mathematics simulation model in the development of Wushu market Study on audio-visual family restoration of children with mental disorders based on the mathematical model of fuzzy comprehensive evaluation of differential equation Application of multi-attribute decision-making methods based on normal random variables in supply chain risk management The impact of financial repression on manufacturing upgrade based on fractional Fourier transform and probability AtanK-A New SVM Kernel for Classification Visual positioning system for marine industrial robot assembly based on complex variable function Application of Lane-Emden differential equation numerical method in fair value analysis of financial accounting Regression function model in risk management of bank resource allocation Application of numerical method of functional differential equations in fair value of financial accounting Optimal solution of fractional differential equations in solving the relief of college students’ mental obstacles Risk contagion in financial markets based on copula model Calculating university education model based on finite element fractional differential equations and macro-control analysis Automatic parameter selection ZVD shaping algorithm for crane vibration suppression based on particle swarm optimisation Educational research on mathematics differential equation to simulate the model of children's mental health prevention and control system Analysis of enterprise management technology and innovation based on multilinear regression model Verifying the validity of the whole person model of mental health education activities in colleges based on differential equation RETRACTION NOTE Innovations to Attribute Reduction of Covering Decision System Based on Conditional Information Entropy Calculation of tourism development income index based on finite element ordinary differential mathematical equation Adoption of deep learning Markov model combined with copula function in portfolio risk measurement Radar system simulation and non-Gaussian mathematical model under virtual reality technology Comparison of compression estimations under the penalty functions of different violent crimes on campus through deep learning and linear spatial autoregressive models Research and application of constructing football training linear programming based on multiple linear regression equation Research on management evaluation of enterprise sales cash flow percentage method based on the application of quadratic linear regression equations Mathematical simulation analysis of optimal detection of shot-putters’ best path Determination of the minimum distance between vibration source and fibre under existing optical vibration signals: a study Mathematical modelling of enterprise financial risk assessment based on risk conduction model Nonlinear differential equations based on the B-S-M model in the pricing of derivatives in financial markets Nonlinear Differential Equations in the Teaching Model of Educational Informatisation Mathematical simulation experiment based on optimisation of heat treatment process of aluminium alloy materials The evaluation of college students’ innovation and entrepreneurship ability based on nonlinear model Mathematical model of transforming image elements to structured data based on BP neural network Smart Communities to Reduce Earthquake Damage: A Case Study in Xinheyuan, China Institutional investor company social responsibility report and company performance Mathematical analysis of China's birth rate and research on the urgency of deepening the reform of art education First-principles calculations of magnetic and mechanical properties of Fe-based nanocrystalline alloy Fe80Si10Nb6B2Cu2 Educational reform informatisation based on fractional differential equation Has the belt and road initiative boosted the resident consumption in cities along the domestic route? – evidence from credit card consumption 3D Mathematical Modelling Technology in Visual Rehearsal System of Sports Dance MCM of Student’s Physical Health Based on Mathematical Cone Attitude control for the rigid spacecraft with the improved extended state observer Sports health quantification method and system implementation based on multiple thermal physiology simulation Research on visual optimization design of machine–machine interface for mechanical industrial equipment based on nonlinear partial equations Informationisation of teaching model for track and field education based on finite element higher-order fractional differential equation Information technology of preschool education reform of fine arts based on fractional differential equation Information Teaching Model of Preschool Art Education in Colleges and Universities Based on Finite Element Higher-Order Fractional Differential Equation Application of artificial intelligence algorithm in mathematical modelling and solving College Students’ Mental Health Climbing Consumption Model Based on Nonlinear Differential Equations Cognitive Computational Model Using Machine Learning Algorithm in Artificial Intelligence Environment Research on tourism income index based on ordinary differential mathematical equation Application of Higher-Order Ordinary Differential Equation Model in Financial Investment Stock Price Forecast Sports Science Teaching of Athletics Based on Nonlinear Mathematical Equation Informatisation of educational reform based on fractional differential equations Research on the control of quantitative economic management variables under the numerical method based on stochastic ordinary differential equations Network monitoring and processing accuracy of big data acquisition based on mathematical model of fractional differential equation System dynamics model of output of ball mill Communication architecture of power monitoring system based on incidence matrix model Differential equation to verify the validity of the model of the whole-person mental health education activity in Universities Optimisation of Modelling of Finite Element Differential Equations with Modern Art Design Theory Analysis and Prediction of College Students’ Mental Health Based on K-means Clustering Algorithm Mathematical function data model analysis and synthesis system based on short-term human movement Sensitivity Analysis of the Waterproof Performance of Elastic Rubber Gasket in Shield Tunnel Human gait modelling and tracking based on motion functionalisation Analysis and synthesis of function data of human movement Energy-saving technology of BIM green buildings using fractional differential equation Study on the training model of football movement trajectory drop point based on fractional differential equation Financial Accounting Measurement Model Based on Numerical Analysis of Rigid Normal Differential Equation and Rigid Functional Equation User online consumption behaviour based on fractional differential equation Design of Morlet wavelet neural network to solve the non-linear influenza disease system Differential equation model of financial market stability based on Internet big data Multi-attribute Decision Method Based on Normal Random Variable in Economic Management Risk Control Children’s cognitive function and mental health based on finite element nonlinear mathematical model Motion about equilibrium points in the Jupiter-Europa system with oblateness Badminton players’ trajectory under numerical calculation method Optimal preview repetitive control for impulse-free continuous-time descriptor systems Development of main functional modules for MVB and its application in rail transit Value Creation of Real Estate Company Spin-off Property Service Company Listing Selection by differential mortality rates Digital model creation and image meticulous processing based on variational partial differential equation Dichotomy model based on the finite element differential equation in the educational informatisation teaching reform model Nonlinear Dissipative System Mathematical Equations in the Multi-regression Model of Information-based Teaching The modelling and implementation of the virtual 3D animation scene based on the geometric centre-of-mass algorithm The policy efficiency evaluation of the Beijing–Tianjin–Hebei regional government guidance fund based on the entropy method Stock price analysis based on the research of multiple linear regression macroeconomic variables Fractional Linear Regression Equation in Agricultural Disaster Assessment Model Based on Geographic Information System Analysis Technology The transfer of stylised artistic images in eye movement experiments based on fuzzy differential equations A review of the treatment techniques of VOC Some classes of complete permutation polynomials in the form of ( x p m −x +δ )s +ax p m +bx overF p 2m Deformation and stress theory of surrounding rock of shallow circular tunnel based on complex variable function method A mathematical model of the fractional differential method for structural design dynamics simulation of lower limb force movement step structure based on Sanda movement Numerical calculation and study of differential equations of muscle movement velocity based on martial articulation body ligament tension Study on the maximum value of flight distance based on the fractional differential equation for calculating the best path of shot put Sports intensity and energy consumption based on fractional linear regression equation Translog function in government development of low-carbon economy Analysis of the properties of matrix rank and the relationship between matrix rank and matrix operations Research on the Psychological Distribution Delay of Artificial Neural Network Based on the Analysis of Differential Equation by Inequality Expansion and Contraction Method Study on Establishment and Improvement Strategy of Aviation Equipment Research on Financial Risk Early Warning of Listed Companies Based on Stochastic Effect Mode The Model of Sugar Metabolism and Exercise Energy Expenditure Based on Fractional Linear Regression Equation Constructing Artistic Surface Modeling Design Based on Nonlinear Over-limit Interpolation Equation Numerical Simulation Analysis Mathematics of Fluid Mechanics for Semiconductor Circuit Breaker Characteristics of Mathematical Statistics Model of Student Emotion in College Physical Education Human Body Movement Coupling Model in Physical Education Class in the Educational Mathematical Equation of Reasonable Exercise Course The contribution of structural equation model analysis to higher education agglomeration and innovation and entrepreneurship Study on the evolutionary game theory of the psychological choice for online purchase of fresh produce under replicator dynamics formula The influence of X fuzzy mathematics method in basketball tactics scoring Mathematical statistics algorithm in the bending performance test of corroded reinforced concrete beams under fatigue load Nonlinear strategic human resource management based on organisational mathematical model Back propagation mathematical model for stock price prediction Evolutionary game research on the psychological choice of online shopping of fresh agricultural products based on dynamic simulation model Differential equation model of financial market stability based on big data Multi-attribute decision-making methods based on normal random variables in supply chain risk management Linear fractional differential equations in bank resource allocation and financial risk management model Construction and reform of art design teaching mode under the background of the integration of non-linear equations and the internet