Parallel finite element method using domain decomposition technique is adapted to a distributed parallel environment of workstation cluster. The algorithm is presented for parallelization of the preconditioned conjuga...Parallel finite element method using domain decomposition technique is adapted to a distributed parallel environment of workstation cluster. The algorithm is presented for parallelization of the preconditioned conjugate gradient method based on domain decomposition. Using the developed code, a dam structural analysis problem is solved on workstation cluster and results are given. The parallel performance is analyzed.展开更多
Parallel computing is a promising approach to alleviate the computational demand in conducting large-scale finite element analyses.This paper presents a numerical modeling approach for earthquake ground response and l...Parallel computing is a promising approach to alleviate the computational demand in conducting large-scale finite element analyses.This paper presents a numerical modeling approach for earthquake ground response and liquefaction using the parallel nonlinear finite element program,ParCYCLIC,designed for distributed-memory message-passing parallel computer systems.In ParCYCLIC,finite elements are employed within an incremental plasticity,coupled solid-fluid formulation,A constitutive model calibrated by physical tests represents the salient characteristics of sand liquefaction and associated accumulation of shear deformations.Key elements of the computational strategy employed in ParCYCLIC include the development of a parallel sparse direct solver,the deployment of an automatic domain decomposer,and the use of the Multilevel Nested Dissection algorithm for ordering of the finite element nodes.Simulation results of centrifuge test models using ParCYCLIC are presented.Performance results from grid models and geotechnical simulations show that ParCYCLIC is efficiently scalable to a large number of processors.展开更多
Based on domain decomposition, a parallel two-level finite element method for the stationary Navier-Stokes equations is proposed and analyzed. The basic idea of the method is first to solve the Navier-Stokes equations...Based on domain decomposition, a parallel two-level finite element method for the stationary Navier-Stokes equations is proposed and analyzed. The basic idea of the method is first to solve the Navier-Stokes equations on a coarse grid, then to solve the resulted residual equations in parallel on a fine grid. This method has low communication complexity. It can be implemented easily. By local a priori error estimate for finite element discretizations, error bounds of the approximate solution are derived. Numerical results are also given to illustrate the high efficiency of the method.展开更多
For a coupled system of multiplayer dynamics of fluids in porous media, the characteristic finite element domain decomposition procedures applicable to parallel arithmetic are put forward. Techniques such as calculus ...For a coupled system of multiplayer dynamics of fluids in porous media, the characteristic finite element domain decomposition procedures applicable to parallel arithmetic are put forward. Techniques such as calculus of variations, domain decomposition, characteristic method, negative norm estimate, energy method and the theory of prior estimates are adopted. Optimal order estimates in L^2 norm are derived for the error in the approximate solution.展开更多
In this paper, we shall study the domain decomposition techniques for the finite element probability computational methods. These techniques provide a theoretical basis for parallel probability computational methods.
Stabilized explicit-implicit domain decomposition is a group of methods for solving time-dependent partial difference equations of the parabolic type on parallel computers. They are efficient, stable, and highly paral...Stabilized explicit-implicit domain decomposition is a group of methods for solving time-dependent partial difference equations of the parabolic type on parallel computers. They are efficient, stable, and highly parallel, but suffer from a restriction that the interface boundaries must not intersect inside the domain. Various techniques have been proposed to handle this restriction. In this paper, we present finite difference schemes for discretizing the equation spatially, which is of high simplicity, easy to implement, attains second-order spatial accuracy, and allows interface boundaries to intersect inside the domain.展开更多
Large eddy simulation(LES) cooperated with a high performance parallel computing method is applied to simulate the flow in a curved duct with square cross section in the paper. The method consists of parallel domain d...Large eddy simulation(LES) cooperated with a high performance parallel computing method is applied to simulate the flow in a curved duct with square cross section in the paper. The method consists of parallel domain decomposition of grids, creation of virtual diagonal bordered matrix, assembling of boundary matrix, parallel LDL^T decomposition, parallel solving of Poisson Equation, parallel estimation of convergence and so on. The parallel computing method can solve the problems that are difficult to solve using traditional serial computing. Furthermore, existing microcomputers can be fully used to resolve some large-scale problems of complex turbulent flow.展开更多
A matrix equation solved in an eddy current analysis,??-??method based on a domain decomposition method becomes a complex symmetric system.In general,iterative method is used as the solver.Convergence of iterative met...A matrix equation solved in an eddy current analysis,??-??method based on a domain decomposition method becomes a complex symmetric system.In general,iterative method is used as the solver.Convergence of iterative method in an interface problem is improved by increasing an accuracy of a solution of an iterative method of a subdomain problem.However,it is difficult to improve the convergence by using a small convergence criterion in the subdomain problem.Therefore,authors propose a method to introduce double-double precision into the interface problem and the subdomain problem.This proposed method improves the convergence of the interface problem.In this paper,first,we describe proposed method.Second,we confirm validity of the method by using Team Workshop Problem 7,standard model for eddy current analysis.Finally,we show effectiveness of the method from two numerical results.展开更多
An iterative nonoverlapping domain decomposition procedure is proposed and analyzed for linear elliptic problems. At the interface of two subdomains, one subdomain problem requires that Dirichlet data be passed to it ...An iterative nonoverlapping domain decomposition procedure is proposed and analyzed for linear elliptic problems. At the interface of two subdomains, one subdomain problem requires that Dirichlet data be passed to it from the previous iteration level, while the other subdomain problem requires that Neumann data be passed to it. This procedure is suitable for parallel processing. A convergence analysis is established. Standard and mixed finite element methods are employed to give discrete versions of this domain decomposition algorithm. Numerical experiments arc conducted to show the effectiveness of the method.展开更多
In this paper,a bioheat model of temperature distribution in the human eye is studied,the mathematical formulation of this model is described using adequate mathematical tools.The existence and the uniqueness of the s...In this paper,a bioheat model of temperature distribution in the human eye is studied,the mathematical formulation of this model is described using adequate mathematical tools.The existence and the uniqueness of the solution of this problem is proven and four algorithms based on finite element method approximation and domain decomposition methods are presented in details.The validation of all algorithm is done using a numerical application for an example where the analytical solution is known.The properties and parameters reported in the open literature for the human eye are used to approximate numerically the temperature for bioheat model by finite element approximation and nonoverlapping domain decomposition method.The obtained results that are verified using the experimental results recorded in the literature revealed a better accuracy by the use of algorithm proposed.展开更多
Based on fully overlapping domain decomposition,a parallel finite element algorithm for the unsteady Oseen equations is proposed and analyzed.In this algorithm,each processor independently computes a finite element ap...Based on fully overlapping domain decomposition,a parallel finite element algorithm for the unsteady Oseen equations is proposed and analyzed.In this algorithm,each processor independently computes a finite element approximate solution in its own subdomain by using a locally refined multiscale mesh at each time step,where conforming finite element pairs are used for the spatial discretizations and backward Euler scheme is used for the temporal discretizations,respectively.Each subproblem is defined in the entire domain with vast majority of the degrees of freedom associated with the particular subdomain that it is responsible for and hence can be solved in parallel with other subproblems using an existing sequential solver without extensive recoding.The algorithm is easy to implement and has low communication cost.Error bounds of the parallel finite element approximate solutions are estimated.Numerical experiments are also given to demonstrate the effectiveness of the algorithm.展开更多
Heterogeneous multicore clusters are becoming more popular for high-performance computing due to their great computing power and cost-to-performance effectiveness nowadays.Nevertheless,parallel efficiency degradation ...Heterogeneous multicore clusters are becoming more popular for high-performance computing due to their great computing power and cost-to-performance effectiveness nowadays.Nevertheless,parallel efficiency degradation is still a problem in large-scale structural analysis based on heterogeneousmulticore clusters.To solve it,a hybrid hierarchical parallel algorithm(HHPA)is proposed on the basis of the conventional domain decomposition algorithm(CDDA)and the parallel sparse solver.In this new algorithm,a three-layer parallelization of the computational procedure is introduced to enable the separation of the communication of inter-nodes,heterogeneous-core-groups(HCGs)and inside-heterogeneous-core-groups through mapping computing tasks to various hardware layers.This approach can not only achieve load balancing at different layers efficiently but can also improve the communication rate significantly through hierarchical communication.Additionally,the proposed hybrid parallel approach in this article can reduce the interface equation size and further reduce the solution time,which can make up for the shortcoming of growing communication overheads with the increase of interface equation size when employing CDDA.Moreover,the distributed sparse storage of a large amount of data is introduced to improve memory access.By solving benchmark instances on the Shenwei-Taihuzhiguang supercomputer,the results show that the proposed method can obtain higher speedup and parallel efficiency compared with CDDA and more superior extensibility of parallel partition compared with the two-level parallel computing algorithm(TPCA).展开更多
间断有限元算法(Discontinuous Galerkin Finite Element Method,DGM)是一种高精度的数值求解算法,针对电磁工程应用中DGM并行计算效率低、计算量较大的问题,提出了基于SW26010平台的并行DGM算法。通过区域分解、数据结构重构、热点函...间断有限元算法(Discontinuous Galerkin Finite Element Method,DGM)是一种高精度的数值求解算法,针对电磁工程应用中DGM并行计算效率低、计算量较大的问题,提出了基于SW26010平台的并行DGM算法。通过区域分解、数据结构重构、热点函数从核并行计算、计算与通信重叠及从核缓冲优化技术完成了DGM算法的并行优化。实现结果表明,与基于MPI进程级的DGM并行算法相比,可以获得46.8的平均加速比。展开更多
基金Project supported by Key Project Science Foundation of ShanghaiMunicipal Commission of Education (Grant No .03AZ03)
文摘Parallel finite element method using domain decomposition technique is adapted to a distributed parallel environment of workstation cluster. The algorithm is presented for parallelization of the preconditioned conjugate gradient method based on domain decomposition. Using the developed code, a dam structural analysis problem is solved on workstation cluster and results are given. The parallel performance is analyzed.
基金the National Science Foundation Grants Number CMS-0084616,0200510 and ANI-0205720 to University of California,San Diego, and Grant Number CMS-0084530 to Stanford UniversityAdditional funding was also provided by the NSF cooperative agreement ACI-9619020 through computing resources provided by the National Partnership for Advanced Computational Infrastructure at the San Diego Supercomputer Center
文摘Parallel computing is a promising approach to alleviate the computational demand in conducting large-scale finite element analyses.This paper presents a numerical modeling approach for earthquake ground response and liquefaction using the parallel nonlinear finite element program,ParCYCLIC,designed for distributed-memory message-passing parallel computer systems.In ParCYCLIC,finite elements are employed within an incremental plasticity,coupled solid-fluid formulation,A constitutive model calibrated by physical tests represents the salient characteristics of sand liquefaction and associated accumulation of shear deformations.Key elements of the computational strategy employed in ParCYCLIC include the development of a parallel sparse direct solver,the deployment of an automatic domain decomposer,and the use of the Multilevel Nested Dissection algorithm for ordering of the finite element nodes.Simulation results of centrifuge test models using ParCYCLIC are presented.Performance results from grid models and geotechnical simulations show that ParCYCLIC is efficiently scalable to a large number of processors.
基金Project supported by the National Natural Science Foundation of China(No.11001061)the Science and Technology Foundation of Guizhou Province of China(No.[2008]2123)
文摘Based on domain decomposition, a parallel two-level finite element method for the stationary Navier-Stokes equations is proposed and analyzed. The basic idea of the method is first to solve the Navier-Stokes equations on a coarse grid, then to solve the resulted residual equations in parallel on a fine grid. This method has low communication complexity. It can be implemented easily. By local a priori error estimate for finite element discretizations, error bounds of the approximate solution are derived. Numerical results are also given to illustrate the high efficiency of the method.
基金Supported by the Major State Basic Research Program of China (No. 1999032803)the National Tackling Key Problems Program (No. 2002020094)+1 种基金the National Natural Scicnccs Foundation of China (Nos.19972039,10271066)the Doctorate Foundation of the Ministry of Education of China (No.2003042047)
文摘For a coupled system of multiplayer dynamics of fluids in porous media, the characteristic finite element domain decomposition procedures applicable to parallel arithmetic are put forward. Techniques such as calculus of variations, domain decomposition, characteristic method, negative norm estimate, energy method and the theory of prior estimates are adopted. Optimal order estimates in L^2 norm are derived for the error in the approximate solution.
基金This research is supported by the Foundation of Education Committee of Henan Province.
文摘In this paper, we shall study the domain decomposition techniques for the finite element probability computational methods. These techniques provide a theoretical basis for parallel probability computational methods.
文摘Stabilized explicit-implicit domain decomposition is a group of methods for solving time-dependent partial difference equations of the parabolic type on parallel computers. They are efficient, stable, and highly parallel, but suffer from a restriction that the interface boundaries must not intersect inside the domain. Various techniques have been proposed to handle this restriction. In this paper, we present finite difference schemes for discretizing the equation spatially, which is of high simplicity, easy to implement, attains second-order spatial accuracy, and allows interface boundaries to intersect inside the domain.
文摘Large eddy simulation(LES) cooperated with a high performance parallel computing method is applied to simulate the flow in a curved duct with square cross section in the paper. The method consists of parallel domain decomposition of grids, creation of virtual diagonal bordered matrix, assembling of boundary matrix, parallel LDL^T decomposition, parallel solving of Poisson Equation, parallel estimation of convergence and so on. The parallel computing method can solve the problems that are difficult to solve using traditional serial computing. Furthermore, existing microcomputers can be fully used to resolve some large-scale problems of complex turbulent flow.
文摘A matrix equation solved in an eddy current analysis,??-??method based on a domain decomposition method becomes a complex symmetric system.In general,iterative method is used as the solver.Convergence of iterative method in an interface problem is improved by increasing an accuracy of a solution of an iterative method of a subdomain problem.However,it is difficult to improve the convergence by using a small convergence criterion in the subdomain problem.Therefore,authors propose a method to introduce double-double precision into the interface problem and the subdomain problem.This proposed method improves the convergence of the interface problem.In this paper,first,we describe proposed method.Second,we confirm validity of the method by using Team Workshop Problem 7,standard model for eddy current analysis.Finally,we show effectiveness of the method from two numerical results.
文摘An iterative nonoverlapping domain decomposition procedure is proposed and analyzed for linear elliptic problems. At the interface of two subdomains, one subdomain problem requires that Dirichlet data be passed to it from the previous iteration level, while the other subdomain problem requires that Neumann data be passed to it. This procedure is suitable for parallel processing. A convergence analysis is established. Standard and mixed finite element methods are employed to give discrete versions of this domain decomposition algorithm. Numerical experiments arc conducted to show the effectiveness of the method.
文摘In this paper,a bioheat model of temperature distribution in the human eye is studied,the mathematical formulation of this model is described using adequate mathematical tools.The existence and the uniqueness of the solution of this problem is proven and four algorithms based on finite element method approximation and domain decomposition methods are presented in details.The validation of all algorithm is done using a numerical application for an example where the analytical solution is known.The properties and parameters reported in the open literature for the human eye are used to approximate numerically the temperature for bioheat model by finite element approximation and nonoverlapping domain decomposition method.The obtained results that are verified using the experimental results recorded in the literature revealed a better accuracy by the use of algorithm proposed.
基金supported by the Natural Science Foundation of China(No.11361016)the Basic and Frontier Explore Program of Chongqing Municipality,China(No.cstc2018jcyjAX0305)Funds for the Central Universities(No.XDJK2018B032).
文摘Based on fully overlapping domain decomposition,a parallel finite element algorithm for the unsteady Oseen equations is proposed and analyzed.In this algorithm,each processor independently computes a finite element approximate solution in its own subdomain by using a locally refined multiscale mesh at each time step,where conforming finite element pairs are used for the spatial discretizations and backward Euler scheme is used for the temporal discretizations,respectively.Each subproblem is defined in the entire domain with vast majority of the degrees of freedom associated with the particular subdomain that it is responsible for and hence can be solved in parallel with other subproblems using an existing sequential solver without extensive recoding.The algorithm is easy to implement and has low communication cost.Error bounds of the parallel finite element approximate solutions are estimated.Numerical experiments are also given to demonstrate the effectiveness of the algorithm.
基金supported by the National Natural Science Foundation of China (Grant No.11772192).
文摘Heterogeneous multicore clusters are becoming more popular for high-performance computing due to their great computing power and cost-to-performance effectiveness nowadays.Nevertheless,parallel efficiency degradation is still a problem in large-scale structural analysis based on heterogeneousmulticore clusters.To solve it,a hybrid hierarchical parallel algorithm(HHPA)is proposed on the basis of the conventional domain decomposition algorithm(CDDA)and the parallel sparse solver.In this new algorithm,a three-layer parallelization of the computational procedure is introduced to enable the separation of the communication of inter-nodes,heterogeneous-core-groups(HCGs)and inside-heterogeneous-core-groups through mapping computing tasks to various hardware layers.This approach can not only achieve load balancing at different layers efficiently but can also improve the communication rate significantly through hierarchical communication.Additionally,the proposed hybrid parallel approach in this article can reduce the interface equation size and further reduce the solution time,which can make up for the shortcoming of growing communication overheads with the increase of interface equation size when employing CDDA.Moreover,the distributed sparse storage of a large amount of data is introduced to improve memory access.By solving benchmark instances on the Shenwei-Taihuzhiguang supercomputer,the results show that the proposed method can obtain higher speedup and parallel efficiency compared with CDDA and more superior extensibility of parallel partition compared with the two-level parallel computing algorithm(TPCA).
文摘间断有限元算法(Discontinuous Galerkin Finite Element Method,DGM)是一种高精度的数值求解算法,针对电磁工程应用中DGM并行计算效率低、计算量较大的问题,提出了基于SW26010平台的并行DGM算法。通过区域分解、数据结构重构、热点函数从核并行计算、计算与通信重叠及从核缓冲优化技术完成了DGM算法的并行优化。实现结果表明,与基于MPI进程级的DGM并行算法相比,可以获得46.8的平均加速比。