Science topic
Finite Difference - Science topic
Explore the latest questions and answers in Finite Difference, and find Finite Difference experts.
Questions related to Finite Difference
I've done this, but the results don't make sense. I want to run it for high Reynolds numbers, like 10000, and eventually calculate the energy spectrum, but the results are not reasonable. Could you help me with this?"
Consider the advection-diffusion equation ∂/∂t U + ∂/∂x F(U) = ∂/∂x ( D(U) * ∂/∂x U ). I know that on uniform grids we can use central differences to approximate the advection term as
∂/∂x F(U) |_{i} = ( F(U)|_{i+1} - F(U)|_{i-1} ) / Δx + O(Δx^2),
and the diffusion term as
∂/∂x ( D(U) * ∂/∂x U ) |_{i} = ( D(U)|_{i+1} + D(U)|_{i} ) * ( U|_{i+1} - U|_{i} ) / (2 * Δx^2) - ( D(U)|_{i} + D(U)|_{i-1} ) * ( U|_{i} - U|_{i-1} ) / (2 * Δx^2) + O(Δx^2).
I was wondering if we have second order formulas similar to these for a non-uniform grid, where Δx |_{i} is different than Δx |_{i+1}. I found some works for the advection term, but none for the diffusion one. Is it even possible? Would you provide references? Thank you!
There is a problem of constructing a PINN based on an integro-differential equation in Tensorflow. Its simplified form is shown on the picture. The function h has no analytical solution. The differential part is calculated quickly with AutoDiff, but there is a problem with the integral part. In the full formulation, I need to calculate several double and triple integrals. I calculate them by finite differences, which makes the calculation slow down a lot. Is there any way to get away from finite-difference integration in the problem shown in the picture? I would be grateful for a hint or an example of a similar solution.
Consider a person who has never heard of symplectic Euler but knows about Initial Value Problems, forward Euler, backward Euler, and Taylor series. Say, you are required to give them an idea of what the symplectic Euler method is in a short manner only for the case of a typical initial value problem of the second order. Would the attached illustration be acceptable?
Or would it create confusion that it is a combination of forward Euler and backward Euler?
*If you think the question has already been answered. Don’t leave it. Please leave a response since I’d like to hear as many responses as possible.
My question is that how we can evaluate the real and imaginary part of impedance of a THz absorber by using the finite difference time domain (FDTD) simulation software.
I have some nonlinear PDEs that I wish to solve numerically. My initial stab at the solution seems to be very naive. I discretised the PDE using finite differences, and this leaves me with a set of nonlinear algebraic equations at each time step. To my simplistic mind, I can solve these using the Newton-Raphson method.
I tried this method and I can't get the solution to converge for some reason. Was my idea wrong from the outset?
I wonder HEC-RAS 2D Only uses "Finite Difference" mothod for solving the equations or it may utilize other numerical methods (Such as "Finite Volume", etc.) for this purpose?
I intend to use analytic derivatives for solving a low thrust trajectory optimization problem via indirect optimal control. Finite difference derivatives are not accurate enough to achieve convergence. In literature, it is mentioned that state transition matrix can be used with chain rule to obtain required analytic partial derivatives. But implementation details are missing.
I am looking for some examples, where it is in action. Any relevant pointers are highly appreciable.
Considering the dynamic characteristics of energy systems, such as gas network and district heating network, we often use partial differential equations to discribe them, then solve them by Euler finite difference technique. While in the state estimation, how to deal with the states of the new nodes added by the difference technique?
Please, how can I use the Newmark method in time in conjunction with the finite central difference in space for the Euler Bernoulli beam equation using Matlab or C (I'm a beginner, and don't have many skills in Matlab or C)?
Hi
I'm solving nonlinear second order equation by using finite difference method . finally for calculating value at any desired node, knowing three preceding nodes is required however by knowing boundary condition just one of these nodes becomes obvious and still knowing two other values is necessary. it must be noted there are plenty of guesses for values of these nodes which lead to compatible response.
I've been using GMAT in my free time to optimize trajectories, and have varied burn component values and spacecraft states, usually with success. The vary command in GMAT, with the Yukon optimizer that I am using, has the following parameters that can be changed:
- Initial value: The initial guess. I know the gradient descent optimization method that GMAT uses is very sensitive to initial conditions and so this must be feasible or reasonably close.
- Perturbation: The step size used to calculate the finite difference derivative.
- Max step: The maximum allowed change in the control variable during a single iteration of the solver.
- Additive scale factor: Number used to nondimensionalize the independent variable. This is done with the equation xn = m (xd + a), where xn is the non-dimensional parameter, xd is the dimensional parameter and this parameter is a.
- Multiplicative scale factor: Same as above, but it's the variable d in the equation.
For the initial value, I can usually see when my chosen value is feasible by observing the solver window or a graphical display of the orbit in different iterations. The max step is the most intuitive of these parameters for me, and by trial and error, observation of the solver window and how sensitive my target variables are to changes in the control variables I can usually get it right and get convergence. It is still partially trial and error though.
However, I do not understand the effect of the other parameters on the optimization. I read a bit about finite difference and nondimensionalization/rescaling, and I think I understand them conceptually, but I still don't understand what values they have to be to get an optimal optimization process.
This is especially a problem now because I have started to vary epochs (TAIModJulian usually) or time intervals (e.g. "travel for x days" and find optimal x, or to find optimal launch windows), and I cannot get the optimizer to vary them properly, even when I use a large step size. The optimizer usually stays close to the initial values, and eventually leads to a non-convergence message.
I have noticed that using large values for the two scale factors sometimes gives me larger step sizes and occasionally what I want, but it's still trial and error. As far as perturbation goes, I do not understand its influence on how the optimization works. Sometimes for extremely small values I get array dimension errors, sometimes for very large values I get similar results to if I'm using too large a max step size, and that's about it. I usually use 1e-5 to 1e-7 and it seems to work most of the time. Unfortunately information on the topic seems sparse, and from what I can tell GMAT's documentation uses different terminology for these concepts than what I can find online.
So I guess my question is two-fold: how to understand the optimization parameters of GMAT and what they should be in different situations, and what should they be when I want GMAT to consider a wide array of possible trajectories with different values of control variables, especially when those control variables are epochs or time intervals? Is there a procedure or automatic method that takes into account the scale of the optimization problem and its sensitivity, and gives an estimate of what the optimization parameters should be?
I've been trying unsuccessfully to solve the 1D diffusion equation in spherical co-ordinates using finite differences. For the life of me, I cannot get the thing to work. Is this a known phenomena? What is the usual method used for this seemingly simple task?
I am trying to solve a time-dependent diffusion equation with finite-difference discretizations using the Newton–Raphson method. However, I encountered some problems in convergence--the solution result changes when changing time step size. Here I want to find some coding examples to refer to. Thank you.
What are advantages of FOM and FMM over other FDMs?
All theses methods are used for solving BVPs of ODEs and PDEs.
I am looking for the latest approaches to find the band-gap of Phononic / Periodic materials. In this regard, if anyone knows a reference (in detail) for Finite Difference Time Domain (FDTD) theory along with the Bloch method, please share.
I really appreciate any help you can provide.
I wonder that if anyone tried SOR method for unsteady problem discretized by finite difference or finite volume method. Does it converge faster AND solve faster when it is compared to Gauss-Seidel and Jacobi solver?
I want to study the effects of some parameters on elution phase of chromatography using lumped kinetic model (LKM) but I have writing the MATLAB code. I want to solve this using finite difference and Euler method. I have attached the equation. Can anyone please help me out?
For a low-pass FIR filter h[n], the common normalization rule is with regards to H(j0), i.e., sum(h[n]). Then, how about the normalization rule for finite difference filters? For example, given h1[n] = {1, -1} and h2[n] = {1/2, 0, -1/2}, and they have been properly normalized according to the meaning of finite difference. Notice that both have a positive number and a negative number, but the normalization factors are quite different. Then, what is the normalization rule for a general finite difference filter?
Hi, my name is Christopher and I'm currently doing a research in solving the linear elasticity equations using finite difference scheme as a part of my undergraduate thesis. I have been able to solve for the static linear elasticity (displacement formulation) using the finite difference scheme. However, I'm unable to solve the dynamic linear elasticity (velocity-stress formulation) equations using finite difference (Central Time and Central Space FD). The solution always diverges with time.
Here are the first order hyperbolic governing equation i used:
(∂V_x)/∂t=1/ρ ((∂σ_xx)/∂x+(∂σ_xy)/∂y)
(∂V_y)/∂t=1/ρ ((∂σ_yy)/∂y+(∂σ_xy)/∂x)
(∂σ_xx)/∂t=(λ+2μ) (∂V_x)/∂x+λ (∂V_y)/∂y
(∂σ_yy)/∂t=(λ+2μ) (∂V_y)/∂y+λ (∂V_x)/∂x
(∂σ_xy)/∂t=μ((∂V_x)/∂y+(∂V_y)/∂x)
Central Time Central Space FD scheme:
∂f/∂t=(f^(n+1)-f^(n-1))/2∆t
∂f/∂x=(f_(i+1)^n-f_(i-1)^n)/2∆x
The domain i'm trying to simulate is a 2D cantilever beam with fixed displacement on one end and shear stress on the other end. The rest is traction free boundary.
As you know Finite difference representations of derivatives are based on Taylor’s series expansions. I'm wondering that is it available to use the Fourier series instead of Taylor series expansion. I'm not sure but I guess it could be a more precise modification for FD method.
Share your ideas, please.
I am reading this article to understand Richardson's extrapolation for NSFD. With MATLAB, I did the simulations and got the same result with the step size they used. But when I increase the step size, I will get negative results in the Richardson Extrapolation (I have used the Aitken-Neville algorithm). What is the problem? Is it the formula used? Or the code that I have used? that result in negative values.
Thank you!
Staggered grid finite-difference (FD) methods are widely used for elastic wave equation modelling because of their high computational efficiency, smaller memory requirement and easy implementation. I am looking for the mathematical foundation for higher order (8th) of finite difference staggered-grid method on 2D P-SV elastic wave propagation.
Does anyone have a reference of finite difference equations for low salinity simulation? or any help how to include the salinity TDS in the finite difference equations.
Thanks in advance
I am trying simulate an infinite domain so I need to use non-reflective boundary conditions. While searching, I came across PML method, but I have certain doubts.
1) How to decide the dimensions of the PML layer?
2) What effect does PML mesh size have on the reflected waves?
I am using TNO DIANA and I simulated a block of soil of 50 m subjected to an impulse load and tried to see the wave travel. I used PML lengths of 10 to 50 m . However, I can still see waves reflecting back. I also tried to increase the function values assigned at the PML boundaries, but after one point I see that the PML behaves like a clamped or fixed boundary. Can someone point me to a source where PML is explained clearly?
Thank you very much.
In recent years, many new heuristic algorithms are proposed in the community. However, it seems that they are already following a similar concept and they have similar benefits and drawbacks. Also, for large scale problems, with higher computational cost (real-world problems), it would be inefficient to use an evolutionary algorithm. These algorithms present different designs in single runs. So they look to be unreliable. Besides, heuristics have no mathematical background.
I think that the hybridization of mathematical algorithms and heuristics will help to handle real-world problems. They may be effective in cases in which the analytical gradient is unavailable and the finite difference is the only way to take the gradients (the gradient information may contain noise due to simulation error). So we can benefit from gradient information, while having a global search in the design domain.
There are some hybrid papers in the state-of-the-art. However, some people think that hybridization is the loss of the benefits of both methods. What do you think? Can it be beneficial? Should we improve heuristics with mathematics?
I solved a nonlinear PDE by linearization and using finite difference and spectral methods. the errors for simple u_exact= exp(-t)(-8x^2-8y^2+7/2) don't change when the meshes become finer, in other word the error for all spatial meshes (20, 40, 60,...) is equal approximately, but for a more complex example u_exact=exp(-t)sin(x)cos(y) the results are very good and order of convergence is correct(i.e. order=2).
can anyone pleas tell me the reason of this trouble that happens in test whit a simple u_exacts?
I have a nonlinear cable dynamic model as follows,
m[(∂u/∂t)-(∂ϕ/∂t v)]=-0.5 ρ_a dπCDt u|u|(1+ε)+(∂T/∂s)-wc sinϕ
m(∂v/∂t+∂ϕ/∂t u)=-0.5 ρ_a dπCDn v|v|(1+ε)+T (∂ϕ/∂s)-wc cosϕ
It involves both space and time derivatives. Finite difference scheme is used to discretize the partial differential equation as shown in figure 1.
where k is the time and j is the space. Since there are multiple unknown values (k+1 terms) are there, direct matrix inversion is not possible. It is found that Newton Raphson method can be used to solve such equations.
How to solve such an equation using Matlab?
Suppose we have an equation like this: du/dx=dv/dy (d/dy partial derivatives)
can we discretize du/dx using a central difference scheme with 2nd order accuracy and dv/dy using forward difference with fourth-order accuracy?
Can anyone suggest me some papers on this?
I have seen several papers on SPH discretization of the shallow water equations and its application to flood and other hydraulic modeling. However, no paper I have read addresses why it is attractive to use SPH for SWE rather than a Finite Volume or Finite Difference approach. FV and FD can use non uniform grids and SPH is only beginning to address that. So am I missing any advantage of SPH in this regard?
For example: Lu+0.5u=f(x,y)
or Lu-au=o (elliptic PDE).
Actually I am looking some PDE for which I should get a singular system after applying any finite difference scheme.
Hello,
My question is concerning the implementation of a parallel-plate waveguide (PPW) using 2D FDFD. I am using the total-field/scattered field method in the paper attached by Rumpf. One way to implement the PPW is to define two PEC objects (by modifying the epsilon matrix on the grid) and specify the total-field between the two objects using the Q matrix to excite the right modes. Is there a way to implement this where the PECs are defined as surfaces or boundary conditions instead of objects?
In the paper "Magnetometer-Only Attitude Determination Using
Novel Two-Step Kalman Filter Approach" in equation 19 do I need to complete quaternion multiplication first and then do simple mathematical finite differencing or it is in other way?
I am going to solve Richards equation for unsaturated zone using finite difference method. I read in several papers that van Genuchten method is used to estimate hydraulic properties. In van Genuchten formula we can estimate theta and K. what is the difference between the theta obtained by van Genuchten formula and the theta obtained by Richards equation. The other question is that in solving Richards equation we assume an initial h. in the next step h should be estimated so that we can calculate using this equation. How it can be updated in each step.
I need to multiply the inverse of a matrix A to another matrix B. If B were to be a vector, I would simply solve a linear system Ax = B to get the product x=inv(A)B. With B being a matrix, I don't know the most efficient way|method to compute inv(A)B.
Kindly share your experience.
Consider solving the nonlinear Schrödinger equation (NLSE) with 2D transverse dimensions. Or more simply, consider the beam propagation method (BPM).
We know that the original formulations of Feit&Fleck relied on the FFT to compute the derivatives.
In the 90s, many works about finite differences (FD) were proposed. The advantage is that the grid is more flexible and the boundary conditions are better understood and controllable (PML, TBC...). Prof. Fibich in his book suggests FD is a better approach to tackle collapses.
With the advent of GPU, FFTs with lots of points seem to be almost costless. Do you think it is not worth anymore to study finite differences? What about non-paraxial propagators?
Thank you for your suggestions.
Hello,
I am doing a series of metal forming simulations in Abaqus. I want the simulations to automatically stop when a critical value of PEEQ (or some other variable) has been reached, in order to indicate the failure of the material.
Please see the attached figure, there is a necking region which is highly unrealistic, in reality, the material would have failed much before this.
Could someone please tell me how I can set Abaqus to stop the simulation once a user-specified failure criteria has been met?
Many thanks,
Hamid
The finite difference method with Taylor expansion give a good accuracy higher order derivative of normal functions for which the expansion coefficients can be found following this link: https://en.wikipedia.org/wiki/Finite_difference_coefficient
My question is what would be the higher order expansion of the functional derivative knowing that it has a similar Taylor expansion. Please note that I'm talking about the numerical differentiation.
Hi all,
I am attempting to implement 3D finite difference (FD) beam propagation method (BPM) based on alternate-direction implicit (ADI) method.
Does anybody know about how to implement or the formulation of transparent boundary condition (TBC) in 3D FD-BPM based on two step ADI method?
Any suggestions or advice would be appreciated,
Thank you!
Dear all, I have a question about implementing finite difference scheme to two related grids (one is the original non-uniform grid, for example grids are clustered near the wall regions when simulating wall turbulence. And the another one is the uniform grid transformed from the original non-uniform grid)
Finite difference scheme can work on both grids. On non-uniform grid, finite difference scheme could be derived from Taylor expansion of non-equidistant points. And on the transformed uniform grid, we can use the difference scheme in the original equidistant situation, just multiply by a transform coefficient.
My question is are these two methods equivalent? Consider a second order central difference scheme for first derivative, we use three points when using a non-uniform grid (to obtain the derivative at i point, we need values at i-1, i, i+1). However we use only two points when using the transformed uniform grid (to obtain the derivative at i point, we need values at i-1, i+1).
Did we lose some information when we did the grid transformation?
I'm trying to implement an incompressible fluid solver with a CIP advection scheme, or to be more specific the USCIP scheme from this paper:
It seems to require colocated velocity components instead of a staggered placement.
My question is what is a suitable FDM scheme for solving the Poisson equation for pressure projection? Unfortunately the paper does not say.
Which stencil for the divergence and Laplace operator would be a good choice for this situation?
In order to solve a time-depended PDE which method is better to use Forward or Backward Euler method,especially when we are talking about small time steps?Which of this methods are more stable?
Does anybody have experience with the Finite Difference Element Method described in http://www.scc.kit.edu/scc/docs/FDEM/Literatur/FDEM-Survey-Feb09.pdf and would advocate for or against using it? The method works on an unstructured grid, the field quantities are represented by their values at the grid points, and spatial derivatives are evaluated at the grid points by means of fitting polynomials into the gridpoints in the neightborhood of the respective gridpoint.
To me, at first sight, the method seems to have a couple of advantages, compared to FEM:
- The meaning of the state variables of the discretized system is intuitive
- It can be applied as a "black box" to virtually every PDE
- There is no a priori pen and paper work necessary for calculating weak forms, quadrature formulas etc.
- It can readily be extanded to rather high orders
- The PDE can contain arbitrarily high derivatives, in principle
- The error of the derivatives can be estimated
Does anyone know any drawbacks of the method?
The Damping term ( bottom left ) is the 4th derivative of the field that is to be solved 'm'. The Error Term I have in the plot ( top right ) is a 3rd derivative term from my finite difference approximation. It can clearly be seen that the error in my m-equation ( bottom right ) is primarily due to the growing oscillatory error term.
It known that the common sources of error in finite differences are round-off error and computer rounding, I am focusing here on using finite differences to numerically evaluate the derivative of a function, sometimes whether we use finite differences or exact analytical expression the results are very close.
My question: Is there special cases when the finite difference approximation fails?
I need to calculate the curvature of a boundary of FE model. I have the current coordinates of nodes of boundary. I used the formula of curvature with finite difference, but i gives noise in the curvature. I also used quadratic polynomial fitting through three points at a time but it also give noisy curvature.
Hello everybody,
I am trying to solve a differential equation in spherical coordinates to obtain the thermal stress caused from the thermal expansion of the considered body. Since there is the spherical symmetry, the equation depends only on the radial coordinate r (see the attached file for details).
In the case of a general thermal profile, I get unphysical spatial oscillations in the solution (see the attached file for details).
Could you kindly indicate me if there is a way to avoid this unphysical effect?
Thank you very much for your help.
Best Regards.
Marco Gandolfi
Which is the latest method to solve non linear equation using finite difference method.
Can you tell me some methods for solving non linear equations using finite difference method.
Hi All,
This is the first time posting here asking a question. I am trying to reproduce the result from this paper. My main area of interest is applying this to Black Scholes. The author has a subsequent paper that does that. However, I still do not understand the mathematics that is done to arrive at the results. I have posted questions to the author but I have not got any response. Here are my questions.
The paper essentially uses Moment matching to arrive at optimal coefficients for the finite difference discretization. I was able to get through the zeroth moment and first moment. I am attaching my attempt at deriving the results of the paper. Things I am having an issue with.
1. The Imaginary part in the paper for R, has a negative sign that I do not have.
2. The higher order terms, I am not sure how the paper arrived at the results. Any clues, hints or other forms of assistance is much appreciated.
Thanks in Advance. I have attached my attempt at the results as a PDF.
Despite the higher accuracy of Finite analytic method than Finite difference and Finite element methods, why is it not popular as the other methods ?
Yes, there is a new method which is called Piecewise Analytic Method (PAM). It does more than Runge-Kutta.
1. PAM gives a general analytic formula that can be used in differentiation and integration.
2. PAM can solve highly non-linear differential equation.
3. The accuracy and error can be controlled according to our needs very easily.
4. PAM can solve problems which other famous techniques can’t solve.
5. In some cases, PAM gives the exact solution.
6. ....
You can see :
Also, You can write your comments and follow the update of PAM in the discussion
I am working on a a finite difference model of a simplex atomizer. The crux of the problem I’m having is existence of a conical geometry converging at the orifice. I need to take advantage of axisymmetry to keep the computational time and memory requirements to a minimum. I was working in cylindrical coordinates and making progress until I realized that the geometry was causing considerable skewness in the nodal positions. I can handle this with Cartesian coordinates but then I have no way to approximate the angular velocity (normal to the solution plane) which was straightforward in cylindrical coordinates. Can anyone suggest a method to compute normal (tangentilal velocities?
In FE some elements are overlapping. I read a paper says thst such overlapping causes higher in plane stiffness only. I wonder does the impact on accuracy of solutions very big?
When using Return Mapping algorithm, I implement Newton–Raphson iteration to reach the value of plastic multiplier. I know that the total value of plastic multiplier should not be negative. But, what should I do if one increment of plastic multiplier in an iteration is negative. Should I stop iteration or continue or what?
I am wondering the capabilities of 2nd order finite difference formula in space and first order formula in time to discretize the vorticity-streamfunction equation to solve Taylor Green Vortex Problem. I am mostly concerned about capturing the vortex interaction using these formulas. Do I need to use high order finite difference schemes both in space and time to capture vortex interaction?
I tried to code this method and it diverges when the stiffness approach zero. As, calculating load vector coefficient ∆λ requires having inverse of the stiffness as shown in the attached photo (https://scholar.harvard.edu/files/vasios/files/ArcLength.pdf) .So do anyone have a solution to it
I know about mesh density, skewness, wrap angles, and aspect ratio.
Per literature, aspect ratio is a quick tool to define quality of mesh.
Is there a rule of thumb for acceptable values of elements aspect ratio?
How different micro textures could be modeled on the tool model in ABAQUS ?
When modelling micro textures can the tool be kept rigid ?
(If it can't be kept rigid, can the tool be modeled as deformable ).
I have developed a honeycomb sandwiched structure in Salome platform, meshed with netgen 2D, then calculated the compression stresses on it using Calculix open source FE.
I tried to optimise the element offset in order to eliminate such problem.
Attached is the photo of the honeycomb core.
Can anyone suggest material regarding Von Neuman stability for fractional finite difference techniques?
Hi everybody
In discretization process of one PDE, can I use FW, BW and central FD approximation simultaneously? for example for one derivative I use BW approximation and for the other one I use FW?
(df/dx)_m,n= FW
(df/dy)_m,n=BW
Thanks.
In many problems such as solving PDEs or optimization problems we need to calculate the numerical approximation for differentiation operation, nowadays in some packages such as Tensorflow the automatic differentiation is available, I want to know which one is more accurate, numerical differentiation methods such as finite difference or automatic differentiation?
I have a set of coupled ODEs:
J = mu*e*n(x)*E(x) + mu*K*T0* dn(x)/dx
and
dE(x)/dx = (e/eps)*[N_D(x) - n(x)]
These are the drift diffusion equation and Gauss's law for a unipolar N+ N N+ device. The doping profile N_D(x), the mobility mu, T0 are known. The DC current, J, is also known, as are the boundary values: n(0) = N+, N(L) = N+. I want to self consistently solve the above two equations using finite differences, but I am unsure how to go about doing so.
Thanks in advance!
FEM or finite difference ? Thanks all, Si
Different people have different biological properties like DNA ,finger prints, iris and so on.
We’re looking for a mechanism that can identify people according to their cerebral frequencies and nervous system.
Is it possible to recognize these differences?
And do you know about unique parameters of the brain frequencies?
Have you ever read something about it?
I am actually simulating 1D Fick's second diffusion law in steels, quantitatively. I am using a grid spacing of 1 Å for better resolution, though the inter-atomic distance in steels is around 2.8 Å. The other parameters are also converted to Å scale. I presume the concentration term is a field here without any physical significance. Can I proceed with this assumption of finer grid spacing? Also I would appreciate any information regarding the understanding of concentration profile in 1D, compared with the actual 3D case with references.
Thank you.
when we need to solve the Fokker Planck equation (Kolmogorov Forward equation) with finite difference, we need to solve it in a bounded domain, (regardless of the dimension of the FPE), for more accurate solution, which kinds of boundary condition should be considered?
1-Natural boundary condition:
which is a Dirichlet type boundary condition
the value of probability at the boundaries equal to zero
2-the Reflecting boundary condition:
which I think is the Robin type boundary condition
and the Flux at boundaries is zero?
I have the following problem:
u_t = u_xx + u_yy, in Omega, t > 0
u(x,y,0) = 1, in Omega
u(x,y,t) = 0, on dOmega, t > 0
when Omega is defined to be a domain between the rectangular 1x1 and the circle of radius 0.3 centered at (0.5,0.5). dOmega denotes the boundary of the domain Omega.
I want to solve the problem numerically using explicit scheme for dx = dy = 1/50. And I want to solve it in MATLAB.
So far i got a general scheme for all the points, the problematic and non-problematic ones. But I don't know how to compute it.
I want some code that can, for each point, detect the value of alpha and beta (the coefficients in front of dx, dy when the distance to a neighboring grid point is less than dx or dy, i.e. when the neighboring grid point is on the boundary of the circle), for every point on the grid.
Can anyone help me figure out how to compute this?
Hi!
I am working on adsorption processes for hydrogen purification and I am using Fortran to simulate some breakthrough experiments.
I am using a subroutine based on finite differences for spatial discretization and the routine LSODA to for time integration. The model is the same used by Cruz et al (
Article Cyclic adsorption separation processes: Analysis strategy an...
). I am not using the same numerical methods, but the model is the same.
Using isothermal conditions, the simulations run perfectly and take only a few seconds. The results are consistent with the experimental results.
However, using non-isothermal conditions, the simulation becomes too slow when the contaminants start to breakthrough.
For example: I have a column packed with an activated carbon, initially clean (only filled with helium, which does not adsorb). After t=0+, I start to feed 75 % Helium and 25 % CO2.
When simulating this under non-isothermal conditions, the program becomes very slow right before the CO2 starts to breakthrough the column. It takes 10 seconds to simulate the first 800s but to simulate the rest, it takes more than 2 hours (to simulate more 100s). If I remove the heat of adsorption, the simulation runs fast.
Does anyone had the same problem or have any idea why is this happening?
Thank you in advance!