matlab's out of memory error - matlab

I try to run the following code on matlab:
syms a c mu epsi real
epsi=10
eq_1=(0.5*pi^2-mu+2*epsi)*a+2*epsi*c-0.25*(3*a^3+3*a^2*c+6*a*c^2);
eq_2=(4.5*pi^2-mu+2*epsi)*c+2*epsi*a-0.25*(a^3+6*a^2*c+3*c^3);
[a_mu c_mu ]=solve(eq_1,eq_2,a,c)
N_prime=diff(0.5*(a_mu.^2+c_mu.^2),mu)
and I get the following error:
??? Error using ==> eq
Out of memory. Type HELP MEMORY for your options.
Error in ==> sym.sym>char2sym at 377
if isempty(x) || all(x == ' ') || strcmp(x,'{}')
Error in ==> sym.sym at 95
S = char2sym(x);
Error in ==> sym.maple at 92
result = sym(result,'keepijalias');
Error in ==> sym.diff at 50
R = reshape(maple('map','diff',S(:),x),size(S));
Error in ==> Untitled4 at 10
N_prime=diff(0.5*(a_mu.^2+c_mu.^2),mu)
how can I solve it?

Related

I'm trying to train the code of Target-Aware Deep Tracking in matlab

I'm for now compiling in CPU version.I am working on matlab 2020a.I've tried to remove the vl_nnconv.m from matconvnet but i still get the following error.
Also the matconvnet i'm using is version matconvnet-1.0-beta25 I'm stuck here since 2 days ,could somebody lease help me out with this issue?
https://github.com/XinLi-zn/TADT
The above is the github code i'm trying to work on.
Foloowing are the errors i'm getting:
Error using vl_nnconv
The option name is not a string (argument number 5)
Error in dagnn.Conv/forward (line 11)
outputs{1} = vl_nnconv(...
Error in dagnn.Layer/forwardAdvanced (line 85)
outputs = obj.forward(inputs, {net.params(par).value}) ;
Error in dagnn.DagNN/eval (line 91)
obj.layers(l).block.forwardAdvanced(obj.layers(l)) ;
Error in get_subwindow_feature (line 37)
net_feat.eval({'input',gpuArray(patch_sw)});
Error in tadt_tracking (line 63)
feat_groups = get_subwindow_feature(net_feat, img, sw_location, input_sz, feat_layer);
Error in Demo_TADT (line 23)
[result, fps]=tadt_tracking(seq_info.img_list, seq_info.gt(1,:), vgg16_model_path, display);
the following are the functions that is causing the error and the argument is obj.pad
function outputs = forward(obj, inputs, params)
if ~obj.hasBias, params{2} = [] ; end
outputs{1} = vl_nnconv(...
inputs{1}, params{1}, params{2}, ...
'pad', obj.pad, ...
'stride', obj.stride, ...
obj.opts{:}) ;
end

How do I use PRtools' forward feature selection in MatLab?

I am trying to apply a forward feature selection on a PRdataset. Following the syntax presented online though produces a bunch of errors that I don't quite understand and haven't been able to solve. Any ideas on what is causing them or how to fix?
Code used and resulting errors shown below:
A=prdataset(data,classes);
[w,r]=featself(A,'NN');
Error using indnn (line 50)
Trainset and testset should by identical for LOO processing
Error in fnnc (line 33)
L = indnn(a,trainset,loo);
Error in prmap (line 231)
[d,varargout{:}] = feval(mapp,a,b);
Error in * (line 14)
d = prmap(a,b);
Error in testk (line 55)
d = a*w;
Error in feateval (line 128)
J = 1 - testk(a,1);
Error in featsellr>plusl (line 182)
critval = feateval(a(:,[state.I Jsub]),crit);
Error in featsellr (line 127)
state = plusl(a,crit,t,state,fid);
Error in featself (line 56)
[w,r] = featsellr(a,crit,ksel,1,0,t);

Cannot install CVX

I try to install CVX in MATLAB but it still cannot complete. There are some error massages occurring during installation process. I have attached them already. Please see below
UNEXPECTED ERROR:
------------------------------------------------------------------------
Invalid MEX-file
'C:\Users\PAE\Downloads\Compressed\cvx-w64-tar\cvx\sdpt3\Solver\Mexfun\mexnnz.mexw64':
C:\Users\PAE\Downloads\Compressed\cvx-w64-tar\cvx\sdpt3\Solver\Mexfun\mexnnz.mexw64
is not a valid Win32 application.
.
Error in ==> checkdepconstr at 97
nnzmatold = mexnnz(AAt);
Error in ==> sqlpmain at 88
[At,b,y,indeprows,par.depconstr,feasible,par.AAt] = ...
Error in ==> sqlp at 241
[obj,X3,y,Z3,info,runhist] = ...
Error in ==> cvx_run_solver at 50
[ varargout{1:nargout} ] = sfunc( inputs{:} );
Error in ==> cvx_sdpt3>solve at 362
[ obj, xx, y, zz, info ] = cvx_run_solver( #sqlp, blk, Avec, Cvec,
b, OPTIONS, 'obj', 'x', 'y', 'z', 'info', settings, 5 ); %#ok
Error in ==> cvxprob.solve at 429
[ x, status, tprec, iters ] = shim.solve( At, b, c,
cones, quiet, prec, solv.settings, eargs{:} );
Error in ==> cvx_end at 88
solve( prob );
Error in ==> cvx_setup at 213
cvx_end
------------------------------------------------------------------------------------------
Please report this error to support, and include entire output of
CVX_SETUP in your support request.
---------------------------------------------------------------------------
I try to find the solution for this problem in GOOGLE but I cannot find it.

MATLAB: errorn in butter() command

I wrote the following function:
function [output_signal] = AddDirectivityError (bat_loc_index, butter_deg_vector, sound_matrix)
global chirp_initial_freq ;
global chirp_end_freq;
global sampling_rate;
global num_of_mics;
global sound_signal_length;
for (i=1 : num_of_mics)
normalized_co_freq = (chirp_initial_freq + chirp_end_freq)/ (1.6* sampling_rate);
A=sound_matrix ( i, : ) ;
peak_signal=max(A);
B=find(abs(A)>peak_signal/100);
if (butter_deg_vector(i)==0)
butter_deg_vector(i)=2;
end
[num, den] = butter(butter_deg_vector(i), normalized_co_freq, 'low');// HERE!!!
filtered_signal=filter(num,den, A );
output_signal(i, :)=filtered_signal;
end
This functions runs many-many times without any error. However, when I reach the line: [num, den] = butter ( butter_deg_vector(i), normalized_co_freq, 'low');
And the local variables are: i=3, butter_deg_vector(i)=1, normalized_co_freq=5.625000e-001
MATLAB prompts an error says:
??? Error using ==> buttap Expected N to be integer-valued.
"Error in ==> buttap at 15 validateattributes(n,{'numeric'},{'scalar','integer','positive'},'buttap','N');
Error in ==> butter at 70 [z,p,k] = buttap(n);"
I don't understand why this problem occurs especially in this iteration. Why does this function prompt an error especially in this case?
Try to change the code line for:
[num, den] = butter (round(butter_deg_vector(i)), normalized_co_freq, 'low');

matlab fails deployment in internal code

I want to compile a gui matlab project, but fail because of this error which is not in my code
Subscript indices must either be real positive integers or logicals.
Error in isscript (line 7)
if strcmpi(pth(end-1:end), '.m') && exist(pth, 'file') == 2
Error in matlab.depfun.internal.Schema/move/#(setMembers)setMembers(~isscript(setMembers))
Error in matlab.depfun.internal.Schema>applyMoveFcn (line 987)
keptFiles = fcn(fileList);
Error in matlab.depfun.internal.Schema>#(files,destMap)applyMoveFcn(op,files,destMap,destSet,reason,rule) (line 822)
#(files, destMap)applyMoveFcn(op, files, destMap, ...
Error in matlab.depfun.internal.Schema/applySetRules (line 141)
xformedSet = feval(operations{n}, xformedSet, rMap);
Error in matlab.depfun.internal.Completion/applySetRules (line 1059)
[modifiedList, rMap] = ...
Error in matlab.depfun.internal.Completion/initializeRootSet (line 1142)
[addedFiles, ruleFilter, notes] = ...
Error in matlab.depfun.internal.Completion (line 1601)
obj.RootSet = initializeRootSet(obj, files);
Error in matlab.depfun.internal.requirements (line 166)
c = matlab.depfun.internal.Completion(files, tgt);
Error in appcreate.internal.appbuilder.getDependencyList (line 173)
[dependentfiles, depproducts, ~] = matlab.depfun.internal.requirements(varargin, 'MATLAB');
How can I get matlab (2013b) to compile the package?
The code where matlab fails is (which is NOT my code)
function tf = isscript(files)
% ISSCRIPT Is the file a script file?
tf = false(1,numel(files));
for k=1:numel(files)
pth = files{k};
% Can't be a script if it isn't an M-file.
if strcmpi(pth(end-1:end), '.m') && exist(pth, 'file') == 2
mt = matlab.depfun.internal.cacheMtree(pth);
fcn = mtfind(mt, 'Kind', 'FUNCTION');
tf(k) = isempty(fcn);
end
end
The code will fail for files with a filename of length 1. Either rename all files with such a short filename or change the line to:
if length(pth)>1 && strcmpi(pth(end-1:end), '.m') && exist(pth, 'file') == 2