Many scientific and engineering problems need to use numerical methods and algorithms to obtain computational simulation results because analytical solutions are seldom available for them.The chemical dissolution-fron...Many scientific and engineering problems need to use numerical methods and algorithms to obtain computational simulation results because analytical solutions are seldom available for them.The chemical dissolution-front instability problem in fluid-saturated porous rocks is no exception.Since this kind of instability problem has both the conventional(i.e.trivial)and the unconventional(i.e.nontrivial)solutions,it is necessary to examine the effects of different numerical algorithms,which are used to solve chemical dissolution-front instability problems in fluid-saturated porous rocks.Toward this goal,two different numerical algorithms associated with the commonly-used finite element method are considered in this paper.In the first numerical algorithm,the porosity,pore-fluid pressure and acid/solute concentration are selected as basic variables,while in the second numerical algorithm,the porosity,velocity of pore-fluid flow and acid/solute concentration are selected as basic variables.The particular attention is paid to the effects of these two numerical algorithms on the computational simulation results of unstable chemical dissolution-front propagation in fluid-saturated porous rocks.The related computational simulation results have demonstrated that:1)the first numerical algorithm associated with the porosity-pressure-concentration approach can realistically simulate the evolution processes of unstable chemical dissolution-front propagation in chemical dissolution systems.2)The second numerical algorithm associated with the porosity-velocity-concentration approach fails to simulate the evolution processes of unstable chemical dissolution-front propagation.3)The extra differential operation is the main source to result in the failure of the second numerical algorithm.展开更多
A closed-form numerical algorithm (CFNA) is analyzed in detail. CFNA iswidely used in mechanical dynamics for periodic solution of second-order original differentialequations (SODE) with periodic time-variant coeffici...A closed-form numerical algorithm (CFNA) is analyzed in detail. CFNA iswidely used in mechanical dynamics for periodic solution of second-order original differentialequations (SODE) with periodic time-variant coefficients. The principle of the algorithm is todiscretize the motion period into many short time intervals, so the coefficient matrices of theequation set are regarded as constant in a time interval. Defects are found in the originalalgorithm in treating the modal coordinates at the two end-nodes and important modifications to thedefects is made for the algorithm. The modified algorithm is finally used to solve the dynamicproblem of a three-ring planetary gear transmission.展开更多
If we use Littlewood-Paley decomposition, there is no pseudo-orthogonality for Ho¨rmander symbol operators OpS m 0 , 0 , which is different to the case S m ρ,δ (0 ≤δ 〈 ρ≤ 1). In this paper, we use a spec...If we use Littlewood-Paley decomposition, there is no pseudo-orthogonality for Ho¨rmander symbol operators OpS m 0 , 0 , which is different to the case S m ρ,δ (0 ≤δ 〈 ρ≤ 1). In this paper, we use a special numerical algorithm based on wavelets to study the L p continuity of non infinite smooth operators OpS m 0 , 0 ; in fact, we apply first special wavelets to symbol to get special basic operators, then we regroup all the special basic operators at given scale and prove that such scale operator’s continuity decreases very fast, we sum such scale operators and a symbol operator can be approached by very good compact operators. By correlation of basic operators, we get very exact pseudo-orthogonality and also L 2 → L 2 continuity for scale operators. By considering the influence region of scale operator, we get H 1 (= F 0 , 2 1 ) → L 1 continuity and L ∞→ BMO continuity. By interpolation theorem, we get also L p (= F 0 , 2 p ) → L p continuity for 1 〈 p 〈 ∞ . Our results are sharp for F 0 , 2 p → L p continuity when 1 ≤ p ≤ 2, that is to say, we find out the exact order of derivations for which the symbols can ensure the resulting operators to be bounded on these spaces.展开更多
As one of the important components of computational flight mechanics and control,numerical algorithms of trajectory optimization for flight vehicles are currently studied by many researchers in aerospace engineering t...As one of the important components of computational flight mechanics and control,numerical algorithms of trajectory optimization for flight vehicles are currently studied by many researchers in aerospace engineering to completely solve these difficult problems,but few papers on the survey of this research field have been published recently.Based on the investigation of more than one hundred literatures,considering the application perspectives of computational flight mechanics and recent developments of trajectory optimization,the numerical algorithms of trajectory optimizations for aerospace vehicles are summarized and systematically analyzed.This paper summarized the basic principle,characteristics and application for all kinds of current trajectory optimization algorithms;and introduced some new methods and theories appearing in recent years.Finally,collaborative trajectory optimization for many flight vehicles,and hypersonic vehicle trajectory optimization were mainly reviewed in this paper.In the conclusion of this paper,the future research properties are presented regarding to numerical algorithms of trajectory optimization and control for flight vehicles as follows:collaboration and antagonization for many flight vehicles and multiple targets,global,real-time online,high accuracy of 7-D trajectory,considering all kinds of unknown random disturbances in trajectory optimization,and so on.展开更多
The development of algebraic and numerical algorithms is a kind of complicated creative work and it is difficult to guarantee the correctness of the algorithms. This paper introduces a systematic and unified formal de...The development of algebraic and numerical algorithms is a kind of complicated creative work and it is difficult to guarantee the correctness of the algorithms. This paper introduces a systematic and unified formal development method of algebraic and numerical algorithms. The method implements the complete refinement process from abstract specifications to a concrete executable program. It uses the core idea of partition and recursion for formal derivation and combines the mathematical induction based on strict mathematical logic with Hoare axiom for correctness verification. This development method converts creative work into non-creative work as much as possible while ensuring the correctness of the algorithm, which can not only verify the correctness of the existing algebraic and numerical algorithms but also guide the development of efficient unknown algorithms for such problems. This paper takes the non-recursive implementation of the Extended Euclidean Algorithm and Horner's method as examples. Therefore, the effectiveness and feasibility of this method are further verified.展开更多
The information of seismic response spectra is key to many problems concerned with aseismic structure and is also helpful for earthquake disaster relief if it is generated in time when earthquake happens. While curren...The information of seismic response spectra is key to many problems concerned with aseismic structure and is also helpful for earthquake disaster relief if it is generated in time when earthquake happens. While current numerical calculation methods suffer from poor precision, especially in frequency band near Nyquist frequency, we present a set of improved parameters for precision improvement. It is shown that precision of displacement and velocity response spectra are both further improved compared to current numerical algorithms. A uniform fitting formula is given for computing these parameters for damping ratio range of 0.01-0.9, quite convenient for practical application.展开更多
In order to achieve attitude control of the six degrees of freedom steward dynamic platform, as well as the real time simulation cockpit attitude, Washout Filtering method was adopted in this paper as the simulation a...In order to achieve attitude control of the six degrees of freedom steward dynamic platform, as well as the real time simulation cockpit attitude, Washout Filtering method was adopted in this paper as the simulation algorithm to derive Washout Fiher high-pass, low-pass filter transfer functions into a differential equation algorithm and longitudinal acceleration tilt strategy, pitching strategies etc. Experimental examples are used to verify correctness of the algorithm.展开更多
A numerical algorithm of principal component analysis (PCA) is proposed and its application in remote sensing image processing is introduced: (1) Multispectral image compression;(2) Multi-spectral image noise cancella...A numerical algorithm of principal component analysis (PCA) is proposed and its application in remote sensing image processing is introduced: (1) Multispectral image compression;(2) Multi-spectral image noise cancellation;(3) Information fusion of multi-spectral images and spot panchromatic images. The software experiments verify and evaluate the effectiveness and accuracy of the proposed algorithm.展开更多
The backtracking search optimization algorithm(BSA) is one of the most recently proposed population-based evolutionary algorithms for global optimization. Due to its memory ability and simple structure, BSA has powe...The backtracking search optimization algorithm(BSA) is one of the most recently proposed population-based evolutionary algorithms for global optimization. Due to its memory ability and simple structure, BSA has powerful capability to find global optimal solutions. However, the algorithm is still insufficient in balancing the exploration and the exploitation. Therefore, an improved adaptive backtracking search optimization algorithm combined with modified Hooke-Jeeves pattern search is proposed for numerical global optimization. It has two main parts: the BSA is used for the exploration phase and the modified pattern search method completes the exploitation phase. In particular, a simple but effective strategy of adapting one of BSA's important control parameters is introduced. The proposed algorithm is compared with standard BSA, three state-of-the-art evolutionary algorithms and three superior algorithms in IEEE Congress on Evolutionary Computation 2014(IEEE CEC2014) over six widely-used benchmarks and 22 real-parameter single objective numerical optimization benchmarks in IEEE CEC2014. The results of experiment and statistical analysis demonstrate the effectiveness and efficiency of the proposed algorithm.展开更多
A new algorithm of structure random response numerical characteristics, namedas matrix algebra algorithm of structure analysis is presented. Using the algorithm, structurerandom response numerical characteristics can ...A new algorithm of structure random response numerical characteristics, namedas matrix algebra algorithm of structure analysis is presented. Using the algorithm, structurerandom response numerical characteristics can easily be got by directly solving linear matrixequations rather than structure motion differential equations. Moreover, in order to solve thecorresponding linear matrix equations, the numerical integration fast algorithm is presented. Thenaccording to the results, dynamic design and life-span estimation can be done. Besides, the newalgorithm can solve non-proportion damp structure response.展开更多
A mathematical model of resin flow and temperature variation in the filling stage of the resin transfer molding (RTM) is developed based on the control volume/finite element method (CV/FEM). The effects of the heat tr...A mathematical model of resin flow and temperature variation in the filling stage of the resin transfer molding (RTM) is developed based on the control volume/finite element method (CV/FEM). The effects of the heat transfer and chemical reaction of the resin on the flow and temperature are considered. The numerical algorithm of the resin flow and temperature variation in the process of RTM are studied. Its accuracy and convergence are analyzed. The comparison of temperature variations between experimental results and model predictions is carried out for two RTM cases. Result shows that the model is efficient for evaluating the flow and temperature variation in the filling stage of RTM and there is a good coincidence between theory and experiment.展开更多
In almost all frozen soil models used currently, three variables of temperature, ice content and moisture content are used as prognostic variables and the rate term, accounting for the contribution of the phase change...In almost all frozen soil models used currently, three variables of temperature, ice content and moisture content are used as prognostic variables and the rate term, accounting for the contribution of the phase change between water and ice, is shown explicitly in both the energy and mass balance equations. The models must be solved by a numerical method with an iterative process, and the rate term of the phase change needs to be pre-estimated at the beginning in each iteration step. Since the rate term of the phase change in the energy equation is closely related to the release or absorption of the great amount of fusion heat, a small error in the rate term estimation will introduce greater error in the energy balance, which will amplify the error in the temperature calculation and in turn, cause problems for the numerical solution convergence. In this work, in order to first reduce the trouble, the methodology of the variable transformation is applied to a simplified frozen soil model used currently, which leads to new frozen soil scheme used in this work. In the new scheme, the enthalpy and the total water equivalent are used as predictive variables in the governing equations to replace temperature, volumetric soil moisture and ice content used in many current models. By doing so, the rate terms of the phase change are not shown explicitly in both the mass and energy equations and its pre-estimation is avoided. Secondly, in order to solve this new scheme more functionally, the development of the numerical scheme to the new scheme is described and a numerical algorithm appropriate to the numerical scheme is developed. In order to evaluate the new scheme of the frozen soil model and its relevant algorithm, a series of model evaluations are conducted by comparing numerical results from the new model scheme with three observational data sets. The comparisons show that the results from the model are in good agreement with these data sets in both the change trend of variables and their magnitude values, and the new scheme, together with the algorithm, is more efficient and saves more computer time.展开更多
A newly-developed numerical algorithm, which is called the new Generalized-α (G-α) method, is presented for solving structural dynamics problems with nonlinear stiffness. The traditional G-α method has undesired ...A newly-developed numerical algorithm, which is called the new Generalized-α (G-α) method, is presented for solving structural dynamics problems with nonlinear stiffness. The traditional G-α method has undesired overshoot properties as for a class of α-method. In the present work, seven independent parameters are introduced into the single-step three-stage algorithmic formulations and the nonlinear internal force at every time interval is approximated by means of the generalized trapezoidal rule, and then the algorithm is implemented based on the finite difference theory. An analysis on the stability, accuracy, energy and overshoot properties of the proposed scheme is performed in the nonlinear regime. The values or the ranges of values of the seven independent parameters are determined in the analysis process. The computational results obtained by the new algorithm show that the displacement accuracy is of order two, and the acceleration can also be improved to a second order accuracy by a suitable choice of parameters. Obviously, the present algorithm is zero- stable, and the energy conservation or energy decay can be realized in the high-frequency range, which can be regarded as stable in an energy sense. The algorithmic overshoot can be completely avoided by using the new algorithm without any constraints with respect to the damping force and initial conditions.展开更多
We introduced a new class of fuzzy set-valued variational inclusions with (H,η)-monotone mappings. Using the resolvent operator method in Hilbert spaces, we suggested a new proximal point algorithm for finding approx...We introduced a new class of fuzzy set-valued variational inclusions with (H,η)-monotone mappings. Using the resolvent operator method in Hilbert spaces, we suggested a new proximal point algorithm for finding approximate solutions, which strongly converge to the exact solution of a fuzzy set-valued variational inclusion with (H,η)-monotone. The results improved and generalized the general quasi-variational inclusions with fuzzy set-valued mappings proposed by Jin and Tian Jin MM, Perturbed proximal point algorithm for general quasi-variational inclusions with fuzzy set-valued mappings, OR Transactions, 2005, 9(3): 31-38, (In Chinese); Tian YX, Generalized nonlinear implicit quasi-variational inclusions with fuzzy mappings, Computers & Mathematics with Applications, 2001, 42: 101-108.展开更多
In this paper,the quasi-static large deformation,wrinkling and fracture behaviors of bimodular structures and membranes are studied with an implicit bond-based peridynamic computational framework.Firstly,the constant ...In this paper,the quasi-static large deformation,wrinkling and fracture behaviors of bimodular structures and membranes are studied with an implicit bond-based peridynamic computational framework.Firstly,the constant and tangential stiffness matrices of the implicit peridynamic formulations for the nonlinear problems are derived,respectively.The former is con structed from the linearization of the bond strain on the basis of the geometric approximation while the latter is established according to the linearization of the pairwise force by using first-order Taylor’s expansion.Then,a bimodular material model in peridynamics is developed,in which the tensile or compressive behavior of the material at each point is conveniently described by the tensile or compressive states of the bonds in its neighborhood.Moreover,the bimodular material model is extended to deal with the wrinkling and fracture problems of membranes by setting the compressive micro-modulus to be zero.In addition,the incremental-iterative algorithm is adopted to obtain the convergent solutions of the nonlinear problems.Finally,several representative numerical examples are presented and the results demonstrate the accuracy and efficiency of the proposed method for the large deformation,wrinkling and fracture analyses of bimodular structures and membranes.展开更多
A unified constitutive model is presented to predict the recently observed“multi-stage”creep behavior of Al−Li−S4 alloy.The corresponding microstructural variables related to the yield strength and creep deformation...A unified constitutive model is presented to predict the recently observed“multi-stage”creep behavior of Al−Li−S4 alloy.The corresponding microstructural variables related to the yield strength and creep deformation of the alloy during the creep ageing process,including dislocations and multiple precipitates,have been characterized in detail by X-ray diffraction(XRD)and transmission electron microscopy(TEM).For the yield strength,the model considers the multiphase strengthening behavior of the alloy based on strengthening mechanisms,which includes shearable T1 precipitate strengthening,non-shearable T1 precipitate strengthening andθ′precipitate strengthening.Based on creep deformation mechanism,the“multi-stage”creep behavior of the alloy is predicted by introducing the effects of interacting microstructural variables,including the radius of multiple precipitates,dislocation density and solute concentration,into the creep stress−strain model.It is concluded that the results calculated by the model are in a good agreement with the experimental data,which validates the proposed model.展开更多
A feedforward approach for generating near time optimal controller for flexible spacecraft rest-to-rest maneuvers is presented with the objective insensitivity to modeling errors, parameter uncertainty and minimizing ...A feedforward approach for generating near time optimal controller for flexible spacecraft rest-to-rest maneuvers is presented with the objective insensitivity to modeling errors, parameter uncertainty and minimizing the residual energy of the flexible modes. The perturbation estimation of flexible appendages to the rigid-hub is accomplished simply via compare the output of real plant with the reference model, and the approach is based on combine this estimation with the bang-bang control for the rigid-hub modes through analysis the basic constraint and the additional constraint, i.e. zero coupling torque and zero coupling torque derivative for general two orders system and three orders system with considerate attitude acceleration mode near time optimal controls. These time optimal controls with control constraints and state constraints leads to forming a boundary-value problem, and resolved the problem using an iterative numerical algorithm. The near time optimal control with perturbation estimation shows a good robust to parameter uncertainty and can suppress the vibration and minimizing the residual energy. The capability of this approach is demonstrated through a numerical example in detail.展开更多
The investigation of local thermal transport rate in the nanolubricants is significant.These lubricants are broadly used in environmental pollution,mechanical engineering and in the paint industry due to high thermal ...The investigation of local thermal transport rate in the nanolubricants is significant.These lubricants are broadly used in environmental pollution,mechanical engineering and in the paint industry due to high thermal performance rate.Therefore,thermal transport in ZnO-SAE50 nanolubricant under the impacts of heat generation/absorption is conducted.The colloidal suspension is flowing between parallel stretching disks in which the lower disk is positioned at z=0 and upper disk apart from distance d.The problem is transformed in dimensionless version via described similarity transforms.In the next stage,an analytical technique(VPM)is implemented for the solution purpose.The graphical results against multiple flow parameters were furnished over the region of interest and explained comprehensively.It is imperative to mention that the results are plotted for ZnO-SAE50 and conventional liquid as well.Further,rapid motion of the fluid is perceived against high Reynolds andγparameters.The wall shear stresses at the upper end rises for multiple Reynolds andγwhile;decrement is detected at the lower end.The significant contribution of an internal heat source is noted for thermal performance rate at the upper end.Foremost,the local heat transport rate declines at the lower disk.By altering Reynolds number,prompt heat transfer rate is gained at the upper disk and increasing behavior of the local heat transport rate is slow at the lower disk.From the study,it is concluded that the nanolubricants have high thermal characteristics.Therefore,such fluids are reliable to use in above stated areas.展开更多
In this article,a new algorithm is presented to solve the nonlinear impulsive differential equations.In the first time,this article combines the reproducing kernel method with the least squares method to solve the sec...In this article,a new algorithm is presented to solve the nonlinear impulsive differential equations.In the first time,this article combines the reproducing kernel method with the least squares method to solve the second-order nonlinear impulsive differential equations.Then,the uniform convergence of the numerical solution is proved,and the time consuming Schmidt orthogonalization process is avoided.The algorithm is employed successfully on some numerical examples.展开更多
This paper focuses on the dynamic thermo-mechanical coupled response of random particulate composite materials. Both the inertia term and coupling term are considered in the dynamic coupled problem. The formulation of...This paper focuses on the dynamic thermo-mechanical coupled response of random particulate composite materials. Both the inertia term and coupling term are considered in the dynamic coupled problem. The formulation of the problem by a statistical second-order two-scale (SSOTS) analysis method and the algorithm procedure based on the finite-element difference method are presented. Numerical results of coupled cases are compared with those of uncoupled cases. It shows that the coupling effects on temperature, thermal flux, displacement, and stresses are very distinct, and the micro- characteristics of particles affect the coupling effect of the random composites. Furthermore, the coupling effect causes a lag in the variations of temperature, thermal flux, displacement, and stresses.展开更多
基金Project(11272359)supported by the National Natural Science Foundation of China
文摘Many scientific and engineering problems need to use numerical methods and algorithms to obtain computational simulation results because analytical solutions are seldom available for them.The chemical dissolution-front instability problem in fluid-saturated porous rocks is no exception.Since this kind of instability problem has both the conventional(i.e.trivial)and the unconventional(i.e.nontrivial)solutions,it is necessary to examine the effects of different numerical algorithms,which are used to solve chemical dissolution-front instability problems in fluid-saturated porous rocks.Toward this goal,two different numerical algorithms associated with the commonly-used finite element method are considered in this paper.In the first numerical algorithm,the porosity,pore-fluid pressure and acid/solute concentration are selected as basic variables,while in the second numerical algorithm,the porosity,velocity of pore-fluid flow and acid/solute concentration are selected as basic variables.The particular attention is paid to the effects of these two numerical algorithms on the computational simulation results of unstable chemical dissolution-front propagation in fluid-saturated porous rocks.The related computational simulation results have demonstrated that:1)the first numerical algorithm associated with the porosity-pressure-concentration approach can realistically simulate the evolution processes of unstable chemical dissolution-front propagation in chemical dissolution systems.2)The second numerical algorithm associated with the porosity-velocity-concentration approach fails to simulate the evolution processes of unstable chemical dissolution-front propagation.3)The extra differential operation is the main source to result in the failure of the second numerical algorithm.
基金This project is supported by National Natural Science Foundation of China (No.50205019) Development Foundation of Shanghai Municipal Commission of Education, China (No.04EB03).
文摘A closed-form numerical algorithm (CFNA) is analyzed in detail. CFNA iswidely used in mechanical dynamics for periodic solution of second-order original differentialequations (SODE) with periodic time-variant coefficients. The principle of the algorithm is todiscretize the motion period into many short time intervals, so the coefficient matrices of theequation set are regarded as constant in a time interval. Defects are found in the originalalgorithm in treating the modal coordinates at the two end-nodes and important modifications to thedefects is made for the algorithm. The modified algorithm is finally used to solve the dynamicproblem of a three-ring planetary gear transmission.
基金Supported by the Doctoral programme foundation of National Education Ministry of China
文摘If we use Littlewood-Paley decomposition, there is no pseudo-orthogonality for Ho¨rmander symbol operators OpS m 0 , 0 , which is different to the case S m ρ,δ (0 ≤δ 〈 ρ≤ 1). In this paper, we use a special numerical algorithm based on wavelets to study the L p continuity of non infinite smooth operators OpS m 0 , 0 ; in fact, we apply first special wavelets to symbol to get special basic operators, then we regroup all the special basic operators at given scale and prove that such scale operator’s continuity decreases very fast, we sum such scale operators and a symbol operator can be approached by very good compact operators. By correlation of basic operators, we get very exact pseudo-orthogonality and also L 2 → L 2 continuity for scale operators. By considering the influence region of scale operator, we get H 1 (= F 0 , 2 1 ) → L 1 continuity and L ∞→ BMO continuity. By interpolation theorem, we get also L p (= F 0 , 2 p ) → L p continuity for 1 〈 p 〈 ∞ . Our results are sharp for F 0 , 2 p → L p continuity when 1 ≤ p ≤ 2, that is to say, we find out the exact order of derivations for which the symbols can ensure the resulting operators to be bounded on these spaces.
基金supported by the Fundatmental Research Funds for the Central Universities of China (Grant No. CXZZ11_0215)
文摘As one of the important components of computational flight mechanics and control,numerical algorithms of trajectory optimization for flight vehicles are currently studied by many researchers in aerospace engineering to completely solve these difficult problems,but few papers on the survey of this research field have been published recently.Based on the investigation of more than one hundred literatures,considering the application perspectives of computational flight mechanics and recent developments of trajectory optimization,the numerical algorithms of trajectory optimizations for aerospace vehicles are summarized and systematically analyzed.This paper summarized the basic principle,characteristics and application for all kinds of current trajectory optimization algorithms;and introduced some new methods and theories appearing in recent years.Finally,collaborative trajectory optimization for many flight vehicles,and hypersonic vehicle trajectory optimization were mainly reviewed in this paper.In the conclusion of this paper,the future research properties are presented regarding to numerical algorithms of trajectory optimization and control for flight vehicles as follows:collaboration and antagonization for many flight vehicles and multiple targets,global,real-time online,high accuracy of 7-D trajectory,considering all kinds of unknown random disturbances in trajectory optimization,and so on.
基金Supported by the National Natural Science Foundation of China (61862033, 61762049, 61902162)Jiangxi Provincial Natural Science Foundation (20202BABL202026, 20202BABL202025, 20202BAB202015)。
文摘The development of algebraic and numerical algorithms is a kind of complicated creative work and it is difficult to guarantee the correctness of the algorithms. This paper introduces a systematic and unified formal development method of algebraic and numerical algorithms. The method implements the complete refinement process from abstract specifications to a concrete executable program. It uses the core idea of partition and recursion for formal derivation and combines the mathematical induction based on strict mathematical logic with Hoare axiom for correctness verification. This development method converts creative work into non-creative work as much as possible while ensuring the correctness of the algorithm, which can not only verify the correctness of the existing algebraic and numerical algorithms but also guide the development of efficient unknown algorithms for such problems. This paper takes the non-recursive implementation of the Extended Euclidean Algorithm and Horner's method as examples. Therefore, the effectiveness and feasibility of this method are further verified.
基金supported by Science for Earthquake Resilience (XH12032)
文摘The information of seismic response spectra is key to many problems concerned with aseismic structure and is also helpful for earthquake disaster relief if it is generated in time when earthquake happens. While current numerical calculation methods suffer from poor precision, especially in frequency band near Nyquist frequency, we present a set of improved parameters for precision improvement. It is shown that precision of displacement and velocity response spectra are both further improved compared to current numerical algorithms. A uniform fitting formula is given for computing these parameters for damping ratio range of 0.01-0.9, quite convenient for practical application.
文摘In order to achieve attitude control of the six degrees of freedom steward dynamic platform, as well as the real time simulation cockpit attitude, Washout Filtering method was adopted in this paper as the simulation algorithm to derive Washout Fiher high-pass, low-pass filter transfer functions into a differential equation algorithm and longitudinal acceleration tilt strategy, pitching strategies etc. Experimental examples are used to verify correctness of the algorithm.
文摘A numerical algorithm of principal component analysis (PCA) is proposed and its application in remote sensing image processing is introduced: (1) Multispectral image compression;(2) Multi-spectral image noise cancellation;(3) Information fusion of multi-spectral images and spot panchromatic images. The software experiments verify and evaluate the effectiveness and accuracy of the proposed algorithm.
基金supported by the National Natural Science Foundation of China(61271250)
文摘The backtracking search optimization algorithm(BSA) is one of the most recently proposed population-based evolutionary algorithms for global optimization. Due to its memory ability and simple structure, BSA has powerful capability to find global optimal solutions. However, the algorithm is still insufficient in balancing the exploration and the exploitation. Therefore, an improved adaptive backtracking search optimization algorithm combined with modified Hooke-Jeeves pattern search is proposed for numerical global optimization. It has two main parts: the BSA is used for the exploration phase and the modified pattern search method completes the exploitation phase. In particular, a simple but effective strategy of adapting one of BSA's important control parameters is introduced. The proposed algorithm is compared with standard BSA, three state-of-the-art evolutionary algorithms and three superior algorithms in IEEE Congress on Evolutionary Computation 2014(IEEE CEC2014) over six widely-used benchmarks and 22 real-parameter single objective numerical optimization benchmarks in IEEE CEC2014. The results of experiment and statistical analysis demonstrate the effectiveness and efficiency of the proposed algorithm.
基金This project is supported by National Natural Science Foundation of China (No.59805001)
文摘A new algorithm of structure random response numerical characteristics, namedas matrix algebra algorithm of structure analysis is presented. Using the algorithm, structurerandom response numerical characteristics can easily be got by directly solving linear matrixequations rather than structure motion differential equations. Moreover, in order to solve thecorresponding linear matrix equations, the numerical integration fast algorithm is presented. Thenaccording to the results, dynamic design and life-span estimation can be done. Besides, the newalgorithm can solve non-proportion damp structure response.
文摘A mathematical model of resin flow and temperature variation in the filling stage of the resin transfer molding (RTM) is developed based on the control volume/finite element method (CV/FEM). The effects of the heat transfer and chemical reaction of the resin on the flow and temperature are considered. The numerical algorithm of the resin flow and temperature variation in the process of RTM are studied. Its accuracy and convergence are analyzed. The comparison of temperature variations between experimental results and model predictions is carried out for two RTM cases. Result shows that the model is efficient for evaluating the flow and temperature variation in the filling stage of RTM and there is a good coincidence between theory and experiment.
基金the National Natural Science Foun-dation of China under Grant Nos. 40575043 and 40605024as well as 40730952the National Basic Research Program of China under Grant No. 2009CB421405The Innovation Project of the Chinese Academy of Sci-ences (Grant No. KZCX2-YW-220)
文摘In almost all frozen soil models used currently, three variables of temperature, ice content and moisture content are used as prognostic variables and the rate term, accounting for the contribution of the phase change between water and ice, is shown explicitly in both the energy and mass balance equations. The models must be solved by a numerical method with an iterative process, and the rate term of the phase change needs to be pre-estimated at the beginning in each iteration step. Since the rate term of the phase change in the energy equation is closely related to the release or absorption of the great amount of fusion heat, a small error in the rate term estimation will introduce greater error in the energy balance, which will amplify the error in the temperature calculation and in turn, cause problems for the numerical solution convergence. In this work, in order to first reduce the trouble, the methodology of the variable transformation is applied to a simplified frozen soil model used currently, which leads to new frozen soil scheme used in this work. In the new scheme, the enthalpy and the total water equivalent are used as predictive variables in the governing equations to replace temperature, volumetric soil moisture and ice content used in many current models. By doing so, the rate terms of the phase change are not shown explicitly in both the mass and energy equations and its pre-estimation is avoided. Secondly, in order to solve this new scheme more functionally, the development of the numerical scheme to the new scheme is described and a numerical algorithm appropriate to the numerical scheme is developed. In order to evaluate the new scheme of the frozen soil model and its relevant algorithm, a series of model evaluations are conducted by comparing numerical results from the new model scheme with three observational data sets. The comparisons show that the results from the model are in good agreement with these data sets in both the change trend of variables and their magnitude values, and the new scheme, together with the algorithm, is more efficient and saves more computer time.
文摘A newly-developed numerical algorithm, which is called the new Generalized-α (G-α) method, is presented for solving structural dynamics problems with nonlinear stiffness. The traditional G-α method has undesired overshoot properties as for a class of α-method. In the present work, seven independent parameters are introduced into the single-step three-stage algorithmic formulations and the nonlinear internal force at every time interval is approximated by means of the generalized trapezoidal rule, and then the algorithm is implemented based on the finite difference theory. An analysis on the stability, accuracy, energy and overshoot properties of the proposed scheme is performed in the nonlinear regime. The values or the ranges of values of the seven independent parameters are determined in the analysis process. The computational results obtained by the new algorithm show that the displacement accuracy is of order two, and the acceleration can also be improved to a second order accuracy by a suitable choice of parameters. Obviously, the present algorithm is zero- stable, and the energy conservation or energy decay can be realized in the high-frequency range, which can be regarded as stable in an energy sense. The algorithmic overshoot can be completely avoided by using the new algorithm without any constraints with respect to the damping force and initial conditions.
基金the Natural Science Foundation of China (No. 10471151)the Educational Science Foundation of Chongqing (KJ051307).
文摘We introduced a new class of fuzzy set-valued variational inclusions with (H,η)-monotone mappings. Using the resolvent operator method in Hilbert spaces, we suggested a new proximal point algorithm for finding approximate solutions, which strongly converge to the exact solution of a fuzzy set-valued variational inclusion with (H,η)-monotone. The results improved and generalized the general quasi-variational inclusions with fuzzy set-valued mappings proposed by Jin and Tian Jin MM, Perturbed proximal point algorithm for general quasi-variational inclusions with fuzzy set-valued mappings, OR Transactions, 2005, 9(3): 31-38, (In Chinese); Tian YX, Generalized nonlinear implicit quasi-variational inclusions with fuzzy mappings, Computers & Mathematics with Applications, 2001, 42: 101-108.
基金The work was supported by the National Natural Science Foundation of China(Grants 11672062,11772082,and 11672063)the 111 Project(Grant B08014)the Fundamental Research Funds for the Central Universities.
文摘In this paper,the quasi-static large deformation,wrinkling and fracture behaviors of bimodular structures and membranes are studied with an implicit bond-based peridynamic computational framework.Firstly,the constant and tangential stiffness matrices of the implicit peridynamic formulations for the nonlinear problems are derived,respectively.The former is con structed from the linearization of the bond strain on the basis of the geometric approximation while the latter is established according to the linearization of the pairwise force by using first-order Taylor’s expansion.Then,a bimodular material model in peridynamics is developed,in which the tensile or compressive behavior of the material at each point is conveniently described by the tensile or compressive states of the bonds in its neighborhood.Moreover,the bimodular material model is extended to deal with the wrinkling and fracture problems of membranes by setting the compressive micro-modulus to be zero.In addition,the incremental-iterative algorithm is adopted to obtain the convergent solutions of the nonlinear problems.Finally,several representative numerical examples are presented and the results demonstrate the accuracy and efficiency of the proposed method for the large deformation,wrinkling and fracture analyses of bimodular structures and membranes.
基金the National Key R&D Program of China(No.2017YFB0306300)the National Natural Science Foundation of China(Nos.51675538,51601060)+1 种基金the State Key Laboratory of High-performance Complex Manufacturing,China(No.ZZYJKT2018-18)the Fundamental Research Funds for the Central Universities of Central South University,China(No.2018zzts151).
文摘A unified constitutive model is presented to predict the recently observed“multi-stage”creep behavior of Al−Li−S4 alloy.The corresponding microstructural variables related to the yield strength and creep deformation of the alloy during the creep ageing process,including dislocations and multiple precipitates,have been characterized in detail by X-ray diffraction(XRD)and transmission electron microscopy(TEM).For the yield strength,the model considers the multiphase strengthening behavior of the alloy based on strengthening mechanisms,which includes shearable T1 precipitate strengthening,non-shearable T1 precipitate strengthening andθ′precipitate strengthening.Based on creep deformation mechanism,the“multi-stage”creep behavior of the alloy is predicted by introducing the effects of interacting microstructural variables,including the radius of multiple precipitates,dislocation density and solute concentration,into the creep stress−strain model.It is concluded that the results calculated by the model are in a good agreement with the experimental data,which validates the proposed model.
文摘A feedforward approach for generating near time optimal controller for flexible spacecraft rest-to-rest maneuvers is presented with the objective insensitivity to modeling errors, parameter uncertainty and minimizing the residual energy of the flexible modes. The perturbation estimation of flexible appendages to the rigid-hub is accomplished simply via compare the output of real plant with the reference model, and the approach is based on combine this estimation with the bang-bang control for the rigid-hub modes through analysis the basic constraint and the additional constraint, i.e. zero coupling torque and zero coupling torque derivative for general two orders system and three orders system with considerate attitude acceleration mode near time optimal controls. These time optimal controls with control constraints and state constraints leads to forming a boundary-value problem, and resolved the problem using an iterative numerical algorithm. The near time optimal control with perturbation estimation shows a good robust to parameter uncertainty and can suppress the vibration and minimizing the residual energy. The capability of this approach is demonstrated through a numerical example in detail.
基金Researchers supporting Project number(RSP-2020/33),King Saud University,Riyadh,Saudi Arabia。
文摘The investigation of local thermal transport rate in the nanolubricants is significant.These lubricants are broadly used in environmental pollution,mechanical engineering and in the paint industry due to high thermal performance rate.Therefore,thermal transport in ZnO-SAE50 nanolubricant under the impacts of heat generation/absorption is conducted.The colloidal suspension is flowing between parallel stretching disks in which the lower disk is positioned at z=0 and upper disk apart from distance d.The problem is transformed in dimensionless version via described similarity transforms.In the next stage,an analytical technique(VPM)is implemented for the solution purpose.The graphical results against multiple flow parameters were furnished over the region of interest and explained comprehensively.It is imperative to mention that the results are plotted for ZnO-SAE50 and conventional liquid as well.Further,rapid motion of the fluid is perceived against high Reynolds andγparameters.The wall shear stresses at the upper end rises for multiple Reynolds andγwhile;decrement is detected at the lower end.The significant contribution of an internal heat source is noted for thermal performance rate at the upper end.Foremost,the local heat transport rate declines at the lower disk.By altering Reynolds number,prompt heat transfer rate is gained at the upper disk and increasing behavior of the local heat transport rate is slow at the lower disk.From the study,it is concluded that the nanolubricants have high thermal characteristics.Therefore,such fluids are reliable to use in above stated areas.
基金This work is supported by a Young Innovative Talents Program in Universities and Colleges of Guangdong Province(2018KQNCX338)two Scientific Research-Innovation Team Projects at Zhuhai Campus,Beijing Institute of Technology(XK-2018-15,XK-2019-10).
文摘In this article,a new algorithm is presented to solve the nonlinear impulsive differential equations.In the first time,this article combines the reproducing kernel method with the least squares method to solve the second-order nonlinear impulsive differential equations.Then,the uniform convergence of the numerical solution is proved,and the time consuming Schmidt orthogonalization process is avoided.The algorithm is employed successfully on some numerical examples.
基金supported by the Special Funds for the National Basic Research Program of China(Grant No.2012CB025904)the National Natural ScienceFoundation of China(Grant Nos.90916027 and 11302052)
文摘This paper focuses on the dynamic thermo-mechanical coupled response of random particulate composite materials. Both the inertia term and coupling term are considered in the dynamic coupled problem. The formulation of the problem by a statistical second-order two-scale (SSOTS) analysis method and the algorithm procedure based on the finite-element difference method are presented. Numerical results of coupled cases are compared with those of uncoupled cases. It shows that the coupling effects on temperature, thermal flux, displacement, and stresses are very distinct, and the micro- characteristics of particles affect the coupling effect of the random composites. Furthermore, the coupling effect causes a lag in the variations of temperature, thermal flux, displacement, and stresses.