文档视界 最新最全的文档下载
当前位置:文档视界 › 二维泊松方程很基础详细的求解过程

二维泊松方程很基础详细的求解过程

二维泊松方程很基础详细的求解过程
二维泊松方程很基础详细的求解过程

Topic 2: Elliptic Partial Di?erential Equations

Lecture 2-4: Poisson’s Equation: Multigrid Methods

Wednesday, February 3, 2010

Contents

1 Multigrid Methods

2 Multigrid method for Poisson’s equation in 2-D

3 Simple V ?cycle algorithm

4 Restricting the Residual to a Coarser Lattice 2 3

5 7

1 MULTIGRID METHODS

5 Prolongation of the Correction to the Finer Lattice

6 Cell-centered and Vertex-centered Grids and Coarsenings

7 Boundary points

8 Restriction and Prolongation Operators

9 Improvements and More Complicated Multigrid Algorithms

8 8 11 11 15

1 Multigrid Methods

The multigrid method provides algorithms which can be used to accelerate the rate of convergence of iterative methods, such as Jacobi or Gauss-Seidel, for solving elliptic partial di?erential equations.

Iterative methods start with an approximate guess for the solution to the di?erential equation. In each iteration, the di?erence between the approximate solution and the exact solution is made smaller.

One can analyze this di?erence or error into components of di?erent wavelengths, for example by using Fourier analysis. In general the error will have components of many di?erent wavelengths: there will be

short wavelength error components and long wavelength error components.

Algorithms like Jacobi or Gauss-Seidel are local because the new value for the solution at any lattice site depends only on the value of the previous iterate at neighboring points. Such local algorithms are generally more e?cient in reducing short wavelength error components.

The basic idea behind multigrid methods is to reduce long wavelength error components by updating blocks of grid points. This strategy is similar to that employed by cluster algorithms in Monte Carlo simulations of the Ising model close to the phase transtion temperature where long range correlations are important. In fact, multigrid algorithms can also be combined with Monte Carlo simulations.

2 Multigrid method for Poisson’s equation in 2-D

With a small change in notation, Poisson’s equation in 2-D can be written:

? 2u ?x2 +

? 2u

?y2

= ?f (x, y) ,

where the unknown solution u(x, y) is determined by the given source term f (x, y) in a closed region. Let’s consider a square domain 0 ≤ x, y ≤ 1 with homogeneous Dirichlet boundary conditions u = 0 on the perimeter of the square. The equation is discretized on a grid with L + 2 lattice points, i.e., L interior points and 2 boundary points, in the x and y directions. At any interior point, the exact solution obeys

u i,j = 1

4

u i+1,j + u i?1,j + u i,j+1 + u i,j?1 + h2f i,j .

The algorithm uses a succession of lattices or grids. The number of di?erent grids is called the number of multigrid levels . The number of interior lattice points in the x and y directions is then taken to be 2 , so that L = 2 + 2, and the lattice spacing h = 1/(L ? 1). L is chosen in this manner so that the downward multigrid iteration can construct a sequence of coarser lattices with

2?1→ 2?2→ . . . → 20 = 1

interior points in the x and y directions.

Suppose that u(x, y) is the approximate solution at any stage in the calculation, and u exact(x, y) is the exact solution which we are trying to ?nd. The multigrid algorithm uses the following de?nitions:

· The correction

v = u exact? u

is the function which must be added to the approximate solution to give the exact solution. · The residual or defect is de?ned as

r = 2 u + f .

Notice that the correction and the residual are related by the equation

2 v = 2 u exact+ f ? 2 u + f = ?r .

This equation has exactly the same form as Poisson’s equation with v playing the role of unknown function and r playing the role of known source function!

3 SIMPLE V ?CYCLE ALGORITHM

3 Simple V ?cycle algorithm

The simplest multigrid algorithm is based on a two-grid improvement scheme. Consider two grids:

· a ?ne grid with L = 2 + 2 points in each direction, and

· a coarse grid with L = 2?1 + 2 points.

We need to be able to move from one grid to another, i.e., given any function on the lattice, we need to able to

· restrict the function from ?ne → coarse, and

· prolongate or interpolate the function from coarse → ?ne.

Given these de?nitions, the multigrid V ?cycle can be de?ned recursively as follows:

· If = 0 there is only one interior point, so solve exactly for

u1,1 = (u0,1 + u2,1 + u1,0 + u1,2 + h2f1,1)/4 .

· Otherwise, calculate the current L = 2 + 2.

3 SIMPLE V ?CYCLE ALGORITHM

· Perform a few pre-smoothing iterations using a local algorithm such as Gauss-Seidel. The idea is to damp or reduce the short wavelength errors in the solution.

· Estimate the correction v = u exact? u as follows:

– Compute the residual

r i,j = 1

h2 [u i+1,j + u i?1,j + u i,j+1 + u i,j?1? 4u i,j] + f i,j .

–Restrict the residual r → R to the coarser grid.

– Set the coarser grid correction V = 0 and improve it recursively.

–Prolongate the correction V → v onto the ?ner grid.

· Correct u → u + v.

· Perform a few post-smoothing Gauss-Seidel interations and return this improved u.

How does this recursive algorithm scale with L? The pre-smoothing and post-smoothing Jacobi or Gauss- Seidel iterations are the most time consuming parts of the calculation. Recall that a single Jacobi or Gauss-Seidel iteration scales like O(L2). The operations must be carried out on the sequence of grids with

2 → 2?1→ 2?2→ . . . → 20 = 1

interior lattice points in each direction. The total number of operations is of order

L2

n=0

1

22n

≤ L2

1

1 .

1 ? 4

4 RESTRICTING THE RESIDUAL TO A COARSER LATTICE

Thus the multigrid V ?cycle scales like O(L 2), i.e., linearly with the number of lattice points N!

4

Restricting the Residual to a Coarser Lattice

The coarser lattice with spacing H = 2h is constructed as shown. A simple algorithm for restricting the residual to the coarser lattice is to set its value to the average of the values on the four surrounding lattice points (cell-centered coarsening):

6 CELL-CENTERED AND VERTEX-CENTERED GRIDS AND COARSENINGS

R I,J = 1

4[r i,j + r i+1,j + r i,j+1 + r i+1,j+1] , i = 2I ? 1 , j = 2J ? 1 .

5 Prolongation of the Correction to the Finer Lattice

Having restricted the residual to the coarser lattice with spacing H = 2h, we need to solve the equation

2 V = ?R(x, y) ,

with the initial guess V (x, y) = 0. This is done by two-grid iteration

V = twoGrid(H, V, R) .

The output must now be i nterpolated or prolongated to the ?ner lattice. The simplest procedure is to copy the value of V I,J on the coarse lattice to the 4 neighboring cell points on the ?ner lattice: v i,j = v i+1,j = v i,j+1 = v i+1,j+1 = V I,J , i = 2I ? 1, j = 2J ? 1 .

6 Cell-centered and Vertex-centered Grids and Coarsenings

In the cell-centered prescription, the spatial domain is partitioned into discrete cells. Lattice points are de?ned at the center of each cell as shown in the ?gure:

The coarsening operation is de?ned by doubling the size of a cell in each spatial dimension and placing a coarse lattice point at the center of the doubled cell.

Note that the number of lattice points or cells in each dimension must be a power of 2 if the coarsening operation is to terminate with a single cell. In the ?gure, the ?nest lattice has 23 = 8 cells in each dimension, and 3 coarsening operations reduce the number of cells in each dimension

23= 8 → 22= 4 → 21= 2 → 20 = 1 .

Note also that with the cell-centered prescription, the spatial location of lattice sites changes with each coarsening: coarse lattice sites are spatially displaced from ?ne lattice sites.

A vertex-centered prescription is de?ned by partitioning the spatial domain into discrete cells and locating the discrete lattice points at the vertices of the cel ls as shown in the ?gure:

The coarsening operation is implemented simply by dropping every other lattice site in each spatial dimension. Note that the number of lattice points in each dimension must be one greater than a power of 2 if the coarsening operation is to reduce the number of cells to a single coarsest cell. In the example in the ?gure the ?nest lattice has 23 + 1 = 9 lattice sites in each dimension, and 2 coarsening operations reduce the number of vertices in each dimension

23+ 1 = 9 → 22+ 1 = 5 → 21 + 1 = 3 .

The vertex-centered prescription has the property that the spatial locations of the discretization points are not changed by the coarsening operation.

8 RESTRICTION AND PROLONGATION OPERATORS

7 Boundary points

Let’s assume that the outermost perimeter points are taken to be the boundary points. The behavior of these boundary points is di?erent in the two prescriptions:

· Cell-centered Prescription: The boundary points move in space towards the center of the region at each coarsening. This implies that one has to be careful in de?ning the “boundary values” of the solution.

· Vertex-centered Prescription: The boundary points do not move when the lattice is coarsened.

This make i t easier in principle to de?ne the boundary values.

These two di?erent behaviors of the boundary points make the vertex-centered prescription a little more convenient to use in multigrid applications. However, there is no reason why the cell-centered prescription should not work as well.

8 Restriction and Prolongation Operators

In the multigrid method it is necessary to move functions from a ?ne grid to the next coarser grid (Restric- tion), and from a coarse grid to the next ?ner grid (Prolongation). Many prescriptions for restricting and

prolongating functions have been studied. Let’s consider two of the simplest prescriptions appropriate for cell- and vertex-centered coarsening:

· Cell-centered Coarsening: In this prescription, a coarse lattice point is naturally associated with 2d neighboring ?ne lattice points in d-dimensions.

· Suppose that f (x) is a function on the ?ne lattice at spatial position x, and F (X ) is the corresponding function on the coarse lattice, then this diagram suggests a simple prescription for restriction and prolongation.

–Restriction: Average the function values at the 4 neighboring ?ne lattice sites x i:

F (X ) = 1

4

4

i=1

f (x i) .

– Prolongation: Inject the value of the function at the coarse lattice site to the 4 neighboring ?ne lattice sites:

f (x i) = F (X ) , i = 1 . . . 4

· Vertex-centered Coarsening: Consider a coarse lattice point and the 9 neighboring ?ne lattice points shown in the ?gure:

2 2

· In this prescription, a coarse lattice point can naturally associated (in 2-D) with · the corresponding ?ne lattice point, or

· the four nearest neighbor ?ne lattice points, left, right, up, and down, or · with the four diagonally nearest ?ne lattice points, etc.

· It is a little more complicated here to de?ne transfer operators. The problem is that the ?ne lattice points are associated with more than one coarse lattice point, unlike the cell-centered case: – The single red ?ne lattice point in the center coincides with an unique coarse lattice point. – Each of the 4 black ?ne lattice points however is equidistant from two coarse lattic e points. – Each of the 4 red ?ne lattice points is equidistant from four coarse lattice points. · This sharing of lattice points suggests the following prescriptions:

· Prolongation: use bilinear interpolation in which the value of F at a coarse grid point is copied to 9 neighboring ?ne -grid points with the following weights:

1 1 1

1 1

1 1 1 1

.

4 2 4

This matrix is called the stencil for the prolongation.

8 8 9 IMPROVEMENTS AND MORE COMPLICATED MULTIGRID ALGORITHMS

· Restriction: The restriction operator is taken to be the adjoint of the prolongation operator:

1 1 1

1 1 16 1

4 1 8 16 1 1 16

. This choice of restriction operator is called full weighting.

9

Improvements and More Complicated Multigrid Algorithms

The algorithm implemented above is the simplest multigrid scheme with a single V-cycle. Section 19.6 of Numerical Recipes discusses various ways of improving this algorithm:

· One can repeat the two-grid iteration more than once. If it is repeated twice in each multigrid level one obtains a W-cycle type of algorithm.

· The Full Multigrid Algorithm starts with the coarsest grid on which the equation can be solved exactly. It then proceeds to ?ner grids, performing one or more V -cycles at each level along the way. Numerical Recipes gives a program mglin(u,n,ncycle) which accepts the source function ?f in the ?rst argument and implements the full multigrid algorithm with = log 2(n ? 1) levels, performing ncycle V-cycles at each level, and returning the solution in the array parameter u. Note that this program assumes that the number of lattice points in each dimension L is odd, which leads to vertex centered coarsening:

REFERENCES

REFERENCES

References

[Recipes-C19-5] W.H. Press, S.A. Teukolsky, W. Vetterling, and B.P. Flannery, “Numerical Recipes in C”,

Chapter 19 §6: Multigrid Methods for Boundary Value Problems, https://www.docsj.com/doc/d59728019.html,/a/bookcpdf/c19-6.pdf.

随机过程poisson过程 中科大

Poisson 过程 1.考虑电子管中的电子发射问题.设单位时间内到达阳极的电子数目N 服从参数为λ的Poisson 分布,而每个电子携带的能量各自不相关且与N 独立,并均服从于区间[1,2]上的均匀分布.记单位时间内阳极接收的能量为S .求S 的期望和方差. 2.设{X (t ),t ≥0}为一个独立增量过程,且X (0)=0,分别记V (t ),R (t,s )为{X (t ),t ≥0}的方差函数和协方差函数,证明:R (t,s )=V (min {t,s }). 3.设N (t )是一强度为λ的Poisson 过程,s,t >0,试求: (a)P(N (s )=k |N (s +t )=n )=?k =1,...,n ; (b)E[N (s )N (s +t )]=? (c)Cov(N (s ),N (s +t ))=? (d)E[N (s +t )|N (s )]的期望和分布; (e)E[W k |N (t )=n ]=?E[W k ]=?(W k 为第k 个事件发生的时刻) 4.某路口蓝车,白车和黄车的到达分别为强度λ1,λ2和λ3的Poisson 过程,且相互独立.试求:(a)第一辆蓝车到达的平均时间和第一辆车到达的平均时间; (b)蓝车首先到达的概率; (c)蓝车先于黄车但落后于白车的概率; (d)在相继到达的两辆蓝车之间,恰有k 辆车到达的概率以及数学期望; (e)在t 0处观察到一辆黄车,在接下来恰有k 辆蓝车连续到达的概率以及数学期望. 5.设要做的试验的次数服从参数为λ的Poisson 分布,试验有n 个可能的结果,每次试验出现第j 个结果的概率为p j ,∑n j =1p j =1.若各次试验相互独立,并以X j 记第j 个结果发生的次数,试求E[X j ]、Var[X j ],j =1,...,n .又问X j 服从什么分布?且X 1,...,X n 是否相互独立?为什么? 6.某人甲负责订阅杂志.设前来订阅杂志的人数服从强度为6的Poisson 过程,每人分别以概率1/2,1/3,1/6订阅1季,2季,3季杂志,且各人的选择相互独立.现以N i (t )表示(0,t ]时段内订阅i 季杂志的人数,i =1,2,3. 1

数理方程与特殊函数教学大纲

数理方程与特殊函数 课程简介:本课程为电子与通信工程类专业的基础课。学分2,周学时2。本课程由“数学物理方程”与“特殊函数”两大部分组成。“数学物理方程”讲授物理学的一个分支——数学与物理所涉及的偏微分方程。主要介绍物理学中常见的三类偏微分方程及其有关的定解问题和这些问题的几种常用解法。“特殊函数”讲授贝塞尔函数与勒让德多项式,以及如何利用这两种特殊函数来解决数学物理方程的一些定解问题的过程。 教学目的与基本要求:通过数理方程与特殊函数课程的学习,使学生系统的掌握工程数学中数学物理方法的知识和技能,培养学生分析问题解决问题的能力,为后续课程的学习及研究奠定重要的数学基础。本课程的先修课程为:高等数学,复变函数,积分变换 主要教学方法:课堂讲授与课外习题。 第零章预备知识(4学时) 复习先修课程中相关的一些内容,主要包括:二阶线性常微分方程解的结构以及常系数情形解的求法;积分学中的一些重要公式和技巧;傅里叶(Fourier)分析;解析函数的极点及其留数;拉普拉斯(Laplace)变换。 第一章典型方程和定解条件的推导(4学时) 在讨论数学物理方程的求解之前,应建立描述某种物理过程的微分方程,再把一个特定物理现象所具有的具体条件用数学形式表达出来。本章学习的重点和难点是了解数学物

理方程的推导及定解问题的确定过程,学会推导一些简单物理过程的微分方程并能确定某些具体物理现象的定解条件。 第一节基本方程的建立 通过几个不同的物理模型,推导出数学物理方程中的三种典型偏微分方程:波动方程、电磁场方程和热传导方程。 第二节初始条件与边界条件 方程决定了物理规律的数学形式,但具体的物理问题所具有的特定条件也应用数学形式表达出来。用以说明某一具体物理现象的初始状态的条件称为初始条件,用以说明其边界上约束情况的条件称为边界条件。 第三节定解问题的提法 由于每一个物理过程都处在特定的条件之下,所以我们要求出偏微分方程适合某些特定条件的解。初始条件和边界条件都称为定解条件。把某个偏微分方程和相应的定解条件结合在一起,就构成了一个定解问题。 本章习题:3-5题 第二章分离变量法(8学时) 本章主要介绍在求解偏微分方程的定解问题时,如何设法把它们转化为常微分方程来求解。本章学习的重点和难点是掌握分离变量法这一“化繁为简”的典型方法的实质,学会求解常见的定解问题。

数理方程期末试题B答案

北 京 交 通 大 学 2007-2008学年第二学期《数理方程与特殊函数》期末考试试卷(B ) (参考答案) 学院_ ____________ 专业___________________ 班级________ ____ 学号_______________ 姓名___________ __ 一、 计算题(共80分,每题16分) 1. 求下列定解问题(15分) 2. 用积分变换法及性质,求解半无界弦的自由振动问题:(15分) 3. 设弦的两端固定于0x =及x l =,弦的出示位移如下图所示。初速度为零,又没有外力 作用。求弦做横向振动时的位移(,)u x t 。 [ 解 ] 问题的定解条件是 由初始条件可得 4. 证明在变换, x at x at ξη=-=+下,波动方程xx tt u a u 2=具有形式解0=n u ξ,并由此求 出波动方程的通解。 5. 用分离变量法解下列定解问题 [ 提示:1) 可以直接给出问题的固有函数,不必推导;2) 利用参数变易法。] [ 解 ] 对应齐次方程的定解问题的固有函数是x l n π sin ,其解可以表示成 把原问题中非齐次项t x t x f l a l π π22sin sin ),(=按照固有函数展开成级数 因此有 利用参数变易法,有 于是 6. 用Bessel 函数法求解下面定解问题 [ 解 ] 用分离变量法求解。令)()(),(t T R t u ρρ=,则可得

以及 设0ρβλn n = 为Bessel 函数)(0x J 的正零点,则问题(II )的特征值和特征函数分别为 问题(I )的解为 于是原问题的解是 由初始条件 得到 故 于是最后得到原问题的解是 二、 证明题(共2分,每题10分) 7. 证明平面上的Green 公式 其中C 是区域D 的边界曲线,ds 是弧长微分。 [证明] 设),(),,(y x Q y x p 在D+C 上有一阶连续偏导数,n 为C 的外法线方向,其方向余弦为βαcos ,cos ,则有 再设u,v 在D 内有二阶连续偏导数,在D+C 上有一阶连续偏导数,令 得到 交换u,v ,得到 上面第二式减去第一式,得到 证毕。 8. 证明关于Bessel 函数的等式:

泊松过程与泊松分布的基本知识

泊松过程与泊松分布的基本知识泊松过程是随机过程的一个经典模型,是一种累积随机事件的发生次数的独立增量过程。也就是说,每次事件的发生是相互独立的。那么泊松分布和泊松过程又什么关系呢?可以说泊松分布是描述稀有事件的统计规律,即可以描述一段时间内发生某个次数的概率。而泊松过程呢,就适合刻画“稀有事件流”的概率特性。 比较:泊松分布 泊松过程的主要公式: 其实没多少不一样对不对?不一样的是泊松过程是一个可以查看在时间t内发生次数的概率,这个t是可变的。泊松分布则是给定了时间。 泊松过程的关键在于,它的到达间隔序列Tn,即每两次发生的时间是服从的独立同指数分布的。如果每次发生的间隔时间不服从指数分布,那么这个随机过程就会更一般化,我们成为是更新过程,这也是随机过程的推广。 泊松过程分为齐次泊松过程和非齐次泊松过程,齐次的意思很简单,就是说过程并不依赖于初始时刻,强度函数是一个常数,从上面的公式也看得出来。而非齐次则是变成了,这意味着什么呢?这以为着随着与时间的改变,强度是会改变的,改变服从强度函数,说了这

么久,强度究竟是个什么概念?强度的意思就是泊松过程的该事件发生的频率,或者说快慢,泊松分布中我们知道期望就是,实际含义就是,在一段时间内,发生的次数平均水平是次。 复合泊松过程:泊松过程我们已经知道,用描述一段时间累积发生的次数,但是如果每次发生带来的后果都是不一样的,我们怎么描述这个过程呢?比如,火车站到达的乘客是服从泊松过程的,但是每个乘客携带有不同重量的行李,我们如何刻画在[0,t]时间内行李总重量呢,这个过程就是复合泊松过程。复合泊松过程的均值函数和方差函数一般可以用全期望和全方差公式进行计算,因为简单泊松过程的期望很容易求。 更新过程: 上文已经说到,更新过程作为泊松过程的推广,更具有一般性,那么在讨论更新过程时,我们更多地讨来更新函数,更新函数是更新过程的均值函数m(t)=E[N(t)],怎么理解呢,就是说需要用t时刻的累积计数的期望特性来表达更新过程。有一条定理: 这个定理是可以证明的,Fn(t)是分布函数,就是说:在t时刻,更新函数值就是在这个时刻,n取遍所有值的分布之和。 那么是否可以这样理解,更新过程和泊松过程的区别就是更新间隔序列不同,那么如果已知了更新间隔序列的概率密度函数,就可以求解该过程的更新函数了,详细的推导就不写了。扔结论出来:对间隔序列概率密度函数做拉氏变换得到Lf(s),然后求 Lm(s)=Lf(s)/s(1-Lf(s)),再对Lm(s)进行逆变换,就得到了m(t),这就是更新函数。

MATLAB编程求解二维泊松方程

%%%% 真解 u=sin(pi*x)*sin(pi*y) %%% %%%% 方程 -Laplace(u)=f %%%%%% %%%% f=2*pi^2*sin(pi*x)*sin(pi*y) %%%%%% %%%%difference code for elliptic equations with constant coefficient %%%%% %clear all %clc N=20; h=1/N; S=h^2; x=0:h:1; y=0:h:1; %%% Stiff matrix A=zeros((N-1)^2,(N-1)^2); for i=1 A(i,i)=4/h^2; A(i,i+1)=-1/h^2; A(i,i+(N-1))=-1/h^2; end for i=N-1 A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,2*i)=-1/h^2; %A(i,i+(N-1))=-1/h^2 end for i=(N-2)*(N-1)+1 A(i,i-(N-1))=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; end for i=(N-1)^2 A(i,i-(N-1))=-1/h^2; A(i,i)=4/h^2; A(i,i-1)=-1/h^2; end for n=2:N-2 i=(N-2)*(N-1)+n; A(i,i-(N-1))=-1/h^2; A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; end for i=2:N-2

A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; A(i,i+(N-1))=-1/h^2; end for m=1:N-3 i=m*(N-1)+1; A(i,i-(N-1))=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; A(i,i+(N-1))=-1/h^2; end for m=2:N-2 i=m*(N-1); A(i,i-(N-1))=-1/h^2; A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,i+(N-1))=-1/h^2; end % for m=1:N-3 % i=m*(N-1)+(N-1); % A(i,i-(N-1))=-1/h^2; % A(i,i-1)=-1/h^2; % A(i,i)=4/h^2; % A(i,i+(N-1))=-1/h^2; % end for m=1:N-3 for n=2:N-2 i=m*(N-1)+n; A(i,i-(N-1))=-1/h^2; A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; A(i,i+(N-1))=-1/h^2; end end %%% Right term F=zeros((N-1)^2,1); for m=0:N-2 for n=1:N-1 i=m*(N-1)+n;

数理方程与特殊函数试卷 3套

2010年6月 一、填空题(20分) 1、微分方程的固有值为 ____________,固有函数为____________。 2、勒让德多项式的母函数为________________________。 3、一长为的均匀直金属杆,x=0端固定,x=l端自由,则纵向震动过程中的边界条件为 ________________________。 4、二阶线性偏微分方程属于____________型方程。 5、微分方程,在条件下的拉氏变换表 达式为____________________________________。 6、埃尔米特多项式的微分表达式为____________________________________。 7、函数是区域内的调和函数,它在上有一阶连续偏导数,则 ____________. 8、定解问题的解为________________________。 9、在第一类奇次边界条件下=____________。 10、=____________,=____________。 二、证明题(10分) 三、建立数学物理方程(10分) 一长为l、截面积为s、密度为、比热容为的均匀细杆,一端保持零度,另一端有恒定的热量q流入,初始温度为试建立热传导方程,写出定界条件(要有必要的步骤)。四、写出下列定解问题的解(35分) 1、

2、 3、 五、将函数展开为广义傅里叶级数(25分) 1、设是的正零点,试将函数展开成的傅里叶贝塞尔级数。 2将函数按埃尔米特多项式展开成级数。 2009年6月 一、填空题(20分) 11、微分方程的固有值为 ____________,固有函数为____________。 12、勒让德多项式的母函数为________________________。 13、一长为的均匀直金属杆,x=0端温度为零,x=l端有恒定的热流流出,则热传导过 程中的边界条件为________________________。 14、二阶线性偏微分方程属于____________型方程。 15、微分方程,在条件下,其拉氏 变换表达式为____________________________________。 16、埃尔米特多项式的微分表达式为____________________________________。 17、函数是区域内的调和函数,它在上有一阶连续偏导数,则 ____________. 18、定解问题的解为 ________________________。 19、在第一类奇次边界条件下=____________。 20、=____________,=____________。 二、证明题(10分)

泊松过程

泊松过程 一种累计随机事件发生次数的最基本的独立增量过程。例如随着时间增长累计某电话交换台收到的呼唤次数,就构成一个泊松过程。 泊松过程是由法国著名数学家泊松(Poisson, Simeon-Denis)(1781—1840)证明的。 1943年C.帕尔姆在电话业务问题的研究中运用了这一过程,后来Α.Я.辛钦于50年代在服务系统的研究中又进一步发展了它。 Poisson过程(Poisson process,大陆译泊松过程、普阿松过程等,台译卜瓦松过程、 布瓦松过程、布阿松过程、波以松过程、卜氏过程等),是以法国数学家泊松(1781 - 1840) 的名字命名的。泊松过程是随机过程的一种,是以事件的发生时间来定义的。我们说一个 随机过程N(t) 是一个时间齐次的一维泊松过程,如果它满足以下条件: 在两个互斥(不重叠)的区间内所发生的事件的数目是互相独立的随机变量。 在区间内发生的事件的数目的概率分布为: 其中λ是一个正数,是固定的参数,通常称为抵达率(arrival rate)或强度(intensity)。 所以,如果给定在时间区间之中事件发生的数目,则随机变数呈现泊松分布,其参数为。 更一般地来说,一个泊松过程是在每个有界的时间区间或在某个空间(例如:一个欧几里得平面或三维的欧几里得空间)中的每一个有界的区域,赋予一个随机的事件数,使得?在一个时间区间或空间区域内的事件数,和另一个互斥(不重叠)的时间区间或空间区域内的事件数,这两个随机变数是独立的。 ?在每一个时间区间或空间区域内的事件数是一个随机变数,遵循泊松分布。(技术上而言,更精确地来说,每一个具有有限测度的集合,都被赋予一个泊松分布的随机变数。)

MATLAB编程求解二维泊松方程doc资料

M A T L A B编程求解二维 泊松方程

%%%% 真解 u=sin(pi*x)*sin(pi*y) %%% %%%% 方程 -Laplace(u)=f %%%%%% %%%% f=2*pi^2*sin(pi*x)*sin(pi*y) %%%%%% %%%%difference code for elliptic equations with constant coefficient %%%%% %clear all %clc N=20; h=1/N; S=h^2; x=0:h:1; y=0:h:1; %%% Stiff matrix A=zeros((N-1)^2,(N-1)^2); for i=1 A(i,i)=4/h^2; A(i,i+1)=-1/h^2; A(i,i+(N-1))=-1/h^2; end for i=N-1 A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,2*i)=-1/h^2; %A(i,i+(N-1))=-1/h^2 end for i=(N-2)*(N-1)+1 A(i,i-(N-1))=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; end for i=(N-1)^2 A(i,i-(N-1))=-1/h^2; A(i,i)=4/h^2; A(i,i-1)=-1/h^2; end for n=2:N-2 i=(N-2)*(N-1)+n; A(i,i-(N-1))=-1/h^2; A(i,i-1)=-1/h^2; A(i,i)=4/h^2; A(i,i+1)=-1/h^2; end

数学物理方程与特殊函数课后答案

29.0(,)11 cos , sin (,)(cos ,sin ),cos sin ; sin cos . sin cos ;s xx yy rr r r x y x y x r y laplace u u r u u u r r x r y r u x y u r r u u u u r u r u u u u r u θθθθθθ θθθθθθθθθ+=++==??=?∴==+??? =?+??=??=∵ 证明方程在极坐标下为 证明: sin cos ;cos cos in .sin .sin ()cos () sin sin cos cos r xx x r r u u r y r r u u u x x r r x u u r r r r θθθθθθθθθθθθθθθθθθ???????=??????????????? ???????+=+?????????? ? ?????? ?==????????? ?????? ??=???????????? 从而 2222222222222 sin cos sin cos sin cos sin cos sin cos sin .cos ()sin () sin yy u u u u r r r r r r u u u r r r r u u u y y r r y θθθθθθθθ θθθθθθθθθθθ?????? ?=+ ?+?????????++???????????==+?????????= 2222 22 2222222 cos cos sin sin cos sin cos cos sin sin cos sin cos cos .1u u r r r r u u u u r r r r r r u u u r r r r u u u u θθθθθθθθθθθθθθ θθθθθθθθ ????? ???++???????????? ????=?++????????+?+????+=+ 所以 1 0. u +=

泊松过程

作者:BUG生成器 来源:知乎 ·从一个生活的例子中引出泊松过程 愉快的暑假结束了,同学们陆陆续续来到学校。在开学当天的上午,学校教导主任开始站在学校门口计数到达学校的同学的个数,每分钟计数一次(单位时间),可能是开学第一天比较清闲,顺便观察一下同学们的精神面貌。 通常在一个短暂的时间段内,单位时间到达学校的人数的数学期望应该是一致的。这是很容易理解的,毕竟这是一个学生人数众多的学校,在教导主任站在门口的这几个小时内到达学校的人数,相比较学校的总人数是微不足道的,也就是说,这一分钟到达学校人数的期望和下一分钟到达学校的人数的期望是相同的。 同时,对于某一分钟(单位时间),某一个学生在这一分钟到达学校的概率也是相同的,两个同学互不相关,在满足学校到校时间要求的前提下,他们到达学校的时间是自由的。并且假设每个学生在一分钟内到达学校的概率为P。 这个时候就可以定义随机变量了,假设有n个随机变量,它表示

也就是每个学生都有一个独立的状态,可以是1或者是0,这些所有随机变量加起来就是自观察记录以来到达学校的总人数。 可以看出对于一个确定的时刻t,所有随机变量的和——假设是X,它的概率模型就是比较常见的二项分布。 为什么会是二项分布呢,可能用这种所有学生相互独立的描述方法不易直观理解,那么我们可以这样想,在这样一个确定的时刻,依次询问这个学校所有的学生(不管他有没有到校)有没有到校,那么获得“这个学生已经到校”这个信息的概率是p,“这个学生还

没有到校”的概率是1-p。拿出来一个学生询问就好比做了一次实验,这个实验的结果(这个结果是从开始到时刻t的整个过程决定的,注意理解)为1就计数+1,为0就不计数。 那么现在就可以根据二项分布的概率模型写出随机变量X的分布函数

泊松过程

第二讲 泊松过程 1.随机过程和有限维分布族 现实世界中的随机过程例子: 液体中,花粉的不规则运动:布朗运动;股市的股票价格; 到某个时刻的电话呼叫次数; 到某个时刻服务器到达的数据流数量,等。 特征:都涉及无限多个随机变量,且依赖于时间。 定义(随机过程) 设有指标集T ,对T t ∈都有随机变量)(t X 与之对应,则称随机变量族 }),({T t t X ∈为随机过程。 注 一个随机过程是就是一个二元函数E T t X →?Ωω:),(。固定ω,即考虑某个事件相 应的随机变量的值,得到函数R T t X →:),(ω称为样本函数或轨道或一个实现。映射的值域空间E 称为状态空间。 例 随机游动(离散时间,离散状态) 质点在直线上每隔单位时间位置就发生变化,分别以概率p 或概率p -1向正或负向移动一个单位。如果以n S 记时刻n 质点所处的位置,那么就得到随机过程{,0}n S n ≥。这里指标集},1,0{ =T ,状态空间},1,0,1,{ -=E 。 如果记n X 为时刻n ,质点的移动,那么{,1}n X n ≥也是随机过程。 两个过程的区别:{}n S 不独立;{}n X 独立; 两个过程的关系:01 n n k k S S X ==+ ∑ 习题 计算n ES 和n DS (设00S =)。 提示 利用∑== n k k n X S 1 ,其中k X 是时刻k 的移动方式。 习题 设从原点出发,则()/2()/2()/2 ,2()0, 21n k n k n k n n C q p n k i P S k n k i +-+?+===?+=-?。 例 服务器到达的数据流(连续时间,离散状态) 在],0[t 内,到达服务器的数据包个数记为)(t N ,那么}0),({≥t t N 也是个随机过程, 其指标集}{+ ∈=R t T ,状态空间},1,0{ =E 。

泊松过程

一个基本的独立增量过程,用于累积随机事件的发生时间。例如,随着时间的推移累积电话交换机接收的呼叫数量就构成了泊松过程。 法国著名数学家泊松(1781-1840)证明了泊松过程。1943年,C。Pahlm将这一过程应用到电话服务的研究中,后来又应用于α。я。1950年代,辛勤在服务系统研究中进一步发展了它。法国数学家Poisson于1781年6月21日出生于法国卢瓦尔河,于1840年4月25日去世,死于法国苏富比镇。 1798年,他进入巴黎综合科学与工程学院深造。毕业后,他以出色的研究论文被任命为讲师。由p.-s赞赏。拉普拉斯和j.l.拉格朗日。1800年毕业后,他留校任教,1802年成为副教授,并接替了J.-B.-J.傅里叶于1806年担任教授。1808年,他是法国经度局的天文学家,1809年,他是巴黎科学研究所的力学教授。1812年,他当选为巴黎科学院院士。 泊松的科学生涯始于对微分方程的研究及其在摆运动和声学理论中的应用。他的工作特征是运用数学方法研究各种机械和物理问题,并获得数学发现。他为积分理论,行星运动理论,热物理学,弹性理论,电磁理论,势能理论和概率论做出了重要贡献。 对于泊松过程,通常认为每个样本函数都是一个左跳(或右跳)连续

阶跃函数,其跳跃为1。可以证明具有此属性的样本函数的随机连续独立增量过程必须是泊松过程,因此,泊松过程是描述随机事件累积发生时间的基本数学模型之一。凭直觉,只要随机事件在不相交的时间间隔内独立发生并且在足够小的间隔内仅发生一次,则它们的累积时间就是一个泊松过程。这些条件在许多应用中都可以满足。例如,某个系统在时间段[0,t]中的故障数和在真空管加热t秒钟后阴极发射的电子总数可以被认为是泊松过程。 描述随机事件的累积发生时间的过程通常称为计数过程(请参阅点过程)。还可以通过依次跳转的时间{Tn,n≥1}定义简单的局部计数过程{X(t),t≥0},即T0 = 0,Tn = inf {t:X(t)≥n},n≥1,并且当TN

数学物理方程与特殊函数期末考试试题卷子2011

XXXXX 大学研究生试卷 (考试时间: 至 ,共 2小时) 课程名称 数理方程与特殊函数 教师 学时60 学分 3 教学方式 闭卷 考核日期 2011年 12 月 28 日 成绩 1.化方程2220xx xy yy x y x u xyu y u xu yu ++++=为标准形. (10分) 2. 把定解问题:(10分) 212(0)(0,)(),(,)() (,0)(),(,0)(),(0) tt xx x x t u a u x l u t h t u l t h t u x x u x x x l ?ψ?=<

3.有一带状的均匀薄板(0x a ≤≤,0y ≤<+∞), 边界0y =上的温度为0u ,其余边界上的温度保持零度,并且当y →+∞时,温度极限为零. 求解板的稳定温度分布. (用分离 变量法求解).(20分) 4.求下面的定解问题:(10分) 090,(,0) 0,sin tt xx t t t u u x R t u u x ==-=∈>??? ==??. 第2页

5.求()2 1,1 (),()0,1 x x F f x f x x ?-≤?=?>??,其中()F ?表示Fourior 变换.(10分) 6.求()2(),()sin(),03 L f t f t t t π =-≥,其中()L ?为Laplace 变换.(10分) 第3页 学 号 姓 名 学 院 教师 座位号 ……………………密……………封……………线……………以……………内……………答……………题……………无……………效……………………

五点差分格式求解泊松方程的第一边值问题(可编辑)

五点差分格式求解泊松方程的第一边值问题(可编辑)五点差分格式求解泊松方程的第一边值问题 摘要:给出了二维泊松方程在单位正方形上的五点差分格式。并运用线性方程组的古典迭代解法??Jacobi迭代求解出在区域上的数值解。最终绘制数值解的图形。 关键字:泊松方程五点差分格式 Jacobi迭代 有限差分法的介绍 有限差分法是求解偏微分方程的主要数值解法之一;其基本思想是把连续问题离散化,即对求解区域做网格剖分,用有限个网格点代替连续区域;其次将微分算子离散化,从而把微分方程组的问题化为线性方程组的求解问题,解方程组就可以得到原问题在离散点上的近似解。 差分法的步骤:1 对求解域做网格剖分 2 插值函数的选择 3 方程组的建立 4 方程组的求解 五点差分格式的构造 二维泊松方程: 在单位正方形上,在正方形边界上的边界条件.在正方形网格上,就是在上离散化,.对于N3如图1所示: 图1 沿方向分别用二阶中心差商代替 2.1 2.2

1、2式相加可得差分方程: 2.3 利用Taylor展式 可得差分算子的截断误差 其中是方程2.3的光滑解。 由于差分方程2.3中只出现在及其四个邻点上的值见图1的中间的粗的点,所以称为五点差分格式。 由边界条件知道,因而2.3式确定了一组具有个未知量的个线性方程。对应的系数矩阵为对称、不可约对角占优,且对角元为正,因而系数矩阵非奇异,且为对称正定阵。 三、方程组的求解 我们已经知道,利用差分方法解椭圆型方程边值问题归结为解大型线性代数方程组的问题。因为差分格式产生的大型线性代数方程组的系数矩阵中非零元素占的比例小,分布很有规律性。而且通过数值线性代数的学习,我们知道对于大型的稀疏矩阵来说,迭代法是比较好的选择,其程序实现比较简单,迭代过程能自动校正计算过程中的偶然误差,要求计算机的存储相对较少。 本文采用了线性方程组古典迭代解法??Jacobi迭代求解由五点差分格式得到的线性方程组。以下对Jacobi迭代作简要的介绍: 给定3.1 令3.2 其中 3.3 那么3.1可以写成,3.4 其中.若给定初始向量,并代入3.4的右端,就可以计算出一个新的向量,即,

二维泊松方程很基础详细的求解过程

Topic 2: Elliptic Partial Di?erential Equations Lecture 2-4: Poisson’s Equation: Multigrid Methods Wednesday, February 3, 2010 Contents 1 Multigrid Methods 2 Multigrid method for Poisson’s equation in 2-D 3 Simple V ?cycle algorithm 4 Restricting the Residual to a Coarser Lattice 2 3 5 7

1 MULTIGRID METHODS 5 Prolongation of the Correction to the Finer Lattice 6 Cell-centered and Vertex-centered Grids and Coarsenings 7 Boundary points 8 Restriction and Prolongation Operators 9 Improvements and More Complicated Multigrid Algorithms 8 8 11 11 15 1 Multigrid Methods The multigrid method provides algorithms which can be used to accelerate the rate of convergence of iterative methods, such as Jacobi or Gauss-Seidel, for solving elliptic partial di?erential equations. Iterative methods start with an approximate guess for the solution to the di?erential equation. In each iteration, the di?erence between the approximate solution and the exact solution is made smaller. One can analyze this di?erence or error into components of di?erent wavelengths, for example by using Fourier analysis. In general the error will have components of many di?erent wavelengths: there will be

应用随机过程实验2-泊松过程

应用随机过程实验2 —泊松过程 一.准备知识 1.泊松过程 2.非齐次泊松过程 3. 复合泊松过程 二.作业 1. 设()1X t 和()2X t 分别是参数为1λ和2λ的相互独立的泊松过程, (1)模拟()1X t 和()2X t ,并画图; (2)生成随机过程()()()12Y t =X +X t t ,并画图; (3)计算(){}Y t ,t 0≥ 的平均到达率与+1λ2λ的相对误差。 2. 设到达某商店的顾客组成强度为λ的泊松过程,每个顾客购买商品的概率为p ,且与其他顾客是否购买商品无关,假设每位购买商品的顾客的花费i X 独立同分布,且服从正态分布2X (,)i N μσ:,1,2,3,i =L ,令()Y t 是t 时刻购买商品的顾客数,()Z t 是t 时刻商品的营业额,0t ≥ , (1)试模拟随机过程(){},0Y t t ≥,并画图,计算随机过程(){},0Y t t ≥ 的均值函数与pt λ的相对误差; (2)试模拟随机过程(){},0Z t t ≥,并画图,计算随机过程(){}t ,t 0Z ≥ 的均值函数与pt λμ的相对误差。

3. 某路公共汽车从早晨5时到晚上9时有车发出,乘客流量如下:5时按平均乘客为200人/小时计算;5时至8时乘客平均到达率线性增加,8时到达率为1400人/小时;8时至18时保持平均到达率不变;18时到21时到达率线性下降,到21时为200人/小时,假定乘客数在不重叠的区间内是相互独立的,令()X t 是t 时刻到达公共汽车的总人数, (1)计算早晨5时到晚上9时的乘客到达率,并画图; (2)模拟从早晨5时到晚上9时的乘客到达过程(){}X t ,t 0≥。

研究生数理方程与特殊函数考题2014

科技大学研究生试卷 (考试时间: 至 ,共 2小时) 课程名称 数理方程与特殊函数 教师 学时60 学分 3 教学方式 闭卷 考核日期 2014年 12 月 日 成绩 考核方式: (学生填写) 1.化简方程22222 (,)(,)(,) 1280u x y u x y u x y x x y y ???++=????并求其通解. (10分) 2. 设有一长度为L 的均匀细棒,其侧面和两端均绝热,初始温度分布为已知。(1)求以后时刻的温度分布;(2)证明:当初始温度分布为常数时,以后时刻的温度分布也必为常数. (20分) 第 1页 3.求解定解问题:(15分) 学 号 姓 名 学 院 教师 座位号 ……………………密……………封……………线……………以……………内……………答……………题……………无……………效……………………

200000 (0,0),t xx x x l t u a u x l t q u u u k u u ===?=<<>? ? ==?? ?=?,00,,,a u k q 均为常数. 4.求函数()() 2 1 ()13f s s s =+- 的Laplace 逆变换.(10分) 第2页 5.求下面的定解问题:(15分) 号 效……………………

2 00,(,0) ,sin tt xx t t t u a u x at x R t u x u x ==?-=+∈>?? ==??. 6.求3()J x dx ? .(10分) 第3页 7.写出平面第一象限的Dirichlets 问题对应的Green 函数及其定解问题.(10分)

随机过程期末复习题

随机过程期末复习题库(2015) 一、填空题 1.对于具有常数均值的二阶矩过程,为宽平稳过程当且仅当二元函 数只与有关, 而与和无关。 2.对于具有常数均值的二阶矩过程,为宽平稳过程当且仅当二元函 数只与有关, 而与和无关。 3.设随机变量服从泊松分布,且,则 2 . 4.已知随机变量的二阶矩存在,且的矩母函数为,则. 5.已知随机变量的二阶矩存在,且的特征函数为,则 . 6.设是平稳序列,其协方差函数为,请给出的均值具有遍 历性的一个充分条件:. 7.设是平稳过程,其协方差函数为,请给出的均值具有遍历性 的一个充分条件:. 8.已知平稳过程的均值,协方差函数为,则该过程的自相关函数 . 9.设为两个随机事件,,则 0.6 . 10.设为二随机变量,,则 2 . 11.已知随机变量的矩母函数为,则服从的分布是参数为的 泊松分布. 12.是二维正态分布,即,. 13.设随机变量的数学期望均存在,则. 14.为随机事件,随机变量的数学期望存在,则 . 15.在强度为的泊松过程中,相继事件发生的间隔时间是相互独立的随机变量,且服从均 值为的同一指数分布. 16.设是强度为的泊松过程,表示第个事件发生的时刻,则的分布函 数为. 17.设是强度为的泊松过程,表示第个事件发生的时刻,则. 18.设是强度为的泊松过程,表示第个事件发生的时刻,则

. 解由定理3.2.3,在已知的条件下,事件发生的个时刻的条件联合分布函数与个在区间上相互独立同均匀分布的随机变量的顺序统计量的联合分布函数相同.故对,有 从而, 19.是强度为的泊松过程,表示第个事件与第个事件发 生的时间间隔.则. 解题思路:注意到与独立,且同服从参数为的指数分布即得. 20.设,是速率为的泊松过程. 则对于, . 21.设,是速率为的泊松过程. 对于, . 解对于,有 增量与独立 22.是强度为的泊松过程,表示第个事件与第个事件发 生的时间间隔.则对,. 解题思路:注意到与独立,且同服从参数为的指数分布即得. 23.设是强度为的泊松过程,表示第个事件与第个事件发 生的时间间隔,则. 24.设是强度为的泊松过程,表示第个事件发生的时刻,则 . 25.设是强度为的泊松过程,表示第个事件发生的时刻,则服从参 数为和的分布. 26.非齐次泊松过程,其强度函数为,则 . 解对于,有

随机过程第三章 泊松过程

第三章 泊松过程 3.1 泊松过程 定义3.1 计数过程:随机过程{}(),0N t t ≥称为一个计数过程,若()N t 表示从0到时 刻t 为止某一事件A 发生的总数,它是一个状态取非负整数、时间连续的随机过程。计数过程满足以下条件: (1)()0N t ≥,且取值非负整数; (2)若s t <,则()()N s N t <; (3)对于s t <,()()N t N s -表示时间区间(,]s t 内事件A 发生的次数。 如果在不相交的时间区间中发生的事件个数是独立的,则称计数过程有独立增量过程。如时刻t 已发生的事件A 的次数即()N t ,必须独立于时刻t 和t s +之间所发生的事件数即 (()())N t s N t +-。 如果在任一时间区间内发生的事件A 的次数的分布只依赖于时间区间的长度,则称计数过程为平稳增量过程。即对一切12t t <及0s >,在区间12(,]t s t s ++中事件A 的发生次数即21(()())N t s N t s +-+与区间12(,]t t 中事件A 的发生次数即21(()())N t N t -具有相同的分布,则过程有平稳增量。 泊松过程是计数过程的最重要类型之一,其定义如下。 定义3.2 泊松过程:计数过程{}(),0N t t ≥称为参数为λ(0λ>)的泊松过程,如果满 足: (1)()0N t =; (2)过程有独立增量; (3)在任一长度为t 的区间中事件的个数服从均值为t λ的泊松分布。即对一切s ,0t ≥, {}()(),0,1,2,! n t t P N t s N s n e n n λλ-+-=== 从条件(3)可知泊松过程有平稳增量且[()]E N t t λ=,于是可认为λ是单位时间内发生事件A 的平均次数,一般称λ是泊松过程的强度或速率。 为确定一个任意的计数过程是泊松过程,必须证明它满足上述三个条件。其中,条件

A-2005级-数理方程与特殊函数B卷

课程编号: 北京理工大学2006-2007学年第二学期 2005级数学物理方程期末试题(B 卷) 班级_______________学号_______________姓名______________成绩_____________ 一、填空(请写在答题纸上,每题5分,共计40分) 1. 设弦一端在0x =处固定,另一端在x l =处做自由运动。则弦振动问题的 边界条件为:________________________________。 2. 边界为Γ的区域Ω上函数u 的第二类边界条件为__________________ 。 3. 三维泊松方程是______________________________。 4. 极坐标下的二维拉普拉斯方程为__________________________。 5. 定解问题2 02||0tt xx t t t u u x u x u ===-∞<<+∞ ???==??, ,的解__________________________。 6. 三维拉普拉斯方程的牛曼内问题为______________________________; 其解存在的必要条件为____________。 7. 设2()J x 为2阶贝塞尔函数,则2 2()d x J kx dx ????=__________________。 8. 写出4阶贝塞尔方程的标准形式_____________________________。 二、(10分)求解定解问题: 200(0)()00()0.t xx x x u a u x l t u t u l t t u x x x l ?=<<>? ==≥??=≤≤? , ,, ,,, , ,0,

相关文档
相关文档 最新文档