I've been trying recently to solve the following system of Hamilton-Jacobi PDE's, which are of the hyperbolic, first-order type:
$ V_1,_t - 0.5 V_1,_x^2 + V_1,_x(0.1x^2+0.03x+.0.01)+0.02(x-0.5)^2-V_1,_x V_2,_x=0$
$ V_2,_t - 0.5 V_2,_x^2 + V_2,_x(0.1x^2+0.03x+.0.01)+0.03(x-0.5)^2-V_1,_x V_2,_x=0 $
With terminal time conditions: $V_1(T,x)=0, V_2(T,x)=0$, where T is some final time and x is scalar.
I need to solve it only numerically, get some plots for the two Value Functions and done! The problem is I couldn't solve it in Mathematica, and I'm having trouble with MATLAB as the PDEtoolbox seems to not let me choose a terminal time condition.
Also I'm not that experienced in solving this kind of problems in any software. However I have available a couple different software so if anyone could give me some help and guidelines in any known software and in order to solve it I would be in debt!
Cheers!
2025-01-13 02:28:11.1736735291
How to solve a system of nonlinear Hamilton-Jacobi PDE's numerically in MATLAB/Maple/other?
631 Views Asked by Jay https://math.techqa.club/user/jay/detail At
1
There are 1 best solutions below
Related Questions in PARTIAL-DIFFERENTIAL-EQUATIONS
- How to solve the following parabolic pde?
- How to transform this nonhomogeneous equation into a homogeneous one by change of variables?
- $L^2$-norm of a solution of the heat equation
- Navier-Stokes on concentric cylinders
- Eliminate all parameters from the differential equation $u_t-Au_x-Bu^3+Cu_{xx}=0$.
- Prove there do not exists such distribution.
- Solving a heat equaton.
- Laplace equation :mean value formula for gradient of weak solution
- Solution of the IVP $\frac{\partial{u}}{\partial{t}}+\frac{\partial^2{u}}{\partial{x^2}}=0$.
- When does a Riemaniann metric form a coercive quadratic form?
Related Questions in MATLAB
- Can I get multivariable taylor series expansion on wolfram alpha or matlab?
- How to handle complicated double integral like this numerically
- How to find the inverse of an upper triangular matrix
- System of ODEs Matrix Representation?!
- Computing columns of a pseudo-inverse
- How to do a double sum in MATLAB given the explicit values of the function
- Optimization function convex or not
- How do I use ode45 in MATLAB on this differential equation?
- Matlab code for finding the curvature of a curve using given data points
- What comes after sorting eigenvalues in PCA?
Related Questions in NONLINEAR-SYSTEM
- Radially bounded or radially unbounded
- Getting independent equations by differentiation
- A system of 1st order nonlinear ODEs with 3 varibles.
- Solving a special system of N+1 equations
- Upper bound on a sequence after a finite number of steps
- Solving for the radius of the Earth based on distance to horizon problem
- Number of solutions for an underdetermined system of nonlinear equations
- Equilibrium Points and Linearization
- Linearisation of nonlinear system of equations
- Analyzing Dynamical System
Related Questions in NUMERICAL-OPTIMIZATION
- references: L-BFGS rate of convergence
- Holding the constraints of a constrained optimization when transformed into unconstrained optimization
- Examples where constant step-size gradient descent fails everywhere?
- Convex optimization where both the region and function are ugly
- Separable linear programs
- Minimization optimization - where have I gone wrong?
- Optimization Problem Involving an Integral Equation
- How to solve a system of nonlinear Hamilton-Jacobi PDE's numerically in MATLAB/Maple/other?
- How would you find the profit maximising level of output of these 2 products?
- Maximization problem on an ellipsoid
Related Questions in HAMILTON-JACOBI-EQUATION
- Weak solutions to Hamilton Jacobi equation
- Obtaining an estimate for the Lagrangian $L=H^*$ from the Hamiltonian $H$
- Jacobi SVD algorithm implementation
- Why are PDEs with Hamiltonians usually solved on compact manifolds?
- Hamilton-Jacobi-Bellman / Multidimensional Optimal Control
- A property of Legendre transform, Chapter 3, Problem 12, Evans PDE
- Proof of KAM Theorem
- Boundary condition for HJB in infinite horizon control
- Solutions to PDE $\langle\nabla\psi,\nabla\psi+\mathbf{f} \rangle= 0$
- Hamiltonian after Co-ordinate Transformation
Trending Questions
- Induction on the number of equations
- How to convince a math teacher of this simple and obvious fact?
- Refuting the Anti-Cantor Cranks
- Find $E[XY|Y+Z=1 ]$
- Determine the adjoint of $\tilde Q(x)$ for $\tilde Q(x)u:=(Qu)(x)$ where $Q:U→L^2(Ω,ℝ^d$ is a Hilbert-Schmidt operator and $U$ is a Hilbert space
- Why does this innovative method of subtraction from a third grader always work?
- What are the Implications of having VΩ as a model for a theory?
- How do we know that the number $1$ is not equal to the number $-1$?
- Defining a Galois Field based on primitive element versus polynomial?
- Is computer science a branch of mathematics?
- Can't find the relationship between two columns of numbers. Please Help
- Is there a bijection of $\mathbb{R}^n$ with itself such that the forward map is connected but the inverse is not?
- Identification of a quadrilateral as a trapezoid, rectangle, or square
- A community project: prove (or disprove) that $\sum_{n\geq 1}\frac{\sin(2^n)}{n}$ is convergent
- Alternative way of expressing a quantied statement with "Some"
Popular # Hahtags
real-analysis
calculus
linear-algebra
probability
abstract-algebra
integration
sequences-and-series
combinatorics
general-topology
matrices
functional-analysis
complex-analysis
geometry
group-theory
algebra-precalculus
probability-theory
ordinary-differential-equations
limits
analysis
number-theory
measure-theory
elementary-number-theory
statistics
multivariable-calculus
functions
derivatives
discrete-mathematics
differential-geometry
inequality
trigonometry
Popular Questions
- How many squares actually ARE in this picture? Is this a trick question with no right answer?
- What is the difference between independent and mutually exclusive events?
- Visually stunning math concepts which are easy to explain
- taylor series of $\ln(1+x)$?
- Determine if vectors are linearly independent
- What does it mean to have a determinant equal to zero?
- How to find mean and median from histogram
- Difference between "≈", "≃", and "≅"
- Easy way of memorizing values of sine, cosine, and tangent
- How to calculate the intersection of two planes?
- What does "∈" mean?
- If you roll a fair six sided die twice, what's the probability that you get the same number both times?
- Probability of getting exactly 2 heads in 3 coins tossed with order not important?
- Fourier transform for dummies
- Limit of $(1+ x/n)^n$ when $n$ tends to infinity
Unless I'm missing something, you can just integrate backwards in time, starting at t=T. Do this by introducing a new variable t'=T-t and then your problem becomes a normal integration with a given starting condition of V1=V2=0, for all x.