46 resultados para Gradient Method

em Chinese Academy of Sciences Institutional Repositories Grid Portal


Relevância:

70.00% 70.00%

Publicador:

Resumo:

A hybrid finite difference method and vortex method (HDV), which is based on domain decomposition and proposed by the authors (1992), is improved by using a modified incomplete LU decomposition conjugate gradient method (MILU-CG), and a high order implicit difference algorithm. The flow around a rotating circular cylinder at Reynolds number R-e = 1000, 200 and the angular to rectilinear speed ratio alpha is an element of (0.5, 3.25) is studied numerically. The long-time full developed features about the variations of the vortex patterns in the wake, and drag, lift forces on the cylinder are given. The calculated streamline contours agreed well with the experimental visualized flow pictures. The existence of critical states and the vortex patterns at the states are given for the first time. The maximum lift to drag force ratio can be obtained nearby the critical states.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Abstract. The atomic motion is coupled by the fast and slow components due to the high frequency vibration of atoms and the low frequency deformation of atomic lattice, respectively. A two-step approximate method was presented to determine the atomic slow motion. The first step is based on the change of the location of the cold potential well bottom and the second step is based on the average of the appropriate slow velocities of the surrounding atoms. The simple tensions of one-dimensional atoms and two-dimensional atoms were performed with the full molecular dynamics simulations. The conjugate gradient method was employed to determine the corresponding location of cold potential well bottom. Results show that our two-step approximate method is appropriate to determine the atomic slow motion under the low strain rate loading. This splitting method may be helpful to develop more efficient molecular modeling methods and simulations pertinent to realistic loading conditions of materials.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Five models for human interleukin-7 (HIL-7), HIL-9, HIL-13, HIL-15 and HIL-17 have been generated by SYBYL software package. The primary models were optimized using molecular dynamics and molecular mechanics methods. The final models were optimized using a steepest descent algorithm and a subsequent conjugate gradient method. The complexes with these interleukins and the common gamma chain of interleukin-2 receptor (IL-2R) were constructed and subjected to energy minimization. We found residues, such as Gln127 and Tyr103, of the common gamma chain of IL-2R are very important. Other residues, e.g. Lys70, Asn128 and Glu162, are also significant. Four hydrophobic grooves and two hydrophilic sites converge at the active site triad of the gamma chain. The binding sites of these interleukins interaction with the common gamma chain exist in the first helical and/or the fourth helical domains. Therefore, we conclude that these interleukins binds to the common gamma chain of IL-2R by the first and the fourth helix domain. Especially at the binding sites of some residues (lysine, arginine, asparagine, glutamic acid and aspartic acid), with a discontinuous region of the common gamma chain of IL-2R, termed the interleukins binding sites (103-210). The study of these sites can be important for the development of new drugs. (C) 2000 Elsevier Science B.V. All rights reserved.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

The atomic motion is coupled by the fast and slow components due to the high frequency vibration of atoms and the low frequency deformation of atomic lattice, respectively. A two-step approximate method was presented to determine the atomic slow motion. The first step is based on the change of the location of the cold potential well bottom and the second step is based on the average of the appropriate slow velocities of the surrounding atoms. The simple tensions of one-dimensional atoms and two-dimensional atoms were performed with the full molecular dynamics simulations. The conjugate gradient method was employed to determine the corresponding location of cold potential well bottom. Results show that our two-step approximate method is appropriate to determine the atomic slow motion under the low strain rate loading. This splitting method may be helpful to develop more efficient molecular modeling methods and simulations pertinent to realistic loading conditions of materials.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

To extend the cross-hole seismic 2D data to outside 3D seismic data, reconstructing the low frequency data to high frequency data is necessary. Blind deconvolution method is a key technology. In this paper, an implementation of Blind deconvolution is introduced. And optimized precondition conjugate gradient method is used to improve the stability of the algorithm and reduce the computation. Then high-frequency retrieved Seismic data and the cross-hole seismic data is combined for constraint inversion. Real data processing proved the method is effective. To solve the problem that the seismic data resolution can’t meet the request of reservoir prediction in the river face thin-layers in Chinese eastern oil fields, a high frequency data reconstruction method is proposed. The extrema of the seismic data are used to get the modulation function which operated with the original seismic data to get the high frequency part of the reconstruction data to rebuild the wide band data. This method greatly saves the computation, and easy to adjust the parameters. In the output profile, the original features of the seismic events are kept, the common feint that breaking the events and adding new zeros to produce alias is avoided. And the interbeded details are enhanced compared to the original profiles. The effective band of seismic data is expended and the method is approved by the processing of the field data. Aim to the problem in the exploration and development of Chinese eastern oil field that the high frequency log data and the relative low frequency seismic data can’t be merged, a workflow of log data extrapolation constrained by time-phase model based on local wave decomposition is raised. The seismic instantaneous phase is resolved by local wave decomposition to build time-phase model, the layers beside the well is matched to build the relation of log and seismic data, multiple log info is extrapolated constrained by seismic equiphase map, high precision attributes inverse sections are produced. In the course of resolve the instantaneous phase, a new method of local wave decomposition --Hilbert transform mean mode decomposition(HMMD) is raised to improve the computation speed and noise immunity. The method is applied in the high resolution reservoir prediction in Mao2 survey of Daqing oil field, Multiple attributes profiles of wave impedance, gamma-ray, electrical resistivity, sand membership degree are produced, of which the resolution is high and the horizontal continuous is good. It’s proved to be a effective method for reservoir prediction and estimation.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Numerical modeling of groundwater is very important for understanding groundwater flow and solving hydrogeological problem. Today, groundwater studies require massive model cells and high calculation accuracy, which are beyond single-CPU computer’s capabilities. With the development of high performance parallel computing technologies, application of parallel computing method on numerical modeling of groundwater flow becomes necessary and important. Using parallel computing can improve the ability to resolve various hydro-geological and environmental problems. In this study, parallel computing method on two main types of modern parallel computer architecture, shared memory parallel systems and distributed shared memory parallel systems, are discussed. OpenMP and MPI (PETSc) are both used to parallelize the most widely used groundwater simulator, MODFLOW. Two parallel solvers, P-PCG and P-MODFLOW, were developed for MODFLOW. The parallelized MODFLOW was used to simulate regional groundwater flow in Beishan, Gansu Province, which is a potential high-level radioactive waste geological disposal area in China. 1. The OpenMP programming paradigm was used to parallelize the PCG (preconditioned conjugate-gradient method) solver, which is one of the main solver for MODFLOW. The parallel PCG solver, P-PCG, is verified using an 8-processor computer. Both the impact of compilers and different model domain sizes were considered in the numerical experiments. The largest test model has 1000 columns, 1000 rows and 1000 layers. Based on the timing results, execution times using the P-PCG solver are typically about 1.40 to 5.31 times faster than those using the serial one. In addition, the simulation results are the exact same as the original PCG solver, because the majority of serial codes were not changed. It is worth noting that this parallelizing approach reduces cost in terms of software maintenance because only a single source PCG solver code needs to be maintained in the MODFLOW source tree. 2. P-MODFLOW, a domain decomposition–based model implemented in a parallel computing environment is developed, which allows efficient simulation of a regional-scale groundwater flow. The basic approach partitions a large model domain into any number of sub-domains. Parallel processors are used to solve the model equations within each sub-domain. The use of domain decomposition method to achieve the MODFLOW program distributed shared memory parallel computing system will process the application of MODFLOW be extended to the fleet of the most popular systems, so that a large-scale simulation could take full advantage of hundreds or even thousands parallel processors. P-MODFLOW has a good parallel performance, with the maximum speedup of 18.32 (14 processors). Super linear speedups have been achieved in the parallel tests, indicating the efficiency and scalability of the code. Parallel program design, load balancing and full use of the PETSc were considered to achieve a highly efficient parallel program. 3. The characterization of regional ground water flow system is very important for high-level radioactive waste geological disposal. The Beishan area, located in northwestern Gansu Province, China, is selected as a potential site for disposal repository. The area includes about 80000 km2 and has complicated hydrogeological conditions, which greatly increase the computational effort of regional ground water flow models. In order to reduce computing time, parallel computing scheme was applied to regional ground water flow modeling. Models with over 10 million cells were used to simulate how the faults and different recharge conditions impact regional ground water flow pattern. The results of this study provide regional ground water flow information for the site characterization of the potential high-level radioactive waste disposal.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Post-stack seismic impedance inversion is the key technology of reservoir prediction and identification. Geophysicists have done a lot of research for the problem, but the developed methods still cannot satisfy practical requirements completely. The results of different inversion methods are different and the results of one method used by different people are different too. The reasons are due to the quality of seismic data, inaccurate wavelet extraction, errors between normal incidence assumption and real situation, and so on. In addition, there are two main influence factors: one is the band-limited property of seismic data; the other is the ill-posed property of impedance inversion. Thus far, the most effective way to solve the band-limited problem is the constrained inversion. And the most effective way to solve ill-posed problems is the regularization method assisted with proper optimization techniques. This thesis systematically introduces the iterative regularization methods and numerical optimization methods for impedance inversion. A regularized restarted conjugate gradient method for solving ill-posed problems in impedance inversion is proposed. Theoretic simulations are made and field data applications are performed. It reveals that the proposed algorithm possesses the superiority to conventional conjugate gradient method. Finally, non-smooth optimization is proposed as the further research direction in seismic impedance inversion according to practical situation.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

The South China Sea (SCS) is one of the largest marginal seas in the western Pacific, which is located at the junction of Eurasian plate, Pacific plate and Indian-Australian plate. It was formed by continent breakup and sea-floor spreading in Cenozoic. The complicated interaction among the three major plates made tectonic movement complex and geological phenomena very rich in this area. The SCS is an ideal place to study the formation and evolution of rifted continental margin and sea-floor spreading since it is old enough to have experienced the major stages of the basin evolution but still young enough to have preserved its original nature. As the demand for energy grows day by day in our country, the deep water region of the northern continental margin in the SCS has become a focus of oil and gas exploration because of its huge hydrocarbon potential. Therefore, to study the rifted continental margin of the SCS not only can improve our understanding of the formation and evolution processes of rifted continental margin, but also can provide theoretical support for hydrocarbon exploration in rifted continental margin. This dissertation mainly includes five topics as follows: (1) Various classic lithosphere stretching models are reviewed, and the continuous non-uniform stretching model is modified to make it suitable for the case where the extension of lithopheric mantle exceeds that of the crust. Then simple/pure shear flexural cantilever model is applied to model the basement geometries of SO49-18 profile in the northern continental margin of the SCS. By fitting the basements obtained by using 2DMove software with modeling results, it is found that the reasonable effective elastic thickness is less than 5km in this region. According to this result, it is assumed that there is weak lower crust in the northern continental margin in the SCS. (2) We research on the methods for stretching factor estimation based on various lithosphere stretching models, and apply the method based on multiple finite rifting model to estimate the stretching factors of several wells and profiles in the northern continental margin of the SCS. (3) We improve one-dimension strain rate inversion method with conjugate gradient method, and apply it to invert the strain rate of several wells in the northern continental margin of the SCS. Two-dimension strain rate forward modeling is carried out, and the modeling results show that effective elastic thickness is a key parameter to control basin’s geometry. (4) We simulate divergent upwelling mantle flow model using finite difference method, and apply this newly developed model to examine the formation mechanism of the northwest and central sub-basin in the SCS. (5) We inverse plate thickness and basal temperature of oceanic lithosphere using sea-floor ages and bathymetries of the North Pacific and the North Atlantic based on varied-parameters plate model, in which the heat conductivity, heat capacity and coefficient of thermal expansion depend on temperature or depth. A new empirical formula is put forward based the inversed parameters, which depicts the relation among sea-floor age, bathymetry and heat flow. Then various similar empirical formulae, including the newly developed one, are applied to examine the sea-floor spread issue in the SCS based on the heat flow and bathymetry data of the abyssal sub-basin.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Impedance inversion is very important in seismic technology. It is based on seismic profile. Good inversion result is derived from high quality seismic profile, which is formed using high resolution imaging resolution. High-resolution process demands that signal/noise ratio is high. It is very important for seismic inversion to improve signal/noise ratio. the main idea is that the physical parameter (wave impedance), which describes the stratigraphy directly, is achieved from seismic data expressing structural style indirectly. The solution of impedance inversion technology, which is based on convolution model, is arbitrary. It is a good way to apply the priori information as the restricted condition in inversion. An updated impedance inversion technology is presented which overcome the flaw of traditional model and highlight the influence of structure. Considering impedance inversion restricted by sedimentary model, layer filling style and congruence relation, the impedance model is built. So the impedance inversion restricted by geological rule could be realized. there are some innovations in this dissertation: 1. The best migration aperture is achieved from the included angle of time surface of diffracted wave and reflected wave. Restricted by structural model, the dip of time surface of reflected wave and diffracted wave is given. 2. The conventional method of FXY forcasting noise is updated, and the signal/noise ratio is improved. 3. Considering the characteristic of probability distribution of seismic data and geological events fully, an object function is constructed using the theory of Bayes estimation as the criterion. The mathematics is used here to describe the content of practice theory. 4. Considering the influence of structure, the seismic profile is interpreted to build the model of structure. A series of structure model is built. So as the impedance model. The high frequency of inversion is controlled by the geological rule. 5. Conjugate gradient method is selected to improve resolving process for it fit the demands of geophysics, and the efficiency of algorithm is enhanced. As the geological information is used fully, the result of impedance inversion is reasonable and complex reservoir could be forecasted further perfectly.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

The dynamic prediction of complex reservoir development is one of the important research contents of dynamic analysis of oil and gas development. With the increase development of time, the permeabilities and porosities of reservoirs and the permeability of block reservoir at its boundaries are dynamically changing. How to track the dynamic change of permeability and porosity and make certain the permeability of block reservoir at its boundary is an important practical problem. To study developing dynamic prediction of complex reservoir, the key problem of research of dynamic prediction of complex reservoir development is realizing inversion of permeability and porosity. To realize the inversion, first of all, the fast forward and inverse method of 3-dimension reservoir simulation must be studied. Although the inversion has been widely applied to exploration and logging, it has not been applied to3-dimension reservoir simulation. Therefore, the study of fast forward and inverse method of 3-dimension reservoir simulation is a cutting-edge problem, takes on important realistic signification and application value. In this dissertation, 2-dimension and 3-dimension fluid equations in porous media are discretized by finite difference, obtaining finite difference equations to meet the inner boundary conditions by Peaceman's equations, giving successive over relaxation iteration of 3-dimension fluid equations in porous media and the dimensional analysis. Several equation-solving methods are compared in common use, analyzing its convergence and convergence rate. The alternating direction implicit procedure of 2-dimension has been turned into successive over relaxation iteration of alternating direction implicit procedure of 3-dimension fluid equations in porous media, which possesses the virtues of fast computing speed, needing small memory of computer, good adaptability for heterogeneous media and fast convergence rate. The geological model of channel-sandy reservoir has been generated with the help of stochastic simulation technique, whose cross sections of channel-sandy reservoir are parabolic shapes. This method makes the hard data commendably meet, very suit for geological modeling of containing complex boundary surface reservoir. To verify reliability of the method, theoretical solution and numerical solution are compared by simplifying model of 3-dimension fluid equations in porous media, whose results show that the only difference of the two pressure curves is that the numerical solution is lower than theoretical at the wellbore in the same space. It proves that using finite difference to solve fluid equations in porous media is reliable. As numerical examples of 3-dimension heterogeneous reservoir of the single-well and multi-well, the pressure distributions have been computed respectively, which show the pressure distributions there are clearly difference as difference of the permeabilities is greater than one order of magnitude, otherwise there are no clearly difference. As application, the pressure distribution of the channel-sandy reservoir have been computed, which indicates that the space distribution of pressure strongly relies on the direction of permeability, and is sensitive for space distributions of permeability. In this dissertation, the Peaceman's equations have been modified into solving vertical well problem and horizontal well problem simultaneously. In porous media, a 3D layer reservoir in which contain vertical wells and horizontal wells has been calculated with iteration. For channel-sandy reservoir in which there are also vertical wells and horizontal wells, a 3D transient heterogeneous fluid equation has been discretized. As an example, the space distribution of pressure has been calculated with iteration. The results of examples are accord with the fact, which shows the modification of Peaceman's equation is correct. The problem has been solved in the space where there are vertical and horizontal wells. In the dissertation, the nonuniform grid permeability integration equation upscaling method, the nonuniform grid 2D flow rate upscaling method and the nonuniform grid 3D flow rate upscaling method have been studied respectively. In those methods, they enhance computing speed greatly, but the computing speed of 3D flow rate upscaling method is faster than that of 2D flow rate upscaling method, and the precision of 3D flow rate upscaling method is better than that of 2D flow rate upscaling method. The results also show that the solutions of upscaling method are very approximating to that of fine grid blocks. In this paper, 4 methods of fast adaptive nonuniform grid upscaling method of 3D fluid equations in porous media have been put forward, and applied to calculate 3D heterogeneous reservoir and channel-sandy reservoir, whose computing results show that the solutions of nonuniform adaptive upscaling method of 3D heterogeneous fluid equations in porous media are very approximating to that of fine grid blocks in the regions the permeability or porosity being abnormity and very approximating to that of coarsen grid blocks in the other region, however, the computing speed of adaptive upscaling method is 100 times faster than that of fine grid block method. The formula of sensitivity coefficients are derived from initial boundary value problems of fluid equations in porous media by Green's reciprocity principle. The sensitivity coefficients of wellbore pressure to permeability parameters are given by Peaceman's equation and calculated by means of numerical calculation method of 3D transient anisotropic fluid equation in porous media and verified by direct method. The computing results are in excellent agreement with those obtained by the direct method, which shows feasibility of the method. In the dissertation, the calculating examples are also given for 3D reservoir, channel-sandy reservoir and 3D multi-well reservoir, whose numerical results indicate: around the well hole, the value of the sensitivity coefficients of permeability is very large, the value of the sensitivity coefficients of porosity is very large too, but the sensitivity coefficients of porosity is much less than the sensitivity coefficients of permeability, so that the effect of the sensitivity coefficients of permeability for inversion of reservoir parameters is much greater than that of the sensitivity coefficients of porosity. Because computing the sensitivity coefficients needs to call twice the program of reservoir simulation in one iteration, realizing inversion of reservoir parameters must be sustained by the fast forward method. Using the sensitivity coefficients of permeability and porosity, conditioned on observed valley erosion thickness in wells (hard data), the inversion of the permeabilities and porosities in the homogeneous reservoir, homogeneous reservoir only along the certain direction and block reservoir are implemented by Gauss-Newton method or conjugate gradient method respectively. The results of our examples are very approximating to the real data of permeability and porosity, but the convergence rate of conjugate gradient method is much faster than that of Gauss-Newton method.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

In this paper, we apply the preconditioned conjugate gradient method to the solution of positive-definite Toeplitz systems, especially we introduce a new kind of co-circulant preconditioners Pn[ca] by the use of embedding method. We have also discussed the properties of these new preconditioners and proved that many of former preconditioners can be considered as some special cases of Pn[co\. Because of the introduction of co-circulant preconditioners pn[a>], we can greatly overcome the singularity caused by circulant preconditioners. We have discussed the oo-circulant series and functions. We compare the ordinary circularity with the co-circularity, showing that the latter one can be considered as the extended form of the former one; correspondingly, many methods and theorems of the ordinary circularity can be extended. Furthermore, we present the co-circulant decompositional method. By the use of this method, we can divide any co-circulant signal into a summation of many sub-signals; especially among those sub-signals, there are many subseries of which their period is just equal to 1, which are actually the frequency elements of the original co-circulant signal. In this way, we can establish the relationship between the signal and its frequency elements, that is, the frequency elements hi the frequency domain are actually signals with the period of 1 in the spatial domain. We have also proved that the co-circulant has already existed in the traditional Fourier theory. By the use of different criteria for constructing preconditioners, we can get many different preconditioned systems. From the preconditioned systems PN[

Relevância:

60.00% 60.00%

Publicador:

Resumo:

Cross well seismic technique is a new type of geophysical method, which observes the seismic wave of the geologic body by placing both the source and receiver in the wells. By applying this method, it averted the absorption to high-frequency component of seismic signal caused by low weathering layers, thus, an extremely high-resolution seismic signal can be acquired. And extremely fine image of cross well formations, structure, and reservoir can be achieved as well. An integrated research is conducted to the high-frequency S-wave and P-wave data and some other data to determine the small faults, small structure and resolving the issues concerning the thin bed and reservoir's connectivity, fluid distribution, steam injection and fracture. This method connects the high-resolution surface seismic, logging and reservoir engineering. In this paper, based on the E & P situation in the oilfield and the theory of geophysical exploration, a research is conducted on cross well seismic technology in general and its important issues in cross well seismic technology in particular. A technological series of integrated field acquisition, data processing and interpretation and its integrated application research were developed and this new method can be applied to oilfield development and optimizing oilfield development scheme. The contents and results in this paper are as listed follows: An overview was given on the status quo and development of the cross well seismic method and problems concerning the cross well seismic technology and the difference in cross well seismic technology between China and international levels; And an analysis and comparison are given on foreign-made field data acquisition systems for cross-well seismic and pointed out the pros and cons of the field systems manufactured by these two foreign companies and this is highly valuable to import foreign-made cross well seismic field acquisition system for China. After analyses were conducted to the geometry design and field data for the cross well seismic method, a common wave field time-depth curve equation was derived and three types of pipe waves were discovered for the first time. Then, a research was conducted on the mechanism for its generation. Based on the wave field separation theory for cross well seismic method, we believe that different type of wave fields in different gather domain has different attributes characteristics, multiple methods (for instance, F-K filtering and median filtering) were applied in eliminating and suppressing the cross well disturbances and successfully separated the upgoing and downgoing waves and a satisfactory result has been achieved. In the area of wave field numerical simulation for cross well seismic method, a analysis was conducted on conventional ray tracing method and its shortcomings and proposed a minimum travel time ray tracing method based on Feraiat theory in this paper. This method is not only has high-speed calculation, but also with no rays enter into "dead end" or "blinded spot" after numerous iterations and it is become more adequate for complex velocity model. This is first time that the travel time interpolation has been brought into consideration, a dynamic ray tracing method with shortest possible path has been developed for the first arrivals of any complex mediums, such as transmission, diffraction and refraction, etc and eliminated the limitation for only traveling from one node to another node and increases the calculation accuracy for minimum travel time and ray tracing path and derives solution and corresponding edge conditions to the fourth-order differential sonic wave equation. The final step is to calculate cross well seismic synthetics for given source and receivers from multiple geological bodies. Thus, real cross-well seismic wave field can be recognized through scientific means and provides important foundation to guide the cross well seismic field geometry designing. A velocity tomographic inversion of the least square conjugated gradient method was developed for cross well seismic velocity tomopgraphic inversion and a modification has been made to object function of the old high frequency ray tracing method and put forward a thin bed oriented model for finite frequency velocity tomographic inversion method. As the theory model and results demonstrates that the method is simple and effective and is very important in seismic ray tomographic imaging for the complex geological body. Based on the characteristics of the cross well seismic algorithm, a processing flow for cross well seismic data processing has been built and optimized and applied to the production, a good section of velocity tomopgrphic inversion and cross well reflection imaging has been acquired. The cross well seismic data is acquired from the depth domain and how to interprets the depth domain data and retrieve the attributes is a brand new subject. After research was conducted on synthetics and trace integration from depth domain for the cross well seismic data interpretation, first of all, a research was conducted on logging constraint wave impedance of cross well seismic data and initially set up cross well seismic data interpretation flows. After it applied and interpreted to the cross well seismic data and a good geological results has been achieved in velocity tomographic inversion and reflection depth imaging and a lot of difficult problems for oilfield development has been resolved. This powerful, new method is good for oilfield development scheme optimization and increasing EOR. Based on conventional reservoir geological model building from logging data, a new method is also discussed on constraining the accuracy of reservoir geological model by applying the high resolution cross well seismic data and it has applied to Fan 124 project and a good results has been achieved which it presents a bight future for the cross well seismic technology.

Relevância:

60.00% 60.00%

Publicador:

Resumo:

The dissertation addressed the problems of signals reconstruction and data restoration in seismic data processing, which takes the representation methods of signal as the main clue, and take the seismic information reconstruction (signals separation and trace interpolation) as the core. On the natural bases signal representation, I present the ICA fundamentals, algorithms and its original applications to nature earth quake signals separation and survey seismic signals separation. On determinative bases signal representation, the paper proposed seismic dada reconstruction least square inversion regularization methods, sparseness constraints, pre-conditioned conjugate gradient methods, and their applications to seismic de-convolution, Radon transformation, et. al. The core contents are about de-alias uneven seismic data reconstruction algorithm and its application to seismic interpolation. Although the dissertation discussed two cases of signal representation, they can be integrated into one frame, because they both deal with the signals or information restoration, the former reconstructing original signals from mixed signals, the later reconstructing whole data from sparse or irregular data. The goal of them is same to provide pre-processing methods and post-processing method for seismic pre-stack depth migration. ICA can separate the original signals from mixed signals by them, or abstract the basic structure from analyzed data. I surveyed the fundamental, algorithms and applications of ICA. Compared with KL transformation, I proposed the independent components transformation concept (ICT). On basis of the ne-entropy measurement of independence, I implemented the FastICA and improved it by covariance matrix. By analyzing the characteristics of the seismic signals, I introduced ICA into seismic signal processing firstly in Geophysical community, and implemented the noise separation from seismic signal. Synthetic and real data examples show the usability of ICA to seismic signal processing and initial effects are achieved. The application of ICA to separation quake conversion wave from multiple in sedimentary area is made, which demonstrates good effects, so more reasonable interpretation of underground un-continuity is got. The results show the perspective of application of ICA to Geophysical signal processing. By virtue of the relationship between ICA and Blind Deconvolution , I surveyed the seismic blind deconvolution, and discussed the perspective of applying ICA to seismic blind deconvolution with two possible solutions. The relationship of PC A, ICA and wavelet transform is claimed. It is proved that reconstruction of wavelet prototype functions is Lie group representation. By the way, over-sampled wavelet transform is proposed to enhance the seismic data resolution, which is validated by numerical examples. The key of pre-stack depth migration is the regularization of pre-stack seismic data. As a main procedure, seismic interpolation and missing data reconstruction are necessary. Firstly, I review the seismic imaging methods in order to argue the critical effect of regularization. By review of the seismic interpolation algorithms, I acclaim that de-alias uneven data reconstruction is still a challenge. The fundamental of seismic reconstruction is discussed firstly. Then sparseness constraint on least square inversion and preconditioned conjugate gradient solver are studied and implemented. Choosing constraint item with Cauchy distribution, I programmed PCG algorithm and implement sparse seismic deconvolution, high resolution Radon Transformation by PCG, which is prepared for seismic data reconstruction. About seismic interpolation, dealias even data interpolation and uneven data reconstruction are very good respectively, however they can not be combined each other. In this paper, a novel Fourier transform based method and a algorithm have been proposed, which could reconstruct both uneven and alias seismic data. I formulated band-limited data reconstruction as minimum norm least squares inversion problem where an adaptive DFT-weighted norm regularization term is used. The inverse problem is solved by pre-conditional conjugate gradient method, which makes the solutions stable and convergent quickly. Based on the assumption that seismic data are consisted of finite linear events, from sampling theorem, alias events can be attenuated via LS weight predicted linearly from low frequency. Three application issues are discussed on even gap trace interpolation, uneven gap filling, high frequency trace reconstruction from low frequency data trace constrained by few high frequency traces. Both synthetic and real data numerical examples show the proposed method is valid, efficient and applicable. The research is valuable to seismic data regularization and cross well seismic. To meet 3D shot profile depth migration request for data, schemes must be taken to make the data even and fitting the velocity dataset. The methods of this paper are used to interpolate and extrapolate the shot gathers instead of simply embedding zero traces. So, the aperture of migration is enlarged and the migration effect is improved. The results show the effectiveness and the practicability.