Science topic
Boundary Value Problem - Science topic
Explore the latest questions and answers in Boundary Value Problem, and find Boundary Value Problem experts.
Questions related to Boundary Value Problem
Hello dear professors, students and all researchers of mathematical sciences, my question is whether it is possible to define only one algorithm by considering all innovative numerical methods for solving partial boundary value problems And the nature of the problem, with the best numerical method that is more consistent and stable with the least error to get the numerical solution of the problem?
The fact that force fields contain an energy density leads to remarkable consequences for the radiation of accelerated force field sources.
The first consequence is that the fields are material subjects that always move with their source in the inertial frame of the source. The idea that field sources would permanently renew their immaterial force fields is refuted if these fields contain an energy density. A permanent renewal would then exhaust the source.
But the second consequence is more spectacular. The fact is that when a field is accelerated, it has to adapt its force field to the changed speed. We know that accelerated force field sources radiate. However, we have not yet noticed that the aperiodic part of this radiation is there to adapt the force field to the changed speed.
This adaptation is now the actual cause of the radiation from accelerated force field sources. So far, we have only focused on the periodic part of the radiation that is produced by accelerated charges or masses. But an aperiodic part is also part of such a situation.
Mathematically, the situation of an accelerated field source is described by an initial/boundary value problem. The solution to such a problem involves periodic and aperiodic parts.
This is a remarkable, very fundamental aspect that affects gravitational, electric and magnetic fields equally. In any case, this is worth a specific discussion.
There are so many papers available to solve initial value problem by using Fuzzy Laplace Transform method. But need solution for the boundary value problem by using the same method.
My joint paper, Dang Quang A, Dang Quang Long, Ngo Thi Kim Quy, A novel efficient method for nonlinear boundary value problems, Numerical Algorithms volume 76, pages 427–439 (2017), see https://link.springer.com/article/10.1007/s11075-017-0264-6 , does not appear in Google scholar . Why? How to add this paper to my profile?
Thank you very much for the help.
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.
How can I get a MATLAB code of numerical methods for solving systems of singularly perturbed boundary value problems?
Many Boundary Value problems can be solved by numerical methods ,l,am looking for the possibilty of combining some numerical methods with some integral transforms in order to speed the convergence
Fuzzy boundary broblems have many applications ,so it's very important to compined semi-numericale methods as HPM,VIM,and ADM,......with some artificial algorithms.
I have solved fractional initial value problems using predictor-corrector algorithm, how do I solve fractional boundary value problem using the same algorithm or other algorithms in MATLAB, please help me to write code for it or please share the MATLAB or Mathematica code for it.
Thank you in advance.
Fuzzy boundary value problems have many applications ,so the issue of the existence and the uniqueness of the solutions is very important .
Conformal mapping is a powerful tool to solve 2D boundary value problems that would would otherwise not be able to be solved analytically
Have these ideas been extended to 3D applications? Can someone point me to a suitable reference?
hello every one
I need some strategy to slove below nonlinear ode:
y(iv)= 1 /(1-y)2
y = y(x) 0<x<1
y(0) = 0 y/(0) = 0
y(1)=1 y/(1) = 0
thanks so much for you help
Dear researchers
As you know, there are many numerical technique for solving the fractional differential equations. Regarding q-fractional differential equations, is there any numerical technique to obtain approximate solutions?
There are many numerical techniques for obtaining approximate solutions of fractional order boundary value problems in which the order of differential equation is a fractional constant number. If we assume that the order of BVP is a continuous functions with respect to the time, then is there any numerical technique to obtain approximate solutions of a variable-order fractional BVP?
When we solve for a nonhomogeneous differential equation due to impulsive force with appropriate boundary conditions, green's function is the only method to solve?
Or. any other method is there?
When studying boundary value problems, we often use the legendre function to solve problems in spherical boundary conditions.
What sort of boundary problems are solved with legendreQ? Any applications to electostatics?
Dear Researchers
As you know, nowadays, the mathematical models of different phenomena and processes are designed by means of fractional operators in the context of various systems of boundary or initial value problems with boundary conditions. Some of such well-known mathematical models can be found in many papers like pantograph equations, Langevin equations, Jerk equations, Snap equations, etc. All of these models are practical examples of fractional boundary value problems.
Could you suggest other examples about practical applications in fractional boundary value problems? I am going to study the dynamical behaviors of these new models theoretically and numerically.
Thank you very much.
Best regards
in ordinary differential equations we use shooting method. I don't know any methods in fractional calculus for solving boundary value problems.
I encountered some complications solving a system of non-linear (3 equations) ODEs (Boundary Value Problems) numerically using the shooting method with the Runge Kutta method in Matlab. Is it possible to share this kind of code with me if someone has a similar solution or has encountered a similar problem or probably, suggest possible literatures which might help.
Thank you.
The original differential Equation associated with BVP or IVPs is transformed into an equivalent integral equation to solve.
Hi,
As I have understood trajectory generation in optimum time is related to solving an optimal control problem with constraints on states defined as position, velocity and acceleration and input as jerk. One way to decrease the position error in this problem is solving the discrete system which I couldn't find any toolbox for it (would be nice to mention if you know any), but I was wondering if could involve time and constraint of minimum time in boundary value problem solvers like bvp4c in matlab.
Thanks
What is the difference between weak from Ritz method and variational form Ritz method while solving a boundary value problem ? Can all differential equations take variational form ?
I want to write Matlab code using finite element method in order to solve the above problem but I didn't succeed because am not familiar with that Matlab programming however I have tried to give such code below which it dosn't work ,any help ?
-u''(x)+u(x)=(-4x^2-6) exp(x^2),u(-1)=u(1)=0, x\in ]-1,1[
[
My attempt code :
function [U] = EquaDiff2(n)
%----------------------------------
% d²u/dx² + 6 du/dx + 9 u = x(1-x)
% u(-1) = 0 u(1)= 0
syms x x1 x2 real % déclaration de variables
symboliques
function [Ke, Fe] = MatElt2Nd(x1,x2) % déclaration de la fonction , Fonction pour calculer la
mat. et vect. élementairs
%----------------------------------
x = ]-1:2/n:1['; % modification d’1 borne
d’intégration
K = zeros(n+1 ) ;
F = zeros(n+1,1) ;
for i = 1:n
j = i+1;
t = [i j];
x1 = x(i);
x2 = x(j);
[Ke,Fe] = MatElt2Nd(x1,x2);
K(t,t) = K(t,t) + Ke;
F(t) = F(t) + Fe;
end;
K(1,:) = [];
K(:,1) = [];
F(1) = [];
U = K\F;
U = [0.0;U];
t = 0:0.01:1;
return
%-------------------------------------------
% Calcul de la matrice Ke et du vecteur Fe
%-------------------------------------------
function [Ke,Fe] = MatElt2Nd(x1,x2)
Ke1 = 1/(x2-x1)*[ 1 -1 % les modifications ne
touchent
-1 1 ] ; % essentiellement que les
matrices
Ke2 =(x2-x1)* [ 2 1 % élémentaires
1 2 ] ;
N = [(x-x2)/(x1-x2) (x-x1)/(x2-x1)] % fonctions de forme
Fe =simple( int(N' * (-4*x^2-6)*exp(x^2) , x, x1, x2) ) % vecteur Fe ;
Ke = Ke1 + Ke2 ;
return

We are working on block multistep method for solving third order boundary value problems with Robin type and now we are trying to implement our proposed method for solving application problems. I'm really appreciate any response and help. Thank you so much.
I encountered some complications solving a system of non-linear (26 equations) ODEs (Boundary Value Problems) numerically using the bvp5c in matlab. But matlab report an error"Unable to solve the collocation equations -- a singular Jacobian encountered", so I calculate the jacobian matrix manually, and it really is singularity(a row of the matrix is zero). Aiming at this problem, what method can be used to solve this kind of Boundary Value Problems?
Thank you.
Sir, I am working with Fractional order differential equation, I would like to know is there any method available that can convert a boundary value problem with final value to an initial value problem with initial value?
Please put light on it.
Thank you in advance.
I am very familiar with problems of the form
y'(x) = f(r; x, y), y(a)=y0, y(b)=y1
where r is a parameter to be estimated using the boundary values.
But apart from this situation, has anyone found other reasons why we should a boundary value problem of the form
y'(x) = f(x, y), y(a)=y0, y(b)=y1
To me, I think a BVP should be of second-order or higher. So I think the simplest BVP should be of the form
y''(x)=f(x,y,y'), y(a)=y0, y(b)=y1
I know that there is an initial guess of initial value to solve a BVP using shooting method but it is obtained from literature that bisection method to find the exact initial value, my question is how bisection method is used to find exact initial value of a BVP.
Please reply.
Thank you
Sir, I am able to solve an initial value problem of fractional order differential equation in MATLAB using a solver, I would like to know how do I solve a boundary value problem, i.e. integrating backward using the same solver.
Thank you in advance.
Dear scholars,
I am working on finding a numerical solution for an equation set with implicit boundary conditions on Matlab. The equations are expressing a nano liquid flow problem which are derived based on including continuity, momentum and heat transfer equations. The equation set and the related boundary conditions are attached. Except f and θ which are the functions of η, all the parameters are the properties of the fluid and known.
So, could you please tell me which numerical method is proper to treat this problem?

The FortranCalculus (FC) Compiler improves Math Modeling, Simulation & Optimization efforts for Engineers & Scientists by improving their productivity by 20 times! Solving differential equation math problems with today’s compilers often take more than 1 man year but our compiler can do it in hours with improved accuracy in the results. Our compiler also allows one to tweak their parameters for an optimal solution.
Solutions are Faster, Improved Accuracy, & Cheaper.
• FC-Compiler™ application is a (free) Calculus-level Compiler that simplifies Tweaking parameters in ones math model. FC solves Algebraic through Ordinary Differential Equations; Laplace transforms; etc. FC is based on Automatic Differentiation that simplifies computer code to an absolute minimum; i.e., a mathematical model, constraints, and the objective (function) definition.
📷
We consider the initial and boundary value problem for isentropic gas dynamics by the vanishing viscosity method, where we consider the boundary condition m (momentum)=0, in particular. The difficult point is what boundary conditions we give the isentropic gas dynamics with the artifical viscosity (We call this equation (AV)). As you know, (AV) is the parabolic equation. So, we must give two boundary conditions. On the other hand, the limit equation, i.e. isentropic gas dynamics, is hyperbolic equation. So, the boundary
condition is only one, m=0.
I have 3 4th order non-linear Partial Differential Equations with three dependent variables and 2 independent variables. I have boundary conditions for 2 dependent variables. The problem is formulated when analysing a laminated composite structure. It is a steady-state analysis. Should I proceed with Navier's method/FEM/ or some other approach? I would appreciate suggestions. Thank you.
In physics, many problems arise in the form of boundary value problems in second order ordinary differential equations. We are discussing here the Matrix Variational Method, as an efficient approach to bound state eigenproblems [1--8], proposed by the author starting in 1977 and used in top peer-reviewed literature in physics, in general [1,6,7] and in the calculation of scaling laws of Rydberg atoms [2], bound states of QM systems [3], bound states of three quarks [4,8], and other areas, such as [5].
We will also use this RG space in a new way, to conduct an open course, as a discussion. This course is physically offered at the same time, in Pasadena, CA.
The objective here is to present the topic as a method in mathematics, for second-year students in college, generally when they see differential equations, not just the epsilons and deltas of calculus, but the more advanced tools and intuition used in physics and maths.
This discussion will aim, as much as possible, to be free of the original connection to physics, in order to be more easily used in other disciplines. It represents the “translation” of a method in physics to mathematics, for general use, while benefiting from the physical intuition that started it.
We will use the theorem that says, “Any second order linear operator can be put into the form of the Sturm-Liouville operator,” and treat the Sturm-Liouville operator in closed-form. This will be done not by using eigenfunctions of any expansion, but an expansion that already obeys the boundary conditions for each case and provides a closed-form expression, which we will calculate following [1-8].
Contributions, and other examples, are welcome.
REFERENCES
[1] Ed Gerck, A. B. d'Oliveira, Matrix-Variational Method: An Efficient Approach to Bound State Eigenproblems, Report number: EAV-12/78, Laboratorio de Estudos Avancados, IAE, CTA, S. J. Campos, SP, Brazil. Copy online at https://www.researchgate.net/publication/286625459_Matrix-Variational_Method_An_Efficient_Approach_to_Bound_State_Eigenproblems
[2] Jason A C Gallas, Ed Gerck, Robert F O'Connell, Scaling Laws for Rydberg Atoms in Magnetic Fields, Physical Review Letters 50(5):324-327, Jan 1983. Copy online at
https://www.researchgate.net/publication/243470610_Scaling_Laws_for_Rydberg_Atoms_in_Magnetic_Fields
[3] Ed Gerck, Jason A C Gallas, Augusto. B. d'Oliveira, Solution of the Schrödinger equation for bound states in closed form, Physical Review A 26:1(1), June 1982. Copy online at
[4] A. B. d'Oliveira, H. F. de Carvalho, Ed Gerck, Heavy baryons as bound states of three quarks, Lettere al Nuovo Cimento 38(1):27-32, Sep 1983. Copy online at
[5] Ed Gerck, A. B. d'Oliveira, The non-relativistic three-body problem with potential of the form K1r^n + K2/r + C, Report number: EAV-11/78, Laboratorio de Estudos Avancados, IAE, CTA, S. J. Campos, SP, Brazil, Nov1978. Copy online at
[6] Ed Gerck, Augusto Brandão d'Oliveira, Continued fraction calculation of the eigenvalues of tridiagonal matrices arising from the Schroedinger equation, Journal of Computational and Applied Mathematics 6(1):81-82, Mar 1980. Copy online at
[7] Ed Gerck, A. B. d'Oliveira, Jason A C Gallas, New Approach to Calculate Bound State Eigenvalues, Revista Brasileira de Ensino de Física, 13(1):183-300, Jan 83. Copy online at
[8] Ed Gerck, A. B. d'Oliveira, The logarithmic and the square-root potential as confining potentials for quarks, Report number: EAV Report 02/79, Laboratorio de Estudos Avancados, IAE, CTA, S. J. Campos, SP, Brazil. Copy online at
Technical Report The logarithmic and the square-root potential as confining p...
Is there anybody with an insightful note or explanation on how to establish the stability of the solution of ODE (bvp) using Poincare-Lyapunov Theorem?
Reduction of the bvp to initial values problem and generation of the Lyapunov function do not incorporate the boundary conditions. We believe these are not acceptable.
Do you know how to include the Neumann boundary condition into Jacobian matrix or how to generate Lyapunov function suitable to establish the stability of the solution of ODE bvp; see the attached problem.
Proving existence results for some initial and boundary value problem, we usually find a corresponding integral equation first and then use some fixed point theorem to prove the existence of solution of differential equation.
Why finding corresponding integral equation is not enough and it is important to use fixed point theorems to prove existence of solutions?
some counter example will be helpful.
I want to solve some singularly perturbed boundary value problems. It's clear in the quintic b-spline collocation point, there are four factitious points which will going to eliminate from algebraic differential equations(ADEs) by substituting the boundary conditions. Now, to do this elimination, is that possible to use Dirichlet boundary condition instead of Neumann or mixed BC?
I am trying to prove the existence of positive solutions to:
-y''=f(y), 0<x<1,
y(0)=y(1)=0.
where f(y)=k sin(y)-sin(2y) "k~ arbitrary constant". Any help with known result or useful technique is much appreciated.
In boundary value problems like scattering from wedges, the scalar wave function is written by Bessel function and the Hankel function is left out due to the irregularity in the origin while the electric field calculated from this scalar wave function is also singular at the origin.
Can any body please help me?
The solution of 1D diffusion equation on a half line (semi infinite) can be found with the help of Fourier Cosine Transform. Equation 3 is the attached figure is the solution of 1D diffusion equation (eq:1). I want to write a code for this equation in MATLAB/Python but I don't understand what value should I give for the dumy variable 'tau' . This variable is not defined at the start and only appears during solution process.

Imposing boundary condition and calculating weighting coefficient
Hello beautiful minds
I have to analyse a simple microwave structure using the Boundary Integral-Resonant Mode Expansion (BI-RME) where I have to calculate the coefficients Aij, Bij, Cij and Kp in order to calculate the admittance matrix. Well, for Aij and Bij it's a simple formula, however, for Cij and Kp I should solve Helmholtz's equation in a 2D domain (Laplacian (U (x, y)) + Kp ^ 2 U (x, y) = 0), so after several attempts, I can find neither Cij nor Kp. I was wondering if someone might be able to give me a help by answering my questions below:
1- the analytical formula of eigenfunction U(x,y) depends on two natural constants (m,n)?
2- How many eigenvalues I should take in consideration to get best results?
I'll appreciate if you add some detail exemplification.
thanks for any help you can provide.
Solution manual of Haberman_ R-Elementary Applied Partial Differential Equations With Fourier Series And Boundary Value Problems-Prentice Hall PTR (1987). (second edition)

One boundary value problem (ODE) has an analytical solution and I guess there is other solution also which I am getting using Mathematica but it depends upon length of infinity. The third order BVP has one condition at infinity. The solution keeps on changing as I go on increasing the value of infinity. Can anybody help?
I am experiencing difficulties in reconstructing a function from know boundary values.
Please see the attachment.
It is easy to solve non linear problems with initial condition.Feeling it difficult to solve non linear problems with two boundary conditions.Any guidance or direction will be appreciated.
can help me
Numerical solution of the Volterra equations of the first kind that appear in an inverse boundary-value problem of heat conduction
I have seen many examples of non-linear equations being solved by HPM, each problem is having specified boundary or initial conditions. What if all the boundary conditions(in BVP) are homogenous?
we have a fourth order boundary value ordinary differential equation, it has Dirichlet and Neumann boundary conditions on both boundaries. What is the most suitable and consistent method that can be used to solve such problem, with the least error.
A summarized description of the problem is attached.

HI, I get a wave equation with mixed overdetermined boundary conditions. I want to know if there is any results about existence or non-existence?
NB: Read the attached file to see the full equation and boundary conditions.
Dears
Kindly, how to derivation boundary value problem using Lagrange interpolating polynomial?
What algorithms could be the most possible approach for both the local integration of the constitutive model and the global iteration in the boundary value problem (say a footing case)?
Here I mean a highly non-linear work hardening-softening model for granular (cohesionless) material. Closest point projection method and cutting plane method in combination with a Newton-Raphson method both failed in my attempts to implement the model in ABAQUS Umat. Could anyone give me some advice?
Hello Everyone
I have to solve a higher order coupled PDE with initial and boundary conditios.
I have tried Matlab pdex4 and pde but could not as they dont allow higher derivatives wrt t. My equations look like as follows
d2v/dt2 = d4v/dx4 + F
d2w/dt2 =d2v/dx2 + F
In Matlab/pde apparently it doesnt allow higher derivative on left handside.
Can anyone please help me in this?
I want to know the method used by 'bvp4c' to converge to the solution.
Thanks.
I am solving a BVP, as the example (1) in attachment, where all the variables only have one condition on the boundary.
So I tried to do the change of variable s = 2 - t for p(t) and q(t), and I obtained , as example (2) in attachment, but that didn't work because solution of (1) and (2) do not are the same.
The issue is I am able to solve the equations but the output waveforms are not as expected. So mostly I think it is issue with boundary conditions. I feel the boundary conditions I have considered are correct but doubting the output. I feel I have missed some of the boundary condition.
I am attaching a copy of the objectives of my project and also the code.
Please help me out
P.S. I can upload the code if someone can help me out with the same
I am a doing a research on analysis of hyperbolic paraboloid shell using levy type soluton which will be validated later by using ansys. Levy type method as suggested by apeland and popov is being used. Since its a eight order differential equation with boundary value problem having a problem in solving boundary condition. Can anyone suggest an easier method to solve the boundary conditions? or can anyone explain the method to use the tables given by Apeland and Popov?
P.S. Already tried spilines method.
If there is any paper regarding this please tell me....Thanks
want any nonlinear ODE BVP of odd order from any fluid flow problen
If f(0) = 0 , f '(0) = 0 , f ' (infinite) = 1
which transformation is use full to convert the limit infinite in to some finite number?
Recently I found various combined slip boundary conditions (such as : bounce back with specular reflection, Mawellian slip boundary, etc) are used in LBM to study the gas flow in micro-channel or micro-tubes. Can we apply those BCs directly to porous media without modification?
I'm working on path planning for robot. However, I would like to ask how I can minimize the cycle time for the industrial robot, the motion of the robot is between point A and point B (the problem is two points boundary value problem).
x(t0) = x0 (point a), x(tf) = x1 (point b)
However I need to minimize the cycle time by minimizing the Hamiltonian equation by applying Pontryagin’s Maximum Principle
I am dealing with a boundary value ODE problem. The (nonlinear) ODE system smoothly depends on a real parameter q. For q=1 the ODE system simplifies and I can derive analytically a complete set of valid solutions of the boundary value problem. Under which conditions are solutions for q = 1 smoothly mapped into solutions for q >1? How can one predict "singularity points" in q where the correspondence breaks down?
I performed a Ritz analysis on 1-D Laplace equation and my results are diverging from the exact results. So is numerical oscillation is the only cause or can it be because of any other reason?
I use MATLAB commands 'ode23' and 'ode45' for solving systems of differential equations and this program involves an *.m function (system), time-span and initial-condition (x0) only. How to solve BVPs in MATLAB? Can you give an example? Thank you!
How can I solve a system of non-linear PDEs (Boundary Value Problem) numerically?
Is there any software that provides accurate estimates of surface charge density of a solute in aqueous media using linear poisson equation?
Consider the boundary value problem \sqrt(y)(1 + cy'') = x(x^2-1) with boundary conditions y(1) = y(-1) = 0. Here y = y(x), the primes denote derivatives with respect to x, and c is a positive parameter.
How can this problem be solved? Does it have a solution for a unique value of c? If so, how can this be proven? How can I obtain an estimate of the value of c?