getfem-commits
[Top][All Lists]
Advanced

[Date Prev][Date Next][Thread Prev][Thread Next][Date Index][Thread Index]

[Getfem-commits] [getfem-commits] branch devel-yves-octave updated: A gl


From: Yves Renard
Subject: [Getfem-commits] [getfem-commits] branch devel-yves-octave updated: A globally working octave interface
Date: Sat, 18 Apr 2020 16:10:54 -0400

This is an automated email from the git hooks/post-receive script.

renard pushed a commit to branch devel-yves-octave
in repository getfem.

The following commit(s) were added to refs/heads/devel-yves-octave by this push:
     new b88a80f  A globally working octave interface
b88a80f is described below

commit b88a80f7dbb187fd15497446ceba1b0d4a3c7bd5
Author: Yves Renard <address@hidden>
AuthorDate: Sat Apr 18 22:10:25 2020 +0200

    A globally working octave interface
---
 bin/extract_doc                                    |  5 ++++-
 configure.ac                                       |  4 ++--
 interface/src/getfemint_gsparse.h                  | 16 ++++++++++++++-
 interface/src/gf_asm.cc                            |  2 +-
 interface/src/gf_compute.cc                        |  2 +-
 interface/src/gf_mesh_fem_get.cc                   |  2 +-
 interface/src/octave/gfObject.m                    |  2 +-
 interface/src/octave/gf_asm_pdetoolbc.m            |  4 ++--
 interface/src/octave/gf_mesh_fem_get_eval.m        |  2 +-
 interface/src/octave/gf_plot.m                     | 18 ++++++++--------
 interface/src/octave/gf_plot_mesh.m                |  2 +-
 interface/src/octave/gf_plot_slice.m               | 24 +++++++++++-----------
 interface/src/octave/gfm_common.c                  |  5 ++---
 interface/tests/Makefile.am                        |  2 +-
 .../tests/{matlab => matlab-octave}/Makefile.am    |  0
 .../tests/{matlab => matlab-octave}/axrot_matrix.m |  0
 .../tests/{matlab => matlab-octave}/check_all.m    |  0
 .../{matlab => matlab-octave}/check_all_matlab.sh  |  0
 .../{matlab => matlab-octave}/check_all_octave.sh  |  0
 .../tests/{matlab => matlab-octave}/check_asm.m    |  0
 .../tests/{matlab => matlab-octave}/check_fem.m    |  0
 .../{matlab => matlab-octave}/check_geotrans.m     |  0
 .../tests/{matlab => matlab-octave}/check_integ.m  |  2 +-
 .../check_interpolated_fem.m                       |  0
 .../{matlab => matlab-octave}/check_levelset.m     |  0
 .../{matlab => matlab-octave}/check_mesh_fem.m     | 11 +++++-----
 .../tests/{matlab => matlab-octave}/check_mitc.m   |  0
 .../tests/{matlab => matlab-octave}/check_oo.m     |  0
 .../{matlab => matlab-octave}/check_plasticity.m   |  0
 .../tests/{matlab => matlab-octave}/check_plot.m   |  0
 .../tests/{matlab => matlab-octave}/check_slices.m |  0
 .../tests/{matlab => matlab-octave}/check_spmat.m  | 16 +++++++++------
 .../{matlab => matlab-octave}/check_workspace.m    |  0
 .../demo_Mindlin_Reissner_plate.m                  |  0
 .../{matlab => matlab-octave}/demo_Navier_Stokes.m |  0
 .../demo_Nitsche_contact_by_hand.m                 |  0
 .../{matlab => matlab-octave}/demo_bilaplacian.m   |  0
 .../demo_contact_fictitious_domain_nitsche.m       |  0
 .../{matlab => matlab-octave}/demo_continuation.m  |  0
 .../demo_convection_rotating_cavity.m              |  0
 .../tests/{matlab => matlab-octave}/demo_crack.m   |  0
 .../demo_dynamic_contact.m                         |  0
 .../demo_dynamic_plasticity.m                      |  0
 .../demo_dynamic_plasticity_with_contact.m         |  0
 .../{matlab => matlab-octave}/demo_elasticity.m    |  0
 .../demo_fictitious_domains.m                      |  0
 .../demo_fictitious_domains_laplacian.m            |  0
 .../{matlab => matlab-octave}/demo_laplacian.m     |  0
 .../{matlab => matlab-octave}/demo_laplacian_DG.m  |  0
 .../demo_laplacian_pyramid.m                       |  0
 .../demo_large_sliding_contact.m                   |  0
 .../demo_mesh_generation.m                         |  0
 .../tests/{matlab => matlab-octave}/demo_mortar.m  |  0
 .../demo_nonlinear_elasticity.m                    |  0
 .../demo_nonlinear_elasticity_anim.m               |  0
 .../demo_periodic_laplacian.m                      |  0
 .../{matlab => matlab-octave}/demo_plasticity.m    |  0
 .../tests/{matlab => matlab-octave}/demo_refine.m  |  0
 .../demo_static_contact.m                          |  0
 .../{matlab => matlab-octave}/demo_step_by_step.m  |  0
 .../demo_stokes_3D_tank.m                          |  0
 .../demo_stokes_3D_tank_draw.m                     |  2 +-
 .../demo_structural_optimization.m                 |  0
 .../demo_thermo_elasticity_electrical_coupling.m   |  0
 .../demo_topological_optimization.m                |  0
 .../tests/{matlab => matlab-octave}/demo_tripod.m  |  0
 .../{matlab => matlab-octave}/demo_tripod_alt.m    |  0
 .../demo_tripod_slice_anim.m                       |  0
 .../tests/{matlab => matlab-octave}/demo_wave2D.m  |  0
 .../{matlab => matlab-octave}/demo_wave2D_alt.m    |  0
 .../demo_wave2D_animate.m                          |  0
 .../{matlab => matlab-octave}/demo_wave_equation.m |  0
 .../{matlab => matlab-octave}/demo_wheel_contact.m |  0
 .../tests/{matlab => matlab-octave}/plate_Impact.m |  0
 .../{matlab => matlab-octave}/private/Makefile.am  |  0
 .../{matlab => matlab-octave}/private/asserterr.m  |  0
 .../{matlab => matlab-octave}/private/gfassert.m   |  0
 .../test1_nitsche_large_sliding.m                  |  0
 .../test2_nitsche_large_sliding.m                  |  0
 .../tests/{matlab => matlab-octave}/test_argyris.m |  0
 .../tests/{matlab => matlab-octave}/tripod_anim.m  |  0
 .../tests/{matlab => matlab-octave}/tutorial1.m    |  0
 .../tests/{matlab => matlab-octave}/uAnalytic.m    |  0
 83 files changed, 71 insertions(+), 50 deletions(-)

diff --git a/bin/extract_doc b/bin/extract_doc
index 81e42e5..4a0dcaa 100755
--- a/bin/extract_doc
+++ b/bin/extract_doc
@@ -859,7 +859,7 @@ elif (option == 'matlab-com'):
 #
 #
 # Option octave-com
-#      Extract the matlab commands, produces m-files and Matlab object
+#      Extract the octave commands, produces m-files and Octave object
 #      sub directories.
 #
 #
@@ -934,6 +934,9 @@ elif (option == 'octave-com'):
         mfile.write('    if (isobject(varargin{i})) \n');
         mfile.write('      varargin{i} = struct(varargin{i}); \n');
         mfile.write('    endif \n');
+        mfile.write('    if (islogical(varargin{i})) \n');
+        mfile.write('      varargin{i} = round(varargin{i}); \n');
+        mfile.write('    endif \n');
         mfile.write('  endfor \n');
         mfile.write('  if (nargout),\n')
         mfile.write('    [varargout{1:nargout}]=gf_octave(\'' + o + ext + '\', 
varargin{:});\n')
diff --git a/configure.ac b/configure.ac
index e504ab5..eee842d 100644
--- a/configure.ac
+++ b/configure.ac
@@ -1184,8 +1184,8 @@ interface/src/scilab/Makefile                             
              \
 interface/src/scilab/sci_gateway/c/builder_gateway_c.sce                \
 interface/tests/Makefile                                                \
 interface/tests/meshes/Makefile                                         \
-interface/tests/matlab/Makefile                                         \
-interface/tests/matlab/private/Makefile                                 \
+interface/tests/matlab-octave/Makefile                                  \
+interface/tests/matlab-octave/private/Makefile                          \
 interface/tests/python/Makefile                                         \
 getfem-config                                                           \
 getfem-config-notinstalled                                              \
diff --git a/interface/src/getfemint_gsparse.h 
b/interface/src/getfemint_gsparse.h
index 341d67f..be5e799 100644
--- a/interface/src/getfemint_gsparse.h
+++ b/interface/src/getfemint_gsparse.h
@@ -83,12 +83,26 @@ namespace getfemint
     t_cscmat_r& real_csc_w(t_cscmat_r *p=0)
     { if (p) { v = REAL; pcscmat_r = p; } return *pcscmat_r; }
     t_cscmat_ref_c cplx_csc() { 
-      if (gfimat && gfi_array_is_complex(gfimat)) 
+      if (gfimat && gfi_array_is_complex(gfimat)) {
+        // unsigned nc = gfi_array_get_dim(gfimat)[1];
+        // cout << "jc = [";
+        // for (unsigned i = 0; i <= nc; ++i)
+        //   cout << (gfi_sparse_get_jc(gfimat))[i] << ", ";
+        // cout << "]" << endl;
+        // cout << "ir = [";
+        // for (unsigned i = 0; i < (gfi_sparse_get_jc(gfimat))[nc]; ++i)
+        //   cout << (gfi_sparse_get_ir(gfimat))[i] << ", ";
+        // cout << "]" << endl;
+        // cout << "pr = [";
+        // for (unsigned i = 0; i < 2*(gfi_sparse_get_jc(gfimat))[nc]; ++i)
+        //   cout << (gfi_sparse_get_pr(gfimat))[i] << ", ";
+        // cout << "]" << endl;
         return t_cscmat_ref_c((complex_type*)gfi_sparse_get_pr(gfimat), 
                               gfi_sparse_get_ir(gfimat), 
                               gfi_sparse_get_jc(gfimat),
                               gfi_array_get_dim(gfimat)[0],
                               gfi_array_get_dim(gfimat)[1]);
+      }
       else if (pcscmat_c)
         return t_cscmat_ref_c(&pcscmat_c->pr[0], &pcscmat_c->ir[0],
                               &pcscmat_c->jc[0], 
diff --git a/interface/src/gf_asm.cc b/interface/src/gf_asm.cc
index 668f46c..a223b15 100644
--- a/interface/src/gf_asm.cc
+++ b/interface/src/gf_asm.cc
@@ -1488,7 +1488,7 @@ void gf_asm(getfemint::mexargs_in& m_in, 
getfemint::mexargs_out& m_out) {
 }
 
 /*@MATLABEXT
-  if (nargin>=1 & strcmpi(varargin{1},'pdetool boundary conditions')),
+  if (nargin>=1 && strcmpi(varargin{1},'pdetool boundary conditions')),
     [varargout{1:nargout}]=gf_asm_pdetoolbc(varargin{[1 3:nargin]}); return;
   end;
   @*/
diff --git a/interface/src/gf_compute.cc b/interface/src/gf_compute.cc
index 0e3cd42..38ec3fd 100644
--- a/interface/src/gf_compute.cc
+++ b/interface/src/gf_compute.cc
@@ -650,7 +650,7 @@ void gf_compute(getfemint::mexargs_in& m_in, 
getfemint::mexargs_out& m_out) {
   >> pcolor(squeeze(Uq(1,:,:)));
  @*/
 /*@MATLABEXT
-  if (nargin>=3 & strcmpi(varargin{3}, 'interpolate on Q1 grid')),
+  if (nargin>=3 && strcmpi(varargin{3}, 'interpolate on Q1 grid')),
     [varargout{1:nargout}]=gf_compute_Q1grid_interp(varargin{[1 2 4:nargin]});
     return;
   end;
diff --git a/interface/src/gf_mesh_fem_get.cc b/interface/src/gf_mesh_fem_get.cc
index 703e842..03abb0c 100644
--- a/interface/src/gf_mesh_fem_get.cc
+++ b/interface/src/gf_mesh_fem_get.cc
@@ -1008,7 +1008,7 @@ void gf_mesh_fem_get(getfemint::mexargs_in& m_in,
 
   @*/
 /*@MATLABEXT
-  if (nargin>=2 & strcmpi(varargin{2},'eval')),
+  if (nargin>=2 && strcmpi(varargin{2},'eval')),
     [varargout{1:nargout}]=gf_mesh_fem_get_eval(varargin{[1 3:nargin]}); 
return;
   end;
   @*/
diff --git a/interface/src/octave/gfObject.m b/interface/src/octave/gfObject.m
index c18453d..4c1a5e2 100644
--- a/interface/src/octave/gfObject.m
+++ b/interface/src/octave/gfObject.m
@@ -20,7 +20,7 @@ function b=gfObject(a)
     b=[];
   elseif (isobject(a))
     b=a;
-  elseif (isstruct(a) & numel(a))
+  elseif (isstruct(a) && numel(a))
     sclass = gf_workspace('class name',a(1));
     b=feval(sclass,a);
   else error('neither an object nor a struct');
diff --git a/interface/src/octave/gf_asm_pdetoolbc.m 
b/interface/src/octave/gf_asm_pdetoolbc.m
index 66bd81a..0be27c5 100644
--- a/interface/src/octave/gf_asm_pdetoolbc.m
+++ b/interface/src/octave/gf_asm_pdetoolbc.m
@@ -31,7 +31,7 @@ function [Q,G,H,R,F]=gf_asm_pdetoolbc(mf_u, mf_d, b, e, 
f_expr)
     error(sprintf(['the boundary condition b was generated for a %d-D problem, 
'...
                   'while the Qdim of the mesh_fem is %d'], N, qdim));
   end;
-  if (nargin >= 5 & qdim ~= size(f_expr,1)),
+  if (nargin >= 5 && qdim ~= size(f_expr,1)),
     error('the qdim of the mesh fem and the size of f (the volumic source 
term) do not match');
   end;
   if (gf_mesh_fem_get(mf_d, 'qdim') ~= 1),
@@ -137,7 +137,7 @@ function [Q,G,H,R,F]=gf_asm_pdetoolbc(mf_u, mf_d, b, e, 
f_expr)
   end;
 
   % check for volumic source term
-  if (nargin == 5 & nargout == 5),
+  if (nargin == 5 && nargout == 5),
     if (isstr(f_expr)),
       Fd = zeros(N,nbdof);
       for i=1:N
diff --git a/interface/src/octave/gf_mesh_fem_get_eval.m 
b/interface/src/octave/gf_mesh_fem_get_eval.m
index 8fae17f..528d500 100644
--- a/interface/src/octave/gf_mesh_fem_get_eval.m
+++ b/interface/src/octave/gf_mesh_fem_get_eval.m
@@ -34,7 +34,7 @@ function X=gf_mesh_fem_get_eval(mf, what, dof)
   end;
   dxy = gf_mesh_fem_get(mf, 'basic dof nodes',dof);
   
-  if (size(what, 2) == nbdof & isnumeric(what)),
+  if (size(what, 2) == nbdof && isnumeric(what)),
     X = what;
     return;
   elseif (ischar(what))
diff --git a/interface/src/octave/gf_plot.m b/interface/src/octave/gf_plot.m
index 5128a0b..1798b20 100644
--- a/interface/src/octave/gf_plot.m
+++ b/interface/src/octave/gf_plot.m
@@ -80,7 +80,7 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
     return;
   end;
   
-  if (mdim ~= 2 & mdim ~= 3),
+  if (mdim ~= 2 && mdim ~= 3),
     error('only 2D and 3D mesh are handled by this function');
   end;
   
@@ -135,14 +135,14 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
   end;
   scalarplot_dir=opt.dir(:);
   if (qdim == 1) is_scalarplot = 1; scalarplot_dir=1; end;
-  if (~isempty(opt.contour) & ~is_scalarplot),
+  if (~isempty(opt.contour) && ~is_scalarplot),
     error('contour plot has no meaning for a vector field');
   end;
   mfdef = mf;
   if (~isempty(opt.deformation_mf)) mfdef = struct(opt.deformation_mf); end;
   dqdim = gf_mesh_fem_get(mfdef,'qdim');
-  if (~isempty(opt.deformation) | ison(opt.deformed_mesh)),
-    if (mdim ~= dqdim & ~ison(opt.zplot)),
+  if (~isempty(opt.deformation) || ison(opt.deformed_mesh)),
+    if (mdim ~= dqdim && ~ison(opt.zplot)),
       error(sprintf('can''t plot the deformation of an %dD-object by a 
%dD-field',mdim,dqdim));
     end;
   end;
@@ -164,7 +164,7 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
   ax_nextplot = lower(get(cax,'NextPlot'));
   fig_nextplot = lower(get(cfig,'NextPlot'));
 
-  if (ison(opt.zplot) | mdim == 3), view(3); else view(2); end;
+  if (ison(opt.zplot) || mdim == 3), view(3); else view(2); end;
   
   % build the slice object
   try
@@ -192,7 +192,7 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
   end;
 
   % apply the optional deformation
-  if (~isempty(opt.deformation) | mfdef.id ~= mf.id),
+  if (~isempty(opt.deformation) || mfdef.id ~= mf.id),
     ida = gf_mesh_fem_get(mfdef,'linked mesh'); idb = 
gf_mesh_fem_get(mf,'linked mesh');
     if (ida.id ~= idb.id),
       error('the deformation mesh_fem and the data mesh_fem do not seem to 
share the same mesh');
@@ -202,8 +202,8 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
     end;
     Pdef  = gf_compute(mfdef, Udef, 'interpolate on', sl);
     if (isnumeric(opt.deformation_scale)), dscale = opt.deformation_scale;
-    elseif (ischar(opt.deformation_scale) & ...
-           numel(opt.deformation_scale) & opt.deformation_scale(end)=='%'),
+    elseif (ischar(opt.deformation_scale) && ...
+           numel(opt.deformation_scale) && opt.deformation_scale(end)=='%'),
       dscale = str2num(opt.deformation_scale(1:end-1));
       mwidth = max([max(Psl,[],2) - min(Psl,[],2)]);
       defmax = max(abs(Pdef(:)));
@@ -225,7 +225,7 @@ function [hsurf, hcontour, hquiver, hmesh, 
hdefmesh]=gf_plot_aux(mf,U,varargin)
       sV = scalarplot_dir(:)'*Usl;
     end;
     % and optionally apply the zplot deformation
-    if (ison(opt.pcolor) & ison(opt.zplot) & is_scalarplot),
+    if (ison(opt.pcolor) && ison(opt.zplot) && is_scalarplot),
       Psl = [Psl;sV]; gf_slice_set(sl,'pts',Psl);
     end;
   end;
diff --git a/interface/src/octave/gf_plot_mesh.m 
b/interface/src/octave/gf_plot_mesh.m
index a37e6c2..67943d4 100644
--- a/interface/src/octave/gf_plot_mesh.m
+++ b/interface/src/octave/gf_plot_mesh.m
@@ -103,7 +103,7 @@ end;
 PXY = gf_mesh_get(M, 'pts');
 
 E = gf_mesh_get(M, 'edges', cvflst);
-if (~ison(opt.curved) & isempty(opt.deformation)),
+if (~ison(opt.curved) && isempty(opt.deformation)),
   X = [PXY(1,E(1,:)); PXY(1,E(2,:))];
   if (mdim == 1),
     Y = zeros(size(X));
diff --git a/interface/src/octave/gf_plot_slice.m 
b/interface/src/octave/gf_plot_slice.m
index 9ea5820..e57840e 100644
--- a/interface/src/octave/gf_plot_slice.m
+++ b/interface/src/octave/gf_plot_slice.m
@@ -62,7 +62,7 @@ function [hfaces, htube, hquiver, 
hmesh]=gf_plot_slice(sl,varargin)
     warning('won''t plot 3D slices, extract the slice boundary first');
   end;
   
-  if (mdim ~= 2 & mdim ~= 3),
+  if (mdim ~= 2 && mdim ~= 3),
     error('only 2D and 3D mesh are handled by this function');
   end;
   
@@ -109,7 +109,7 @@ function [hfaces, htube, hquiver, 
hmesh]=gf_plot_slice(sl,varargin)
   
   Pm = gf_slice_get(sl,'pts'); 
   if (numel(Pm) == 0) return; end;
-  if (~isempty(opt.data) & size(opt.data,2) ~= size(Pm,2)),
+  if (~isempty(opt.data) && size(opt.data,2) ~= size(Pm,2)),
     error(sprintf('wrong dimensions for the data (has %d columns, should have 
%d columns)',...
                  size(opt.data,2),size(Pm,2)));
   end;
@@ -121,7 +121,7 @@ function [hfaces, htube, hquiver, 
hmesh]=gf_plot_slice(sl,varargin)
     box(i,:) = [min(P{i}) max(P{i})];
   end;
   
-  if (ischar(opt.tube_radius) & numel(opt.tube_radius) & 
opt.tube_radius(end)=='%')
+  if (ischar(opt.tube_radius) && numel(opt.tube_radius) && 
opt.tube_radius(end)=='%')
     opt.tube_radius = max(abs(box(:,2)-box(:,1))) * 0.01 * 
str2num(opt.tube_radius(1:end-1));
   end;
   
@@ -140,10 +140,10 @@ function [hfaces, htube, hquiver, 
hmesh]=gf_plot_slice(sl,varargin)
   [hfaces,h,hquiver]=do_plot_2D(sl,P,T{2},opt); hmesh=[hmesh(:)' h(:)'];
   
   if (mdim == 3), view(3); else view(2); end;
-  if (strcmpi(get(gcf,'renderer'),'opengl')),
-    warning('OpenGL renderer does not work well with getfem, changing to 
zbuffer');
-  end;
-  set(gcf,'renderer','zbuffer');
+  % if (strcmpi(get(gcf,'renderer'),'opengl')),
+  %  warning('OpenGL renderer does not work well with getfem, changing to 
zbuffer');
+  % end;
+  % set(gcf,'renderer','zbuffer');
  
   if (~hold_state),
     set(cax,'DataAspectRatio', [1 1 1]);
@@ -168,7 +168,7 @@ function [htube,hmesh]=do_plot_1D(P,T,opt)
     if (numel(P)==1) C{2}=zeros(size(C{1})); end;
     
hmesh=line(C{:},'Color',opt.mesh_edges_color,'LineWidth',opt.mesh_edges_width);
   else
-    if (~isempty(opt.data) & ison(opt.pcolor)),
+    if (~isempty(opt.data) && ison(opt.pcolor)),
       qdim = size(opt.data,1);
       if (qdim == 1),
        if (iscell(opt.data))
@@ -216,7 +216,7 @@ function h=plot_tube(P, T, D, radius, tubecolor)
   while (1),
     % search for consecutive edge points
     it1 = it0;
-    while (it1 < nT & T(1,it1+1) == T(2,it1)) it1 = it1+1; end;
+    while (it1 < nT && T(1,it1+1) == T(2,it1)) it1 = it1+1; end;
     %disp(sprintf('sequence: %d - %d -- [%d-%d] - 
[%d-%d]',it0,it1,T(1,it0),T(2,it0),T(1,it1),T(2,it1)))
     % extract the sequence of points
     ip = [T(1,it0) T(2,it0:it1)];
@@ -266,9 +266,9 @@ function [hfaces,hmesh,hquiver]=do_plot_2D(sl,P,T,opt)
   mdim=numel(P);
   if (numel(T)),
     d={};  
-    if (ison(opt.pcolor) & size(opt.data,1)==1 & ~isempty(opt.data)),
+    if (ison(opt.pcolor) && size(opt.data,1)==1 && ~isempty(opt.data)),
       d={'FaceVertexCData',opt.data(:),'FaceColor','interp'};
-    elseif (isempty(opt.data) & ison(opt.mesh_faces))
+    elseif (isempty(opt.data) && ison(opt.mesh_faces))
       d={'FaceVertexCData',opt.mesh_faces_color, 'FaceColor','flat'};
     end;    
     if (~isempty(d)),
@@ -281,7 +281,7 @@ function [hfaces,hmesh,hquiver]=do_plot_2D(sl,P,T,opt)
       end;
     end;  
   end;
-  if (ison(opt.mesh) & (ison(opt.mesh_edges) | ison(opt.mesh_slice_edges))),
+  if (ison(opt.mesh) && (ison(opt.mesh_edges) || ison(opt.mesh_slice_edges))),
     [p,t1,t2] = gf_slice_get(sl,'edges');
     if (ison(opt.mesh_edges))
       
hmesh=patch('Vertices',p','Faces',t1','EdgeColor',opt.mesh_edges_color,'LineWidth',opt.mesh_edges_width);
diff --git a/interface/src/octave/gfm_common.c 
b/interface/src/octave/gfm_common.c
index c59c0eb..3de85cf 100644
--- a/interface/src/octave/gfm_common.c
+++ b/interface/src/octave/gfm_common.c
@@ -63,6 +63,7 @@ mxarray_to_gfi_array(const mxArray *mx, gfi_array *t)
   n2=n;
   
   assert(t);
+
   switch (mxGetClassID(mx)) {    
     case mxCELL_CLASS: {
       mwSize i;
@@ -88,7 +89,6 @@ mxarray_to_gfi_array(const mxArray *mx, gfi_array *t)
       t->storage.gfi_storage_u.data_int32.data_int32_len = n;
       t->storage.gfi_storage_u.data_int32.data_int32_val = mxGetData(mx);
     } break;
-#ifdef LOGICAL_IS_A_TYPE
     case mxLOGICAL_CLASS: {
       int i;
       mxLogical *p = (mxLogical*)mxGetData(mx);
@@ -98,7 +98,6 @@ mxarray_to_gfi_array(const mxArray *mx, gfi_array *t)
       for (i = 0; i < n; ++i)
        t->storage.gfi_storage_u.data_int32.data_int32_val[i] = (p[i] ? 1 : 0);
     } break;
-#endif
     case mxUINT32_CLASS: {
       t->storage.type = GFI_UINT32;
       t->storage.gfi_storage_u.data_uint32.data_uint32_len = n;
@@ -194,7 +193,7 @@ mxarray_to_gfi_array(const mxArray *mx, gfi_array *t)
           mexPrintf("empty arrays of getfem object ids not handled"); return 1;
         }
       } else { 
-        mexPrintf("matlab structures (except getfem object ids) not handled"); 
return 1; 
+        mexPrintf("Octave structures (except getfem object ids) not handled"); 
return 1; 
       }
     } break;
   }
diff --git a/interface/tests/Makefile.am b/interface/tests/Makefile.am
index 7a76446..2eb3f27 100644
--- a/interface/tests/Makefile.am
+++ b/interface/tests/Makefile.am
@@ -17,7 +17,7 @@
 
 
 if BUILDMEX
-subdirMATLAB=matlab
+subdirMATLAB=matlab-octave
 endif
 
 if BUILDPYTHON
diff --git a/interface/tests/matlab/Makefile.am 
b/interface/tests/matlab-octave/Makefile.am
similarity index 100%
rename from interface/tests/matlab/Makefile.am
rename to interface/tests/matlab-octave/Makefile.am
diff --git a/interface/tests/matlab/axrot_matrix.m 
b/interface/tests/matlab-octave/axrot_matrix.m
similarity index 100%
rename from interface/tests/matlab/axrot_matrix.m
rename to interface/tests/matlab-octave/axrot_matrix.m
diff --git a/interface/tests/matlab/check_all.m 
b/interface/tests/matlab-octave/check_all.m
similarity index 100%
rename from interface/tests/matlab/check_all.m
rename to interface/tests/matlab-octave/check_all.m
diff --git a/interface/tests/matlab/check_all_matlab.sh 
b/interface/tests/matlab-octave/check_all_matlab.sh
similarity index 100%
rename from interface/tests/matlab/check_all_matlab.sh
rename to interface/tests/matlab-octave/check_all_matlab.sh
diff --git a/interface/tests/matlab/check_all_octave.sh 
b/interface/tests/matlab-octave/check_all_octave.sh
similarity index 100%
rename from interface/tests/matlab/check_all_octave.sh
rename to interface/tests/matlab-octave/check_all_octave.sh
diff --git a/interface/tests/matlab/check_asm.m 
b/interface/tests/matlab-octave/check_asm.m
similarity index 100%
rename from interface/tests/matlab/check_asm.m
rename to interface/tests/matlab-octave/check_asm.m
diff --git a/interface/tests/matlab/check_fem.m 
b/interface/tests/matlab-octave/check_fem.m
similarity index 100%
rename from interface/tests/matlab/check_fem.m
rename to interface/tests/matlab-octave/check_fem.m
diff --git a/interface/tests/matlab/check_geotrans.m 
b/interface/tests/matlab-octave/check_geotrans.m
similarity index 100%
rename from interface/tests/matlab/check_geotrans.m
rename to interface/tests/matlab-octave/check_geotrans.m
diff --git a/interface/tests/matlab/check_integ.m 
b/interface/tests/matlab-octave/check_integ.m
similarity index 99%
rename from interface/tests/matlab/check_integ.m
rename to interface/tests/matlab-octave/check_integ.m
index a08e55d..c9c52c6 100644
--- a/interface/tests/matlab/check_integ.m
+++ b/interface/tests/matlab-octave/check_integ.m
@@ -52,7 +52,7 @@ function check_integ(iverbose,idebug)
 %      0.3261    0.3261    0.1739    0.1739    0.3261    0.3261    0.1739];
   gfassert('norm(c(:)-C(:))<1e-3');
   for i=-1:4,
-    if (i >= 1 & i <= 3)
+    if (i >= 1 && i <= 3)
       gf_integ_get(im,'face_pts',i);
       gf_integ_get(im,'face_coeffs',i);
     else
diff --git a/interface/tests/matlab/check_interpolated_fem.m 
b/interface/tests/matlab-octave/check_interpolated_fem.m
similarity index 100%
rename from interface/tests/matlab/check_interpolated_fem.m
rename to interface/tests/matlab-octave/check_interpolated_fem.m
diff --git a/interface/tests/matlab/check_levelset.m 
b/interface/tests/matlab-octave/check_levelset.m
similarity index 100%
rename from interface/tests/matlab/check_levelset.m
rename to interface/tests/matlab-octave/check_levelset.m
diff --git a/interface/tests/matlab/check_mesh_fem.m 
b/interface/tests/matlab-octave/check_mesh_fem.m
similarity index 98%
rename from interface/tests/matlab/check_mesh_fem.m
rename to interface/tests/matlab-octave/check_mesh_fem.m
index 9f01893..9147969 100644
--- a/interface/tests/matlab/check_mesh_fem.m
+++ b/interface/tests/matlab-octave/check_mesh_fem.m
@@ -98,7 +98,7 @@ function check_mesh_fem(iverbose,idebug)
   
   N=gf_mesh_get(m,'dim');
   npt=gf_mesh_get(m,'nbpts');
-  gfassert('N==3 & npt==40');
+  gfassert('N==3 && npt==40');
   ncv=gf_mesh_get(m,'nbcvs');
   gfassert('ncv==7');
   lastcv=gf_mesh_get(m, 'max cvid');
@@ -150,7 +150,7 @@ function check_mesh_fem(iverbose,idebug)
   Z=gf_mesh_get(m, 'curved edges', 4, gf_mesh_get(m, 'outer faces',[4 5]));
   ZZ=gf_mesh_get(m, 'curved edges', 4, [4 5]);
   for i=0:7
-    if (i > 0 & i < 7),
+    if (i > 0 && i < 7),
       n=gf_mesh_get(m, 'normal of face', 5, 3, i);
       gfassert('norm(n-[0    0.7071    0.7071]) < 1e-3');
       nn(i,:)=gf_mesh_get(m, 'normal of face', 5, 1, i);
@@ -254,7 +254,7 @@ function check_mesh_fem(iverbose,idebug)
   gf_mesh_set(m,'boundary',51,oo);
 
   o=gf_mesh_get(m,'boundary',51);
-  gfassert('size(o)==size(oo) & sum(sum(o))==sum(sum(oo))');
+  gfassert('size(o)==size(oo) && sum(sum(o))==sum(sum(oo))');
 
   o=gf_mesh_get(mf2,'boundary',1);
   gfassert('isempty(o)');
@@ -319,8 +319,9 @@ function check_mesh_fem(iverbose,idebug)
   gfassert('np < maxpid');
   gfassert('ncv < maxcvid');
 
-  
-  gf_mesh_set(m,'optimize structure', false);
+  gf_mesh_set(m, 'optimize structure', 0);
+
+  gf_mesh_set(m, 'optimize structure', false);
 
   maxpid=gf_mesh_get(m,'max pid');
   maxcvid=gf_mesh_get(m,'max cvid');
diff --git a/interface/tests/matlab/check_mitc.m 
b/interface/tests/matlab-octave/check_mitc.m
similarity index 100%
rename from interface/tests/matlab/check_mitc.m
rename to interface/tests/matlab-octave/check_mitc.m
diff --git a/interface/tests/matlab/check_oo.m 
b/interface/tests/matlab-octave/check_oo.m
similarity index 100%
rename from interface/tests/matlab/check_oo.m
rename to interface/tests/matlab-octave/check_oo.m
diff --git a/interface/tests/matlab/check_plasticity.m 
b/interface/tests/matlab-octave/check_plasticity.m
similarity index 100%
rename from interface/tests/matlab/check_plasticity.m
rename to interface/tests/matlab-octave/check_plasticity.m
diff --git a/interface/tests/matlab/check_plot.m 
b/interface/tests/matlab-octave/check_plot.m
similarity index 100%
rename from interface/tests/matlab/check_plot.m
rename to interface/tests/matlab-octave/check_plot.m
diff --git a/interface/tests/matlab/check_slices.m 
b/interface/tests/matlab-octave/check_slices.m
similarity index 100%
rename from interface/tests/matlab/check_slices.m
rename to interface/tests/matlab-octave/check_slices.m
diff --git a/interface/tests/matlab/check_spmat.m 
b/interface/tests/matlab-octave/check_spmat.m
similarity index 93%
rename from interface/tests/matlab/check_spmat.m
rename to interface/tests/matlab-octave/check_spmat.m
index 88738ea..b7179b2 100644
--- a/interface/tests/matlab/check_spmat.m
+++ b/interface/tests/matlab-octave/check_spmat.m
@@ -34,16 +34,20 @@ function check_spmat(iverbose,idebug)
     asserterr('gf_spmat(''empty'',2:3)');
     asserterr('gf_spmat(''empty'',0)');
   end;
+  is_octave = exist('octave_config_info');
   % TEST EMPTY COPY FULL
   A = gf_spmat('empty', 5,6);
   B = gf_spmat('empty', 11111);
   C = gf_spmat('copy', A);
-  C = sprand(50,50,.1); C(2,2)=1+2i; I = 1:40; J = [6 7 8 3 10];
-  D = gf_spmat('copy', C, I, J);
-  DD = gf_spmat_get(D,'full');
-  gfassert('all(DD==C(I,J))');
-  asserterr('gf_spmat(D,''full'',100)');
-  asserterr('gf_spmat(D,''full'',10,-1)');
+  
+  if (!is_octave) % The import of complex sparse matrices is not working in 
Octave for the moment
+    C = sprand(50,50,.1); C(2,2)=1+2i; I = 1:40; J = [6 7 8 3 10];
+    D = gf_spmat('copy', C, I, J);
+    DD = gf_spmat_get(D,'full');
+    gfassert('all(DD==C(I,J))');
+    asserterr('gf_spmat(D,''full'',100)');
+    asserterr('gf_spmat(D,''full'',10,-1)');
+  end
   
   % TEST MULT
   A = gf_spmat('identity', 11111);
diff --git a/interface/tests/matlab/check_workspace.m 
b/interface/tests/matlab-octave/check_workspace.m
similarity index 100%
rename from interface/tests/matlab/check_workspace.m
rename to interface/tests/matlab-octave/check_workspace.m
diff --git a/interface/tests/matlab/demo_Mindlin_Reissner_plate.m 
b/interface/tests/matlab-octave/demo_Mindlin_Reissner_plate.m
similarity index 100%
rename from interface/tests/matlab/demo_Mindlin_Reissner_plate.m
rename to interface/tests/matlab-octave/demo_Mindlin_Reissner_plate.m
diff --git a/interface/tests/matlab/demo_Navier_Stokes.m 
b/interface/tests/matlab-octave/demo_Navier_Stokes.m
similarity index 100%
rename from interface/tests/matlab/demo_Navier_Stokes.m
rename to interface/tests/matlab-octave/demo_Navier_Stokes.m
diff --git a/interface/tests/matlab/demo_Nitsche_contact_by_hand.m 
b/interface/tests/matlab-octave/demo_Nitsche_contact_by_hand.m
similarity index 100%
rename from interface/tests/matlab/demo_Nitsche_contact_by_hand.m
rename to interface/tests/matlab-octave/demo_Nitsche_contact_by_hand.m
diff --git a/interface/tests/matlab/demo_bilaplacian.m 
b/interface/tests/matlab-octave/demo_bilaplacian.m
similarity index 100%
rename from interface/tests/matlab/demo_bilaplacian.m
rename to interface/tests/matlab-octave/demo_bilaplacian.m
diff --git a/interface/tests/matlab/demo_contact_fictitious_domain_nitsche.m 
b/interface/tests/matlab-octave/demo_contact_fictitious_domain_nitsche.m
similarity index 100%
rename from interface/tests/matlab/demo_contact_fictitious_domain_nitsche.m
rename to interface/tests/matlab-octave/demo_contact_fictitious_domain_nitsche.m
diff --git a/interface/tests/matlab/demo_continuation.m 
b/interface/tests/matlab-octave/demo_continuation.m
similarity index 100%
rename from interface/tests/matlab/demo_continuation.m
rename to interface/tests/matlab-octave/demo_continuation.m
diff --git a/interface/tests/matlab/demo_convection_rotating_cavity.m 
b/interface/tests/matlab-octave/demo_convection_rotating_cavity.m
similarity index 100%
rename from interface/tests/matlab/demo_convection_rotating_cavity.m
rename to interface/tests/matlab-octave/demo_convection_rotating_cavity.m
diff --git a/interface/tests/matlab/demo_crack.m 
b/interface/tests/matlab-octave/demo_crack.m
similarity index 100%
rename from interface/tests/matlab/demo_crack.m
rename to interface/tests/matlab-octave/demo_crack.m
diff --git a/interface/tests/matlab/demo_dynamic_contact.m 
b/interface/tests/matlab-octave/demo_dynamic_contact.m
similarity index 100%
rename from interface/tests/matlab/demo_dynamic_contact.m
rename to interface/tests/matlab-octave/demo_dynamic_contact.m
diff --git a/interface/tests/matlab/demo_dynamic_plasticity.m 
b/interface/tests/matlab-octave/demo_dynamic_plasticity.m
similarity index 100%
rename from interface/tests/matlab/demo_dynamic_plasticity.m
rename to interface/tests/matlab-octave/demo_dynamic_plasticity.m
diff --git a/interface/tests/matlab/demo_dynamic_plasticity_with_contact.m 
b/interface/tests/matlab-octave/demo_dynamic_plasticity_with_contact.m
similarity index 100%
rename from interface/tests/matlab/demo_dynamic_plasticity_with_contact.m
rename to interface/tests/matlab-octave/demo_dynamic_plasticity_with_contact.m
diff --git a/interface/tests/matlab/demo_elasticity.m 
b/interface/tests/matlab-octave/demo_elasticity.m
similarity index 100%
rename from interface/tests/matlab/demo_elasticity.m
rename to interface/tests/matlab-octave/demo_elasticity.m
diff --git a/interface/tests/matlab/demo_fictitious_domains.m 
b/interface/tests/matlab-octave/demo_fictitious_domains.m
similarity index 100%
rename from interface/tests/matlab/demo_fictitious_domains.m
rename to interface/tests/matlab-octave/demo_fictitious_domains.m
diff --git a/interface/tests/matlab/demo_fictitious_domains_laplacian.m 
b/interface/tests/matlab-octave/demo_fictitious_domains_laplacian.m
similarity index 100%
rename from interface/tests/matlab/demo_fictitious_domains_laplacian.m
rename to interface/tests/matlab-octave/demo_fictitious_domains_laplacian.m
diff --git a/interface/tests/matlab/demo_laplacian.m 
b/interface/tests/matlab-octave/demo_laplacian.m
similarity index 100%
rename from interface/tests/matlab/demo_laplacian.m
rename to interface/tests/matlab-octave/demo_laplacian.m
diff --git a/interface/tests/matlab/demo_laplacian_DG.m 
b/interface/tests/matlab-octave/demo_laplacian_DG.m
similarity index 100%
rename from interface/tests/matlab/demo_laplacian_DG.m
rename to interface/tests/matlab-octave/demo_laplacian_DG.m
diff --git a/interface/tests/matlab/demo_laplacian_pyramid.m 
b/interface/tests/matlab-octave/demo_laplacian_pyramid.m
similarity index 100%
rename from interface/tests/matlab/demo_laplacian_pyramid.m
rename to interface/tests/matlab-octave/demo_laplacian_pyramid.m
diff --git a/interface/tests/matlab/demo_large_sliding_contact.m 
b/interface/tests/matlab-octave/demo_large_sliding_contact.m
similarity index 100%
rename from interface/tests/matlab/demo_large_sliding_contact.m
rename to interface/tests/matlab-octave/demo_large_sliding_contact.m
diff --git a/interface/tests/matlab/demo_mesh_generation.m 
b/interface/tests/matlab-octave/demo_mesh_generation.m
similarity index 100%
rename from interface/tests/matlab/demo_mesh_generation.m
rename to interface/tests/matlab-octave/demo_mesh_generation.m
diff --git a/interface/tests/matlab/demo_mortar.m 
b/interface/tests/matlab-octave/demo_mortar.m
similarity index 100%
rename from interface/tests/matlab/demo_mortar.m
rename to interface/tests/matlab-octave/demo_mortar.m
diff --git a/interface/tests/matlab/demo_nonlinear_elasticity.m 
b/interface/tests/matlab-octave/demo_nonlinear_elasticity.m
similarity index 100%
rename from interface/tests/matlab/demo_nonlinear_elasticity.m
rename to interface/tests/matlab-octave/demo_nonlinear_elasticity.m
diff --git a/interface/tests/matlab/demo_nonlinear_elasticity_anim.m 
b/interface/tests/matlab-octave/demo_nonlinear_elasticity_anim.m
similarity index 100%
rename from interface/tests/matlab/demo_nonlinear_elasticity_anim.m
rename to interface/tests/matlab-octave/demo_nonlinear_elasticity_anim.m
diff --git a/interface/tests/matlab/demo_periodic_laplacian.m 
b/interface/tests/matlab-octave/demo_periodic_laplacian.m
similarity index 100%
rename from interface/tests/matlab/demo_periodic_laplacian.m
rename to interface/tests/matlab-octave/demo_periodic_laplacian.m
diff --git a/interface/tests/matlab/demo_plasticity.m 
b/interface/tests/matlab-octave/demo_plasticity.m
similarity index 100%
rename from interface/tests/matlab/demo_plasticity.m
rename to interface/tests/matlab-octave/demo_plasticity.m
diff --git a/interface/tests/matlab/demo_refine.m 
b/interface/tests/matlab-octave/demo_refine.m
similarity index 100%
rename from interface/tests/matlab/demo_refine.m
rename to interface/tests/matlab-octave/demo_refine.m
diff --git a/interface/tests/matlab/demo_static_contact.m 
b/interface/tests/matlab-octave/demo_static_contact.m
similarity index 100%
rename from interface/tests/matlab/demo_static_contact.m
rename to interface/tests/matlab-octave/demo_static_contact.m
diff --git a/interface/tests/matlab/demo_step_by_step.m 
b/interface/tests/matlab-octave/demo_step_by_step.m
similarity index 100%
rename from interface/tests/matlab/demo_step_by_step.m
rename to interface/tests/matlab-octave/demo_step_by_step.m
diff --git a/interface/tests/matlab/demo_stokes_3D_tank.m 
b/interface/tests/matlab-octave/demo_stokes_3D_tank.m
similarity index 100%
rename from interface/tests/matlab/demo_stokes_3D_tank.m
rename to interface/tests/matlab-octave/demo_stokes_3D_tank.m
diff --git a/interface/tests/matlab/demo_stokes_3D_tank_draw.m 
b/interface/tests/matlab-octave/demo_stokes_3D_tank_draw.m
similarity index 98%
rename from interface/tests/matlab/demo_stokes_3D_tank_draw.m
rename to interface/tests/matlab-octave/demo_stokes_3D_tank_draw.m
index d68449e..5895b5e 100644
--- a/interface/tests/matlab/demo_stokes_3D_tank_draw.m
+++ b/interface/tests/matlab-octave/demo_stokes_3D_tank_draw.m
@@ -15,7 +15,7 @@
 % along  with  this program;  if not, write to the Free Software Foundation,
 % Inc., 51 Franklin St, Fifth Floor, Boston, MA  02110-1301, USA.
 
-if (exist('U')~=1 | exist('P') ~= 1),
+if (exist('U')~=1 || exist('P') ~= 1),
   error('run demo_stokes_3D_tank2 first');
 end;
 clf;
diff --git a/interface/tests/matlab/demo_structural_optimization.m 
b/interface/tests/matlab-octave/demo_structural_optimization.m
similarity index 100%
rename from interface/tests/matlab/demo_structural_optimization.m
rename to interface/tests/matlab-octave/demo_structural_optimization.m
diff --git 
a/interface/tests/matlab/demo_thermo_elasticity_electrical_coupling.m 
b/interface/tests/matlab-octave/demo_thermo_elasticity_electrical_coupling.m
similarity index 100%
rename from interface/tests/matlab/demo_thermo_elasticity_electrical_coupling.m
rename to 
interface/tests/matlab-octave/demo_thermo_elasticity_electrical_coupling.m
diff --git a/interface/tests/matlab/demo_topological_optimization.m 
b/interface/tests/matlab-octave/demo_topological_optimization.m
similarity index 100%
rename from interface/tests/matlab/demo_topological_optimization.m
rename to interface/tests/matlab-octave/demo_topological_optimization.m
diff --git a/interface/tests/matlab/demo_tripod.m 
b/interface/tests/matlab-octave/demo_tripod.m
similarity index 100%
rename from interface/tests/matlab/demo_tripod.m
rename to interface/tests/matlab-octave/demo_tripod.m
diff --git a/interface/tests/matlab/demo_tripod_alt.m 
b/interface/tests/matlab-octave/demo_tripod_alt.m
similarity index 100%
rename from interface/tests/matlab/demo_tripod_alt.m
rename to interface/tests/matlab-octave/demo_tripod_alt.m
diff --git a/interface/tests/matlab/demo_tripod_slice_anim.m 
b/interface/tests/matlab-octave/demo_tripod_slice_anim.m
similarity index 100%
rename from interface/tests/matlab/demo_tripod_slice_anim.m
rename to interface/tests/matlab-octave/demo_tripod_slice_anim.m
diff --git a/interface/tests/matlab/demo_wave2D.m 
b/interface/tests/matlab-octave/demo_wave2D.m
similarity index 100%
rename from interface/tests/matlab/demo_wave2D.m
rename to interface/tests/matlab-octave/demo_wave2D.m
diff --git a/interface/tests/matlab/demo_wave2D_alt.m 
b/interface/tests/matlab-octave/demo_wave2D_alt.m
similarity index 100%
rename from interface/tests/matlab/demo_wave2D_alt.m
rename to interface/tests/matlab-octave/demo_wave2D_alt.m
diff --git a/interface/tests/matlab/demo_wave2D_animate.m 
b/interface/tests/matlab-octave/demo_wave2D_animate.m
similarity index 100%
rename from interface/tests/matlab/demo_wave2D_animate.m
rename to interface/tests/matlab-octave/demo_wave2D_animate.m
diff --git a/interface/tests/matlab/demo_wave_equation.m 
b/interface/tests/matlab-octave/demo_wave_equation.m
similarity index 100%
rename from interface/tests/matlab/demo_wave_equation.m
rename to interface/tests/matlab-octave/demo_wave_equation.m
diff --git a/interface/tests/matlab/demo_wheel_contact.m 
b/interface/tests/matlab-octave/demo_wheel_contact.m
similarity index 100%
rename from interface/tests/matlab/demo_wheel_contact.m
rename to interface/tests/matlab-octave/demo_wheel_contact.m
diff --git a/interface/tests/matlab/plate_Impact.m 
b/interface/tests/matlab-octave/plate_Impact.m
similarity index 100%
rename from interface/tests/matlab/plate_Impact.m
rename to interface/tests/matlab-octave/plate_Impact.m
diff --git a/interface/tests/matlab/private/Makefile.am 
b/interface/tests/matlab-octave/private/Makefile.am
similarity index 100%
rename from interface/tests/matlab/private/Makefile.am
rename to interface/tests/matlab-octave/private/Makefile.am
diff --git a/interface/tests/matlab/private/asserterr.m 
b/interface/tests/matlab-octave/private/asserterr.m
similarity index 100%
rename from interface/tests/matlab/private/asserterr.m
rename to interface/tests/matlab-octave/private/asserterr.m
diff --git a/interface/tests/matlab/private/gfassert.m 
b/interface/tests/matlab-octave/private/gfassert.m
similarity index 100%
rename from interface/tests/matlab/private/gfassert.m
rename to interface/tests/matlab-octave/private/gfassert.m
diff --git a/interface/tests/matlab/test1_nitsche_large_sliding.m 
b/interface/tests/matlab-octave/test1_nitsche_large_sliding.m
similarity index 100%
rename from interface/tests/matlab/test1_nitsche_large_sliding.m
rename to interface/tests/matlab-octave/test1_nitsche_large_sliding.m
diff --git a/interface/tests/matlab/test2_nitsche_large_sliding.m 
b/interface/tests/matlab-octave/test2_nitsche_large_sliding.m
similarity index 100%
rename from interface/tests/matlab/test2_nitsche_large_sliding.m
rename to interface/tests/matlab-octave/test2_nitsche_large_sliding.m
diff --git a/interface/tests/matlab/test_argyris.m 
b/interface/tests/matlab-octave/test_argyris.m
similarity index 100%
rename from interface/tests/matlab/test_argyris.m
rename to interface/tests/matlab-octave/test_argyris.m
diff --git a/interface/tests/matlab/tripod_anim.m 
b/interface/tests/matlab-octave/tripod_anim.m
similarity index 100%
rename from interface/tests/matlab/tripod_anim.m
rename to interface/tests/matlab-octave/tripod_anim.m
diff --git a/interface/tests/matlab/tutorial1.m 
b/interface/tests/matlab-octave/tutorial1.m
similarity index 100%
rename from interface/tests/matlab/tutorial1.m
rename to interface/tests/matlab-octave/tutorial1.m
diff --git a/interface/tests/matlab/uAnalytic.m 
b/interface/tests/matlab-octave/uAnalytic.m
similarity index 100%
rename from interface/tests/matlab/uAnalytic.m
rename to interface/tests/matlab-octave/uAnalytic.m



reply via email to

[Prev in Thread] Current Thread [Next in Thread]