MaplePrimes Questions

For implicitplot of say (cos(\theta))^2, I had to use 'factor' in the options for the plot so that it considers cos(theta) also while plotting. But I couldn't do the same in implicitplot3d. How can I achieve this plotting of all factors of a function for implicitplot3d?

this is the matlab is it possible to rewrite it in simple maple code

J = rand()+1e-10;

function [M, num, E] = ising(N,J)

B = 0;

M = []; % The total magnetic field of the system

E = []; % The total energy of the system

randTol = 0.1; % The tolerance, dampens the spin flip process

% First we generate a random initial configuration

spin = (-1).^(round(rand(N)));

% Then we let the system evolve for a fixed number of steps

for i=1:1000,

% Calculating the total spin of neighbouring cells

neighbours = circshift(spin, [ 0 1]) + ...

circshift(spin, [ 0 -1]) + ...

circshift(spin, [ 1 0]) + ...

circshift(spin, [-1 0]);

% Calculate the change in energy of flipping a spin

DeltaE = 2 * (J*(spin .* neighbours) + B*spin);

% Calculate the transition probabilities

p_trans = exp(-DeltaE);

% Decide which transitions will occur

transitions = (rand(N) < p_trans ).*(rand(N) < randTol) * -2 + 1;

% Perform the transitions

spin = spin .* transitions;

% Sum up our variables of interest

M = sum(sum(spin));

E = -sum(sum(DeltaE))/2; % Divide by two because of double counting

% Display the current state of the system (optional)

image((spin+1)*128);

xlabel(sprintf('J = %0.2f, M = %0.2f, E = %0.2f', J, M/N^2, E/N^2));

set(gca,'YTickLabel',[],'XTickLabel',[]);

axis square; colormap bone; drawnow;

end

% Count the number of clusters of 'spin up' states

[L, num] = bwlabel(spin == 1, 4);

############################# 

For people new to Maple, an easy way to learn how to code may be Tutor Syntax, that is the technique of generating code by selecting everything in a Tutor dialog Maple Command window and then copying it to a current session.

The code can then be edited to tailor it to user’s needs. A problem with this technique is the copied syntax contains many single quotes (‘ ‘). The single quotes, which are usually not needed if the program in current session is short and specific, increase the difficulty when editing copied syntax. The attached file (mby2.mw) shows a method which removes the single quotes by using the SubstitueAll command in the StringTools package. One drawback: any strings inside the original syntax (e.g., “#78000E”) must be removed before the syntax can be converted to a string.

Is there a better way to generate code from Tutor dialog so it can be edited (without single quotes) in user’s current session?

mby2.mw

hi.please help me for remove error'' 

Error, illegal use of an object as a name''

 

thanks

PLATE.mw

   

Parse:-ConvertTo1D, "first argument to _Inert_ASSIGN must be assignable"

Error, illegal use of an object as a name

"restart:Digits :=15: beta:=10:alpha:=100: xi:=.5: upsilon:=0.2841945289:n:=3: aa:=1:b:=1:N_x:=0.4:N_y:=0.4:N_xy:=0: hl2:=1:mu:=65.8e9:E:=169e9: delta0:=1:delta1:=1: mus:=3:D1:=2;h:=1: lambda:=0.1: D2:=5:A1:=-2:A2:=-2:A3:=-6:A4:=7:A5:=7:A6:=7:A7:=7:A8:=8:A9:=7:A10:=7:A11:=1: A12:=1:tau:=4.730040745:t:=0: g2:=sin(theta):g3:=cos(theta):g1:=cos(theta):a:=0.0:with(Student[Calculus1]): a1:=evalf((A1*ApproximateInt(g3^2,theta=a..1,method=simpson)  ) ) : a2:= evalf(A2*ApproximateInt(g3*((&DifferentialD;)^2)/((&DifferentialD;theta)^2)g3,theta=a..1,method=simpson)): a3:=evalf(A3*ApproximateInt(g3*g3,theta=a..1,method=simpson)) : a4:=evalf(A4*ApproximateInt(g3*g3,theta=a..1,method=simpson)) :a5:=evalf(A5*ApproximateInt(g3^2,theta=a..1,method=simpson)) : a6:=evalf(A6*ApproximateInt(((&DifferentialD;)^2)/((&DifferentialD;theta)^2)g3*g3,theta=a..1,method=simpson)) :a7:=evalf(A7*ApproximateInt(g3*g3,theta=a..1,method=simpson)): a8:=evalf(A8*ApproximateInt(g3^2,theta=a..1,method=simpson)):a9:=evalf(ApproximateInt(A9*(g3*g3 )     ,theta=a..1,method=simpson)) :a10:=evalf(A10*ApproximateInt(g3*g3,theta=a..1,method=simpson)):a11:=evalf(ApproximateInt(1,theta=a..1,method=simpson)):a12:=evalf(ApproximateInt(1*(1-1/2 (1)),theta=a..1,method=simpson)):dsys3 := { f3(x)*(a1)+ f3(x)*(a2)  +((&DifferentialD;)^2)/((&DifferentialD;x)^2) f3(x)*(a3) +f3(x)*a4+ f3(x)*(a5) +((&DifferentialD;)^2)/((&DifferentialD;x)^2) f3(x)*(a6) +f3(x)*a7= ((&DifferentialD;)^2)/((&DifferentialD;x)^2) f3(x) *(a8)   + a9*(&DifferentialD;)/(&DifferentialD;x) f3(x) +f3(x)*a10+ a11+a12  , f3(1) =0,f3(0) =0 , D^(1)(f3)(1) = 0, D^(1)(f3)(0)=0,D^(3)(f3)(1) = 0, D^(3)(f3)(0)=0}    :dsol5 := dsolve(dsys3, 'maxmesh'=2024, numeric,abserr=.0001, range=0..1, output=listprocedure):fy3:= eval(f3(x),dsol5):with(CurveFitting):fy33:=PolynomialInterpolation([[0,fy3(0)],[.1,fy3(0.1)],[.2,fy3(0.2)],[0.3,fy3(0.3)],[.4,fy3(0.4)],[.5,fy3(0.5)],[0.6,fy3(0.6)],[0.7,fy3(0.7)],[0.8,fy3(0.8)],[0.9,fy3(0.9)],[1,fy3(1)]],x): d1:=A1*ApproximateInt(((&DifferentialD;)^6)/((&DifferentialD;x)^6)fy33*fy33,x=a..1,method=simpson)   :d2:= A2*ApproximateInt(((&DifferentialD;)^4)/((&DifferentialD;x)^4)fy33*fy33 ,x=a..1,method=simpson)   :d3:=A3*ApproximateInt(((&DifferentialD;)^2)/((&DifferentialD;x)^2)fy33*fy33,x=a..1,method=simpson): d4:= A4*ApproximateInt(fy33*fy33,x=a..1,method=simpson):d5:=A5*ApproximateInt(((&DifferentialD;)^4)/((&DifferentialD;x)^4)fy33*fy33,x=a..1,method=simpson)  : d6:=A6*ApproximateInt(((&DifferentialD;)^2)/((&DifferentialD;x)^2)fy33*fy33,x=a..1,method=simpson)    :d7:=A7*ApproximateInt(fy33*fy33,x=a..1,method=simpson)  :d8:=A8*ApproximateInt(((&DifferentialD;)^2)/((&DifferentialD;x)^2)fy33*fy33,x=a..1,method=simpson)      :d9:=ApproximateInt(A9*(((&DifferentialD;)^1)/((&DifferentialD;x)^1)fy33*fy33 )   ,x=a..1,method=simpson) :d10:=A10*ApproximateInt(fy33*fy33,x=a..1,method=simpson)    :d11:=evalf(ApproximateInt(1,theta=a..1,method=simpson)):d12:=evalf(ApproximateInt(1*(1-1/2 (1)),theta=a..1,method=simpson))  : d sys4 := { h3(theta)*(d1)+((&DifferentialD;)^2)/((&DifferentialD;theta)^2) h3(theta)*(d2)+((&DifferentialD;)^4)/((&DifferentialD;theta)^4) h3(theta)*(d3)+ ((&DifferentialD;)^6)/((&DifferentialD;theta)^6) h3(theta)*(d4)+h3(theta) *(d5)+ h3(theta) *(d6) +((&DifferentialD;)^4)/((&DifferentialD;theta)^4) h3(theta)*(d7)= h3(theta)*(d8)  +d9*(&DifferentialD;)/(&DifferentialD;theta) h3(theta)  +((&DifferentialD;)^2)/((&DifferentialD;theta)^2) h3(theta)*(d10)  +d11+d12   ,h3(1) = 0,h3(0) = 0 , D^(1)(h3)(1) = 0, D^(1)(h3)(0)=0,D^(3)(h3)(1) = 0, D^(3)(h3)(0)=0}  :dsol6 := dsolve(dsys4, 'maxmesh'=2024, abserr=.0001, range=0..1, numeric, output=listprocedure):g33:= eval(h3(theta),dsol6):with(CurveFitting):g3:=PolynomialInterpolation([[0,g33(0)],[.1,g33(0.1)],[.2,g33(0.2)],[0.3,g33(0.3)],[.4,g33(0.4)],[.5,g33(0.5)],[0.6,g33(0.6)],[0.7,g33(0.7)],[0.8,g33(0.8)],[0.9,g33(0.9)],[1,g33(1)]],theta):"

 

 

``

 

Download PLATE.mw

When the Physics package is loaded, Maple returns the following error in connection with the simple statement 2*D[1]:

Error, (in TypeTools/ac_var_local) unable to determine the anticommutative character of D[1]

Why that? Although to no avail, for D[1] there is no problem. Note that the above error results even without having set up any anticommutative prefixes or the likes in Physics Setup.

PS: I am using Maple 17.

Hi,
I would like to present you a recurring problem of mine.

Context:

It is very common, in Modeling and Simulation activities, to account for Uncertainties.

In order to set these ideas down, consider a computational code F (typically a code that solves a set of PDEs in space (M) and time (t) ) and its response Y = F(M,t) (here Y is a short for Y(M,t)).

This response Y usually depends also on some set P of parameters (each of them considered as a scalar quantity) .
A more convenient way to note Y  is Y(M, t | P) where the "|" character is used here to express that Y is considered as a function of M and t for each given value of P.
Generally one does not consider Y as a whole but more often one focuses on some quantity of interest (Q) derived from Y through applying it some operator G (for example the operator max(Y) over some space and time domain).

Applying G generally makes  Q to appear as a function of P alone.
In Uncertainty Quantification activities, a major concern is to understand how uncertainties about P modify the values of Q ?
The classical framework is to consider P as a (multi-dimensionnal) random variable. 
One of the most common problems is then to assess some basic characteristics of Q, where Q is considered as a function of P (a quick and notional notation is Q = H(P) = (G°F)(X, t | P)).

The simpler and faster method to do this is based on a Taylor expansion of H (provided some conditions hold) arround some particular point p* (p* could be the mean of the multi-dimensional distribution of P)
One writes, for every value p of P :

Q = H(p) = H(p*) + (H')t (p-p*) + 1/2 (p-p*)t H" (p-p*) ...

where
  H'  is the gradient vector of H according to P at point P = p*
  H" is the hessian matrix of H according to P at point P = p*
  (p-p*) is the vector of differences, assumed to be "small"

Let E the usual "mathematical expectation" operator.
Let us assume  p* denotes the mean of P.
Then, applying E to  the previous formula gives :

E(Q) = E(H(p*)) + E(...) + ....

Assuming some conditions hold, the first order mathematical expectation E(Q) of Q is simply E(H(p*)) = H(p*) = H(E(P))

Some little algebra gives the first order approximation of the variance V(Q) = E(Q^2)-(E(Q))^2 of Q : 

V(Q) = (H')V(P) H'  where V(P) is the variance matrix of P

-----------------------------------------------------------------------------------------------------------------------

Problem

I would like to define the operator E so that I could derive automatically approximations of the first 4 moments of Q, up to any desired order.
In particular, order 2 is often necessary as soon as (G°F) is highly non linear regarding P ; and estimations of the 3rd and 4th moments is of great help to determine how much symetric or flat is the distribution of Q.

The idea is to define an operator E with suitable properties and to apply it to a multivariate taylor expansion of Q^n where n is any positive integer

I tried to do this by my own (look to the supplied .mw file) but I do not have sufficient skill in Maple to complete the job.

Could someone help me ?

Even if I am not qualified in saying this, I believe that this type of approximation of the different moments of Q could be included in a future release of Maple ?


Thanks in advance 

 

Download MathematicalExpectation.mw








 

The expression (D[1]@D[2])(f) is equivalent to D[1,2](f). On grounds of that, I would naively have expected that (D[1]@D[1])(f) was equivalent to D[1,1](f). But it seems not to be, their lprint-versions being different:

expr1 := (D[1]@D[1])(f):
expr2 := D[1,1](f):
simplify(expr1 - expr2);
simplify(expr1 - expr2,`@`);
lprint(expr1);
lprint(expr2);

(D[1]@@2)(f)
D[1, 1](f)

I am curious to know why it has been implemented this way? Have I fundamentally misunderstood something?

I'm working in a tridimensional euclidean space, with vectorial functions of the type:

Fi(t)=<fix(t),fiy(t),fiz(t)>

Fi'(t)=<fix'(t),fiy'(t),fiz'(t)>

The two odes are of the type:

ode1:=K1*F1''(t)=K2*F2(t)&xF3(t)+...

While there are other non-differential vectorial equations like:

eq1:=K4*F4''(t)=(K5*F5(t)&x<0,1,0>)/Norm(F6(t))+..., etc

 

Is there a way i can input this system in dsolve with vectors instead of scalars? And without splitting everything into its 3 vectorial components? I can't make maple realize some of the Fi(t) functions are vectors, it counts them as scalars and says the number of functions and equations are not the same.

 

Thank you!

Hi

Hope a nice day for all

restart;

#  *%   define the product of between two operators, and q real number
a*%b = q*b*%a+1;

# First I would like to give a simple for

 a^n*%b;
# and                                    
a*%b^n;

them deduce a general for                                      

b^n*%a^k*%b^N*%a^K-q^(k*N-n*K)*b^N*%a^K*%b^n*%a^k;

 where n, k and k greater than 1 and  n geater than k

Simplification.mw

 

Thanks for your help


 


If I am in the Maple debugger, stopped in a routine, how can I navigate between stack frames, such as looking at the variables of the calling function?

"outfrom" is not sufficient for this purpose as that continues execution until return, which would change the variables of the routine I am in, and could potentially take a long time. And more importantly for my particular purpose, the routine I am stopped in is a package's "I found an error" routine which is (deliberately) throwing an exception, so there will not be any return.

I can use where or where? to look at the name of the calling routines. Unfortunately, for the code I am debugging, the calling routine is being dynamically loaded so I do not have a file name for it and I cannot put a persistent breakpoint in it: I need to climb the tree of dynamic calls with their various parameters in order to figure out how the error occured.

Hi all

Is Ising a package?

for i = 1:12000

%while (1),

% Choose a random value between 0 and 1 for the interaction strength

J = rand()+1e-10;

% Perform a simulation

[M, N, E] = ising2(n_grid, J);

% Records the results

Ms = [Ms M/(n_grid^2)];

Es = [Es E/(n_grid^2)];

Ns = [Ns N];

Js = [Js J];

i = i+1;

Is there an elegant way to plot the region between the surfaces z=-y^2 and z=x^2, only on the domain of the XY-plane bounded by the triangle with vertices (0,0), (1,0) and (1,1)?

I am trying to simplify the square of a parameterized polynomial mod 2. My parameters are intended to be either 0 or 1. How do I accomplish this?

For example:

 

alias(alpha = RootOf(x^4+x+1))

alpha

(1)

z := alpha^3*a[3]+alpha^2*a[2]+alpha*a[1]+a[0]``

a[3]*alpha^3+a[2]*alpha^2+a[1]*alpha+a[0]

(2)

z2 := collect(`mod`(Expand(z^2), 2), alpha)

a[3]^2*alpha^3+(a[1]^2+a[3]^2)*alpha^2+a[2]^2*alpha+a[0]^2+a[2]^2

(3)

``

``

 

Download Polynomial_Mod_2.mw

 

I would like to simplify the squared parameters modulo 2. a[3]^2=a[3], etc.

Any help would be appreciated. Elegant methods even more so!

Regards.

 

 

 

 

How can i over come convergence error, i am unable to apply approxsoln appropriately and continouation as well. regards

N := 5;

-(1/2)*Pr*n*x*(diff(f(x), x))*(diff(theta(x), x))-(1/2)*Pr*(n+1)*f(x)*(diff(theta(x), x))-(1/2)*(n+1)*(diff(diff(theta(x), x), x))+Pr*gamma*((1/4)*(n^2-3*n+3)*x^2*(diff(f(x), x))*(diff(diff(f(x), x), x))*(diff(theta(x), x))+(1/4)*(2*n^2+5*n+3)*f(x)*(diff(f(x), x))*(diff(theta(x), x))+(1/4)*n(n+1)*x*f(x)*(diff(diff(f(x), x), x))*(diff(theta(x), x))+(1/4)*(2*n^2+3*n-3)*x*(diff(f(x), x))^2*(diff(theta(x), x))+(1/4)*(n-1)*x^2*(diff(diff(f(x), x), x))*(diff(theta(x), x))+(1/2)*n*(n+1)*x*f(x)*(diff(f(x), x))*(diff(diff(theta(x), x), x))+(1/4)*(n^2-1)*(diff(f(x), x))^2*(diff(theta(x), x))+(1/4)*(n+1)^2*f(x)^2*(diff(diff(theta(x), x), x))+(1/4)*(n-1)^2*x^2*(diff(f(x), x))^2*(diff(diff(theta(x), x), x))) = 0

(1)

bc := (D(theta))(0) = -Bi*(1-theta(0)), theta(N) = 0, f(0) = 0, (D(f))(0) = 0, (D(f))(N) = 1;

(D(theta))(0) = -Bi*(1-theta(0)), theta(5) = 0, f(0) = 0, (D(f))(0) = 0, (D(f))(5) = 1

(2)

a1 := dsolve(subs(beta = .1, n = .5, Pr = 10, gamma = .1, Bi = 50, {bc, eq1, eq2}), numeric, method = bvp[midrich], abserr = 10^(-8), output = array([seq(.1*i, i = 0 .. 10*N)]))

Error, (in dsolve/numeric/BVPSolve) initial Newton iteration is not converging

 

``

 

Download ehtasham.mwehtasham.mw

This week I am participating in 19th Ising lectures (see https://drive.google.com/folderview?id=0B0uPwoK-03XgSEZpYWljYnpXN0U&usp=sharing). The Serguei Nechaev's talk inspired me to ask the question:
"How to simulate a random walk on an undirected and unweighted (and, of course, connected) graph
(All the paths from a vertex of degree k have the same probability 1/k.)?"
A Maple procedure to this end is welcome.

First 1125 1126 1127 1128 1129 1130 1131 Last Page 1127 of 2434